GSL
2.8
Introduction
Using the Library
Error Handling
Mathematical Functions
Complex Numbers
Polynomials
Special Functions
Vectors and Matrices
Permutations
Combinations
Multisets
Sorting
BLAS Support
Linear Algebra
Eigensystems
Fast Fourier Transforms (FFTs)
Numerical Integration
Random Number Generation
Quasi-Random Sequences
Random Number Distributions
Statistics
Running Statistics
Moving Window Statistics
Digital Filtering
Histograms
N-tuples
Monte Carlo Integration
Simulated Annealing
Ordinary Differential Equations
Interpolation
Numerical Differentiation
Chebyshev Approximations
Series Acceleration
Wavelet Transforms
Discrete Hankel Transforms
One Dimensional Root-Finding
One Dimensional Minimization
Multidimensional Root-Finding
Multidimensional Minimization
Linear Least-Squares Fitting
Nonlinear Least-Squares Fitting
Basis Splines
Sparse Matrices
Sparse BLAS Support
Sparse Linear Algebra
Physical Constants
IEEE floating-point arithmetic
Debugging Numerical Programs
Contributors to GSL
Autoconf Macros
GSL CBLAS Library
GNU General Public License
GNU Free Documentation License
GSL
»
Index
Index
Symbols
|
A
|
B
|
C
|
D
|
E
|
F
|
G
|
H
|
I
|
J
|
K
|
L
|
M
|
N
|
O
|
P
|
Q
|
R
|
S
|
T
|
U
|
V
|
W
|
Y
|
Z
Symbols
$, shell prompt
2D histograms
2D random direction vector
3-j symbols
3D random direction vector
6-j symbols
9-j symbols
A
acceleration of series
acosh
Adams method
Adaptive step-size control, differential equations
Ai(x)
Airy functions
Akima splines
aliasing of arrays
alternative optimized functions
AMAX, Level-1 BLAS
Angular Mathieu Functions
angular reduction
ANSI C, use of
Apell symbol, see Pochhammer symbol
approximate comparison of floating point numbers
arctangent integral
argument of complex number
arithmetic exceptions
asinh
astronomical constants
ASUM, Level-1 BLAS
atanh
atomic physics, constants
autoconf, using with GSL
AXPY, Level-1 BLAS
B
B-spline wavelets
Bader and Deuflhard, Bulirsch-Stoer method.
balancing matrices
banded Cholesky Decomposition
banded general matrices
banded LDLT decomposition
banded LU Decomposition
banded matrices
banded symmetric matrices
Basic Linear Algebra Subroutines (BLAS)
,
[1]
basis splines, allocating
basis splines, B-splines
basis splines, breakpoints
basis splines, derivatives
basis splines, evaluation
basis splines, examples
basis splines, Gram matrix
basis splines, Greville abscissae
basis splines, Hermite interpolation
basis splines, integration
basis splines, interpolation
basis splines, knots
basis splines, least squares
basis splines, Marsden-Schoenberg points
basis splines, overview
basis splines, properties
BDF method
Bernoulli trial, random variates
Bessel functions
Bessel Functions, Fractional Order
best-fit parameters, covariance
Beta distribution
Beta function
Beta function, incomplete normalized
BFGS algorithm, minimization
Bi(x)
bias, IEEE format
bicubic interpolation
bidiagonalization of real matrices
bilinear interpolation
binning data
Binomial random variates
biorthogonal wavelets
bisection algorithm for finding roots
Bivariate Gaussian distribution
,
[1]
BLAS
BLAS, Low-level C interface
BLAS, sparse
blocks
bounds checking, extension to GCC
breakpoints
Brent's method for finding minima
Brent's method for finding roots
Broyden algorithm for multidimensional roots
BSD random number generator
bug-gsl
bug-gsl mailing list
bugs
Bulirsch-Stoer method
C
C extensions, compatible use of
C++, compatibility
C99, inline keyword
Carlson forms of Elliptic integrals
Cash-Karp, Runge-Kutta method
Cauchy distribution
Cauchy principal value, by numerical quadrature
CBLAS
CBLAS, Low-level interface
cblas_caxpy (C function)
cblas_ccopy (C function)
cblas_cdotc_sub (C function)
cblas_cdotu_sub (C function)
cblas_cgbmv (C function)
cblas_cgemm (C function)
cblas_cgemv (C function)
cblas_cgerc (C function)
cblas_cgeru (C function)
cblas_chbmv (C function)
cblas_chemm (C function)
cblas_chemv (C function)
cblas_cher (C function)
cblas_cher2 (C function)
cblas_cher2k (C function)
cblas_cherk (C function)
cblas_chpmv (C function)
cblas_chpr (C function)
cblas_chpr2 (C function)
cblas_cscal (C function)
cblas_csscal (C function)
cblas_cswap (C function)
cblas_csymm (C function)
cblas_csyr2k (C function)
cblas_csyrk (C function)
cblas_ctbmv (C function)
cblas_ctbsv (C function)
cblas_ctpmv (C function)
cblas_ctpsv (C function)
cblas_ctrmm (C function)
cblas_ctrmv (C function)
cblas_ctrsm (C function)
cblas_ctrsv (C function)
cblas_dasum (C function)
cblas_daxpy (C function)
cblas_dcopy (C function)
cblas_ddot (C function)
cblas_dgbmv (C function)
cblas_dgemm (C function)
cblas_dgemv (C function)
cblas_dger (C function)
cblas_dnrm2 (C function)
cblas_drot (C function)
cblas_drotg (C function)
cblas_drotm (C function)
cblas_drotmg (C function)
cblas_dsbmv (C function)
cblas_dscal (C function)
cblas_dsdot (C function)
cblas_dspmv (C function)
cblas_dspr (C function)
cblas_dspr2 (C function)
cblas_dswap (C function)
cblas_dsymm (C function)
cblas_dsymv (C function)
cblas_dsyr (C function)
cblas_dsyr2 (C function)
cblas_dsyr2k (C function)
cblas_dsyrk (C function)
cblas_dtbmv (C function)
cblas_dtbsv (C function)
cblas_dtpmv (C function)
cblas_dtpsv (C function)
cblas_dtrmm (C function)
cblas_dtrmv (C function)
cblas_dtrsm (C function)
cblas_dtrsv (C function)
cblas_dzasum (C function)
cblas_dznrm2 (C function)
cblas_icamax (C function)
cblas_idamax (C function)
cblas_isamax (C function)
cblas_izamax (C function)
cblas_sasum (C function)
cblas_saxpy (C function)
cblas_scasum (C function)
cblas_scnrm2 (C function)
cblas_scopy (C function)
cblas_sdot (C function)
cblas_sdsdot (C function)
cblas_sgbmv (C function)
cblas_sgemm (C function)
cblas_sgemv (C function)
cblas_sger (C function)
cblas_snrm2 (C function)
cblas_srot (C function)
cblas_srotg (C function)
cblas_srotm (C function)
cblas_srotmg (C function)
cblas_ssbmv (C function)
cblas_sscal (C function)
cblas_sspmv (C function)
cblas_sspr (C function)
cblas_sspr2 (C function)
cblas_sswap (C function)
cblas_ssymm (C function)
cblas_ssymv (C function)
cblas_ssyr (C function)
cblas_ssyr2 (C function)
cblas_ssyr2k (C function)
cblas_ssyrk (C function)
cblas_stbmv (C function)
cblas_stbsv (C function)
cblas_stpmv (C function)
cblas_stpsv (C function)
cblas_strmm (C function)
cblas_strmv (C function)
cblas_strsm (C function)
cblas_strsv (C function)
cblas_xerbla (C function)
cblas_zaxpy (C function)
cblas_zcopy (C function)
cblas_zdotc_sub (C function)
cblas_zdotu_sub (C function)
cblas_zdscal (C function)
cblas_zgbmv (C function)
cblas_zgemm (C function)
cblas_zgemv (C function)
cblas_zgerc (C function)
cblas_zgeru (C function)
cblas_zhbmv (C function)
cblas_zhemm (C function)
cblas_zhemv (C function)
cblas_zher (C function)
cblas_zher2 (C function)
cblas_zher2k (C function)
cblas_zherk (C function)
cblas_zhpmv (C function)
cblas_zhpr (C function)
cblas_zhpr2 (C function)
cblas_zscal (C function)
cblas_zswap (C function)
cblas_zsymm (C function)
cblas_zsyr2k (C function)
cblas_zsyrk (C function)
cblas_ztbmv (C function)
cblas_ztbsv (C function)
cblas_ztpmv (C function)
cblas_ztpsv (C function)
cblas_ztrmm (C function)
cblas_ztrmv (C function)
cblas_ztrsm (C function)
cblas_ztrsv (C function)
CDFs, cumulative distribution functions
ce(q,x), Mathieu function
Chebyshev series
checking combination for validity
checking multiset for validity
checking permutation for validity
Chi(x)
Chi-squared distribution
Cholesky decomposition
Cholesky decomposition, banded
Cholesky decomposition, modified
Cholesky decomposition, pivoted
Cholesky decomposition, square root free
Ci(x)
Clausen functions
Clenshaw-Curtis quadrature
CMRG, combined multiple recursive random number generator
code reuse in applications
combinations
combinatorial factor C(m
combinatorial optimization
comparison functions, definition
compatibility
compiling programs, include paths
compiling programs, library paths
complementary incomplete Gamma function
complete Fermi-Dirac integrals
complete orthogonal decomposition
complex arithmetic
complex cosine function, special functions
Complex Gamma function
complex hermitian matrix, eigensystem
complex log sine function, special functions
complex numbers
complex sinc function, special functions
complex sine function, special functions
confluent hypergeometric function
confluent hypergeometric functions
conical functions
Conjugate gradient algorithm, minimization
conjugate of complex number
constant matrix
constants, fundamental
constants, mathematical (defined as macros)
constants, physical
constants, prefixes
contacting the GSL developers
conventions, used in manual
convergence, accelerating a series
conversion of units
cooling schedule
COPY, Level-1 BLAS
correlation, of two datasets
cosine function, special functions
cosine of complex number
cost function
Coulomb wave functions
coupling coefficients
covariance matrix, from linear regression
covariance matrix, linear fits
covariance matrix, nonlinear fits
covariance, of two datasets
cquad, doubly-adaptive integration
CRAY random number generator, RANF
cubic equation, solving
cubic splines
cumulative distribution functions (CDFs)
Cylindrical Bessel Functions
D
Daubechies wavelets
Dawson function
DAXPY, Level-1 BLAS
debugging numerical programs
Debye functions
denormalized form, IEEE format
deprecated functions
derivatives, calculating numerically
determinant of a matrix, by LU decomposition
Deuflhard and Bader, Bulirsch-Stoer method.
DFTs, see FFT
diagonal, of a matrix
differential equations, initial value problems
differentiation of functions, numeric
digamma function
dilogarithm
direction vector, random 2D
direction vector, random 3D
direction vector, random N-dimensional
Dirichlet distribution
discontinuities, in ODE systems
Discrete Fourier Transforms, see FFT
discrete Hankel transforms
Discrete Newton algorithm for multidimensional roots
Discrete random numbers
,
[1]
,
[2]
,
[3]
Discrete random numbers, preprocessing
divided differences, polynomials
division by zero, IEEE exceptions
Dogleg algorithm
Dogleg algorithm, double
dollar sign $, shell prompt
DOT, Level-1 BLAS
double Dogleg algorithm
double factorial
double precision, IEEE format
downloading GSL
DWT initialization
DWT, mathematical definition
DWT, one dimensional
DWT, see wavelet transforms
DWT, two dimensional
E
e, defined as a macro
E1(x)
E2(x)
Ei(x)
eigenvalues and eigenvectors
elementary functions
elementary operations
elliptic functions (Jacobi)
elliptic integrals
energy function
energy, units of
erf(x)
erfc(x)
Erlang distribution
error codes
error codes, reserved
error function
error handlers
error handling
error handling macros
estimated standard deviation
estimated variance
estimation, location
estimation, scale
Eta Function
euclidean distance function, hypot
euclidean distance function, hypot3
Euler's constant, defined as a macro
evaluation of polynomials
evaluation of polynomials, in divided difference form
examples, conventions used in
exceptions, C++
exceptions, floating point
exceptions, IEEE arithmetic
exchanging permutation elements
exp
expm1
exponent, IEEE format
Exponential distribution
exponential function
exponential integrals
Exponential power distribution
exponential, difference from 1 computed accurately
exponentiation of complex number
extern inline
F
F-distribution
factorial
,
[1]
factorization of matrices
false position algorithm for finding roots
Fast Fourier Transforms, see FFT
Fehlberg method, differential equations
Fermi-Dirac function
FFT
FFT mathematical definition
FFT of complex data, mixed-radix algorithm
FFT of complex data, radix-2 algorithm
FFT of real data
FFT of real data, mixed-radix algorithm
FFT of real data, radix-2 algorithm
FFT, complex data
finding minima
finding roots
finding zeros
fits, multi-parameter linear
fitting
fitting, using Chebyshev polynomials
Fj(x), Fermi-Dirac integral
Fj(x,b), incomplete Fermi-Dirac integral
flat distribution
Fletcher-Reeves conjugate gradient algorithm, minimization
floating point exceptions
floating point numbers, approximate comparison
floating point registers
force and energy
Fortran range checking, equivalent in gcc
Four-tap Generalized Feedback Shift Register
Fourier integrals, numerical
Fourier Transforms, see FFT
Fractional Order Bessel Functions
free software, explanation of
frexp
functions, numerical differentiation
fundamental constants
G
Gamma distribution
gamma functions
Gastwirth estimator
Gauss-Kronrod quadrature
Gaussian distribution
Gaussian distribution, bivariate
,
[1]
Gaussian Tail distribution
gcc extensions, range-checking
gcc warning options
gdb
Gegenbauer functions
GEMM, Level-3 BLAS
GEMV, Level-2 BLAS
general polynomial equations, solving
generalized eigensystems
generalized hermitian definite eigensystems
generalized symmetric eigensystems
Geometric random variates
,
[1]
GER, Level-2 BLAS
GERC, Level-2 BLAS
GERU, Level-2 BLAS
Givens rotation
Givens Rotation, BLAS
Givens Rotation, Modified, BLAS
gmres
GNU General Public License
golden section algorithm for finding minima
gsl_acosh (C function)
gsl_asinh (C function)
gsl_atanh (C function)
gsl_blas_caxpy (C function)
gsl_blas_ccopy (C function)
gsl_blas_cdotc (C function)
gsl_blas_cdotu (C function)
gsl_blas_cgemm (C function)
gsl_blas_cgemv (C function)
gsl_blas_cgerc (C function)
gsl_blas_cgeru (C function)
gsl_blas_chemm (C function)
gsl_blas_chemv (C function)
gsl_blas_cher (C function)
gsl_blas_cher2 (C function)
gsl_blas_cher2k (C function)
gsl_blas_cherk (C function)
gsl_blas_cscal (C function)
gsl_blas_csscal (C function)
gsl_blas_cswap (C function)
gsl_blas_csymm (C function)
gsl_blas_csyr2k (C function)
gsl_blas_csyrk (C function)
gsl_blas_ctrmm (C function)
gsl_blas_ctrmv (C function)
gsl_blas_ctrsm (C function)
gsl_blas_ctrsv (C function)
gsl_blas_dasum (C function)
gsl_blas_daxpy (C function)
gsl_blas_dcopy (C function)
gsl_blas_ddot (C function)
gsl_blas_dgemm (C function)
gsl_blas_dgemv (C function)
gsl_blas_dger (C function)
gsl_blas_dnrm2 (C function)
gsl_blas_drot (C function)
gsl_blas_drotg (C function)
gsl_blas_drotm (C function)
gsl_blas_drotmg (C function)
gsl_blas_dscal (C function)
gsl_blas_dsdot (C function)
gsl_blas_dswap (C function)
gsl_blas_dsymm (C function)
gsl_blas_dsymv (C function)
gsl_blas_dsyr (C function)
gsl_blas_dsyr2 (C function)
gsl_blas_dsyr2k (C function)
gsl_blas_dsyrk (C function)
gsl_blas_dtrmm (C function)
gsl_blas_dtrmv (C function)
gsl_blas_dtrsm (C function)
gsl_blas_dtrsv (C function)
gsl_blas_dzasum (C function)
gsl_blas_dznrm2 (C function)
gsl_blas_icamax (C function)
gsl_blas_idamax (C function)
gsl_blas_isamax (C function)
gsl_blas_izamax (C function)
gsl_blas_sasum (C function)
gsl_blas_saxpy (C function)
gsl_blas_scasum (C function)
gsl_blas_scnrm2 (C function)
gsl_blas_scopy (C function)
gsl_blas_sdot (C function)
gsl_blas_sdsdot (C function)
gsl_blas_sgemm (C function)
gsl_blas_sgemv (C function)
gsl_blas_sger (C function)
gsl_blas_snrm2 (C function)
gsl_blas_srot (C function)
gsl_blas_srotg (C function)
gsl_blas_srotm (C function)
gsl_blas_srotmg (C function)
gsl_blas_sscal (C function)
gsl_blas_sswap (C function)
gsl_blas_ssymm (C function)
gsl_blas_ssymv (C function)
gsl_blas_ssyr (C function)
gsl_blas_ssyr2 (C function)
gsl_blas_ssyr2k (C function)
gsl_blas_ssyrk (C function)
gsl_blas_strmm (C function)
gsl_blas_strmv (C function)
gsl_blas_strsm (C function)
gsl_blas_strsv (C function)
gsl_blas_zaxpy (C function)
gsl_blas_zcopy (C function)
gsl_blas_zdotc (C function)
gsl_blas_zdotu (C function)
gsl_blas_zdscal (C function)
gsl_blas_zgemm (C function)
gsl_blas_zgemv (C function)
gsl_blas_zgerc (C function)
gsl_blas_zgeru (C function)
gsl_blas_zhemm (C function)
gsl_blas_zhemv (C function)
gsl_blas_zher (C function)
gsl_blas_zher2 (C function)
gsl_blas_zher2k (C function)
gsl_blas_zherk (C function)
gsl_blas_zscal (C function)
gsl_blas_zswap (C function)
gsl_blas_zsymm (C function)
gsl_blas_zsyr2k (C function)
gsl_blas_zsyrk (C function)
gsl_blas_ztrmm (C function)
gsl_blas_ztrmv (C function)
gsl_blas_ztrsm (C function)
gsl_blas_ztrsv (C function)
gsl_block (C type)
gsl_block_alloc (C function)
gsl_block_calloc (C function)
gsl_block_fprintf (C function)
gsl_block_fread (C function)
gsl_block_free (C function)
gsl_block_fscanf (C function)
gsl_block_fwrite (C function)
gsl_bspline_alloc (C function)
gsl_bspline_alloc_ncontrol (C function)
gsl_bspline_basis (C function)
gsl_bspline_basis_deriv (C function)
gsl_bspline_basis_integ (C function)
gsl_bspline_calc (C function)
gsl_bspline_calc_deriv (C function)
gsl_bspline_calc_integ (C function)
gsl_bspline_col_interp (C function)
gsl_bspline_covariance (C function)
gsl_bspline_err (C function)
gsl_bspline_free (C function)
gsl_bspline_gram (C function)
gsl_bspline_gram_interval (C function)
gsl_bspline_greville_abscissa (C function)
gsl_bspline_init (C function)
gsl_bspline_init_augment (C function)
gsl_bspline_init_hermite (C function)
gsl_bspline_init_interp (C function)
gsl_bspline_init_periodic (C function)
gsl_bspline_init_uniform (C function)
gsl_bspline_interp_chermite (C function)
gsl_bspline_lsnormal (C function)
gsl_bspline_lsnormalm (C function)
gsl_bspline_lssolve (C function)
gsl_bspline_nbreak (C function)
gsl_bspline_ncontrol (C function)
gsl_bspline_oprod (C function)
gsl_bspline_order (C function)
gsl_bspline_plsqr (C function)
gsl_bspline_plssolve (C function)
gsl_bspline_proj_rhs (C function)
gsl_bspline_pwlssolve (C function)
gsl_bspline_rcond (C function)
gsl_bspline_residuals (C function)
gsl_bspline_vector_calc (C function)
gsl_bspline_vector_calc_deriv (C function)
gsl_bspline_wlssolve (C function)
gsl_bspline_workspace (C type)
GSL_C99_INLINE
(C macro)
gsl_cdf_beta_P (C function)
gsl_cdf_beta_Pinv (C function)
gsl_cdf_beta_Q (C function)
gsl_cdf_beta_Qinv (C function)
gsl_cdf_binomial_P (C function)
gsl_cdf_binomial_Q (C function)
gsl_cdf_cauchy_P (C function)
gsl_cdf_cauchy_Pinv (C function)
gsl_cdf_cauchy_Q (C function)
gsl_cdf_cauchy_Qinv (C function)
gsl_cdf_chisq_P (C function)
gsl_cdf_chisq_Pinv (C function)
gsl_cdf_chisq_Q (C function)
gsl_cdf_chisq_Qinv (C function)
gsl_cdf_exponential_P (C function)
gsl_cdf_exponential_Pinv (C function)
gsl_cdf_exponential_Q (C function)
gsl_cdf_exponential_Qinv (C function)
gsl_cdf_exppow_P (C function)
gsl_cdf_exppow_Q (C function)
gsl_cdf_fdist_P (C function)
gsl_cdf_fdist_Pinv (C function)
gsl_cdf_fdist_Q (C function)
gsl_cdf_fdist_Qinv (C function)
gsl_cdf_flat_P (C function)
gsl_cdf_flat_Pinv (C function)
gsl_cdf_flat_Q (C function)
gsl_cdf_flat_Qinv (C function)
gsl_cdf_gamma_P (C function)
gsl_cdf_gamma_Pinv (C function)
gsl_cdf_gamma_Q (C function)
gsl_cdf_gamma_Qinv (C function)
gsl_cdf_gaussian_P (C function)
gsl_cdf_gaussian_Pinv (C function)
gsl_cdf_gaussian_Q (C function)
gsl_cdf_gaussian_Qinv (C function)
gsl_cdf_geometric_P (C function)
gsl_cdf_geometric_Q (C function)
gsl_cdf_gumbel1_P (C function)
gsl_cdf_gumbel1_Pinv (C function)
gsl_cdf_gumbel1_Q (C function)
gsl_cdf_gumbel1_Qinv (C function)
gsl_cdf_gumbel2_P (C function)
gsl_cdf_gumbel2_Pinv (C function)
gsl_cdf_gumbel2_Q (C function)
gsl_cdf_gumbel2_Qinv (C function)
gsl_cdf_hypergeometric_P (C function)
gsl_cdf_hypergeometric_Q (C function)
gsl_cdf_laplace_P (C function)
gsl_cdf_laplace_Pinv (C function)
gsl_cdf_laplace_Q (C function)
gsl_cdf_laplace_Qinv (C function)
gsl_cdf_logistic_P (C function)
gsl_cdf_logistic_Pinv (C function)
gsl_cdf_logistic_Q (C function)
gsl_cdf_logistic_Qinv (C function)
gsl_cdf_lognormal_P (C function)
gsl_cdf_lognormal_Pinv (C function)
gsl_cdf_lognormal_Q (C function)
gsl_cdf_lognormal_Qinv (C function)
gsl_cdf_negative_binomial_P (C function)
gsl_cdf_negative_binomial_Q (C function)
gsl_cdf_pareto_P (C function)
gsl_cdf_pareto_Pinv (C function)
gsl_cdf_pareto_Q (C function)
gsl_cdf_pareto_Qinv (C function)
gsl_cdf_pascal_P (C function)
gsl_cdf_pascal_Q (C function)
gsl_cdf_poisson_P (C function)
gsl_cdf_poisson_Q (C function)
gsl_cdf_rayleigh_P (C function)
gsl_cdf_rayleigh_Pinv (C function)
gsl_cdf_rayleigh_Q (C function)
gsl_cdf_rayleigh_Qinv (C function)
gsl_cdf_tdist_P (C function)
gsl_cdf_tdist_Pinv (C function)
gsl_cdf_tdist_Q (C function)
gsl_cdf_tdist_Qinv (C function)
gsl_cdf_ugaussian_P (C function)
gsl_cdf_ugaussian_Pinv (C function)
gsl_cdf_ugaussian_Q (C function)
gsl_cdf_ugaussian_Qinv (C function)
gsl_cdf_weibull_P (C function)
gsl_cdf_weibull_Pinv (C function)
gsl_cdf_weibull_Q (C function)
gsl_cdf_weibull_Qinv (C function)
gsl_cheb_alloc (C function)
gsl_cheb_calc_deriv (C function)
gsl_cheb_calc_integ (C function)
gsl_cheb_coeffs (C function)
gsl_cheb_eval (C function)
gsl_cheb_eval_err (C function)
gsl_cheb_eval_n (C function)
gsl_cheb_eval_n_err (C function)
gsl_cheb_free (C function)
gsl_cheb_init (C function)
gsl_cheb_order (C function)
gsl_cheb_series (C type)
gsl_cheb_size (C function)
gsl_check_range (C var)
gsl_combination (C type)
gsl_combination_alloc (C function)
gsl_combination_calloc (C function)
gsl_combination_data (C function)
gsl_combination_fprintf (C function)
gsl_combination_fread (C function)
gsl_combination_free (C function)
gsl_combination_fscanf (C function)
gsl_combination_fwrite (C function)
gsl_combination_get (C function)
gsl_combination_init_first (C function)
gsl_combination_init_last (C function)
gsl_combination_k (C function)
gsl_combination_memcpy (C function)
gsl_combination_n (C function)
gsl_combination_next (C function)
gsl_combination_prev (C function)
gsl_combination_valid (C function)
gsl_complex
gsl_complex_abs (C function)
gsl_complex_abs2 (C function)
gsl_complex_add (C function)
gsl_complex_add_imag (C function)
gsl_complex_add_real (C function)
gsl_complex_arccos (C function)
gsl_complex_arccos_real (C function)
gsl_complex_arccosh (C function)
gsl_complex_arccosh_real (C function)
gsl_complex_arccot (C function)
gsl_complex_arccoth (C function)
gsl_complex_arccsc (C function)
gsl_complex_arccsc_real (C function)
gsl_complex_arccsch (C function)
gsl_complex_arcsec (C function)
gsl_complex_arcsec_real (C function)
gsl_complex_arcsech (C function)
gsl_complex_arcsin (C function)
gsl_complex_arcsin_real (C function)
gsl_complex_arcsinh (C function)
gsl_complex_arctan (C function)
gsl_complex_arctanh (C function)
gsl_complex_arctanh_real (C function)
gsl_complex_arg (C function)
gsl_complex_conjugate (C function)
gsl_complex_cos (C function)
gsl_complex_cosh (C function)
gsl_complex_cot (C function)
gsl_complex_coth (C function)
gsl_complex_csc (C function)
gsl_complex_csch (C function)
gsl_complex_div (C function)
gsl_complex_div_imag (C function)
gsl_complex_div_real (C function)
gsl_complex_exp (C function)
gsl_complex_inverse (C function)
gsl_complex_log (C function)
gsl_complex_log10 (C function)
gsl_complex_log_b (C function)
gsl_complex_logabs (C function)
gsl_complex_mul (C function)
gsl_complex_mul_imag (C function)
gsl_complex_mul_real (C function)
gsl_complex_negative (C function)
gsl_complex_polar (C function)
gsl_complex_poly_complex_eval (C function)
gsl_complex_pow (C function)
gsl_complex_pow_real (C function)
gsl_complex_rect (C function)
gsl_complex_sec (C function)
gsl_complex_sech (C function)
gsl_complex_sin (C function)
gsl_complex_sinh (C function)
gsl_complex_sqrt (C function)
gsl_complex_sqrt_real (C function)
gsl_complex_sub (C function)
gsl_complex_sub_imag (C function)
gsl_complex_sub_real (C function)
gsl_complex_tan (C function)
gsl_complex_tanh (C function)
GSL_CONST_MKSA_ACRE (C macro)
GSL_CONST_MKSA_ANGSTROM (C macro)
GSL_CONST_MKSA_ASTRONOMICAL_UNIT (C macro)
GSL_CONST_MKSA_BAR (C macro)
GSL_CONST_MKSA_BARN (C macro)
GSL_CONST_MKSA_BOHR_MAGNETON (C macro)
GSL_CONST_MKSA_BOHR_RADIUS (C macro)
GSL_CONST_MKSA_BOLTZMANN (C macro)
GSL_CONST_MKSA_BTU (C macro)
GSL_CONST_MKSA_CALORIE (C macro)
GSL_CONST_MKSA_CANADIAN_GALLON (C macro)
GSL_CONST_MKSA_CARAT (C macro)
GSL_CONST_MKSA_CURIE (C macro)
GSL_CONST_MKSA_DAY (C macro)
GSL_CONST_MKSA_DEBYE (C macro)
GSL_CONST_MKSA_DYNE (C macro)
GSL_CONST_MKSA_ELECTRON_CHARGE (C macro)
GSL_CONST_MKSA_ELECTRON_MAGNETIC_MOMENT (C macro)
GSL_CONST_MKSA_ELECTRON_VOLT (C macro)
GSL_CONST_MKSA_ERG (C macro)
GSL_CONST_MKSA_FARADAY (C macro)
GSL_CONST_MKSA_FATHOM (C macro)
GSL_CONST_MKSA_FOOT (C macro)
GSL_CONST_MKSA_FOOTCANDLE (C macro)
GSL_CONST_MKSA_FOOTLAMBERT (C macro)
GSL_CONST_MKSA_GAUSS (C macro)
GSL_CONST_MKSA_GRAM_FORCE (C macro)
GSL_CONST_MKSA_GRAV_ACCEL (C macro)
GSL_CONST_MKSA_GRAVITATIONAL_CONSTANT (C macro)
GSL_CONST_MKSA_HECTARE (C macro)
GSL_CONST_MKSA_HORSEPOWER (C macro)
GSL_CONST_MKSA_HOUR (C macro)
GSL_CONST_MKSA_INCH (C macro)
GSL_CONST_MKSA_INCH_OF_MERCURY (C macro)
GSL_CONST_MKSA_INCH_OF_WATER (C macro)
GSL_CONST_MKSA_JOULE (C macro)
GSL_CONST_MKSA_KILOMETERS_PER_HOUR (C macro)
GSL_CONST_MKSA_KILOPOUND_FORCE (C macro)
GSL_CONST_MKSA_KNOT (C macro)
GSL_CONST_MKSA_LAMBERT (C macro)
GSL_CONST_MKSA_LIGHT_YEAR (C macro)
GSL_CONST_MKSA_LITER (C macro)
GSL_CONST_MKSA_LUMEN (C macro)
GSL_CONST_MKSA_LUX (C macro)
GSL_CONST_MKSA_MASS_ELECTRON (C macro)
GSL_CONST_MKSA_MASS_MUON (C macro)
GSL_CONST_MKSA_MASS_NEUTRON (C macro)
GSL_CONST_MKSA_MASS_PROTON (C macro)
GSL_CONST_MKSA_METER_OF_MERCURY (C macro)
GSL_CONST_MKSA_METRIC_TON (C macro)
GSL_CONST_MKSA_MICRON (C macro)
GSL_CONST_MKSA_MIL (C macro)
GSL_CONST_MKSA_MILE (C macro)
GSL_CONST_MKSA_MILES_PER_HOUR (C macro)
GSL_CONST_MKSA_MINUTE (C macro)
GSL_CONST_MKSA_MOLAR_GAS (C macro)
GSL_CONST_MKSA_NAUTICAL_MILE (C macro)
GSL_CONST_MKSA_NEWTON (C macro)
GSL_CONST_MKSA_NUCLEAR_MAGNETON (C macro)
GSL_CONST_MKSA_OUNCE_MASS (C macro)
GSL_CONST_MKSA_PARSEC (C macro)
GSL_CONST_MKSA_PHOT (C macro)
GSL_CONST_MKSA_PINT (C macro)
GSL_CONST_MKSA_PLANCKS_CONSTANT_H (C macro)
GSL_CONST_MKSA_PLANCKS_CONSTANT_HBAR (C macro)
GSL_CONST_MKSA_POINT (C macro)
GSL_CONST_MKSA_POISE (C macro)
GSL_CONST_MKSA_POUND_FORCE (C macro)
GSL_CONST_MKSA_POUND_MASS (C macro)
GSL_CONST_MKSA_POUNDAL (C macro)
GSL_CONST_MKSA_PROTON_MAGNETIC_MOMENT (C macro)
GSL_CONST_MKSA_PSI (C macro)
GSL_CONST_MKSA_QUART (C macro)
GSL_CONST_MKSA_RAD (C macro)
GSL_CONST_MKSA_ROENTGEN (C macro)
GSL_CONST_MKSA_RYDBERG (C macro)
GSL_CONST_MKSA_SOLAR_MASS (C macro)
GSL_CONST_MKSA_SPEED_OF_LIGHT (C macro)
GSL_CONST_MKSA_STANDARD_GAS_VOLUME (C macro)
GSL_CONST_MKSA_STD_ATMOSPHERE (C macro)
GSL_CONST_MKSA_STEFAN_BOLTZMANN_CONSTANT (C macro)
GSL_CONST_MKSA_STILB (C macro)
GSL_CONST_MKSA_STOKES (C macro)
GSL_CONST_MKSA_TEXPOINT (C macro)
GSL_CONST_MKSA_THERM (C macro)
GSL_CONST_MKSA_THOMSON_CROSS_SECTION (C macro)
GSL_CONST_MKSA_TON (C macro)
GSL_CONST_MKSA_TORR (C macro)
GSL_CONST_MKSA_TROY_OUNCE (C macro)
GSL_CONST_MKSA_UK_GALLON (C macro)
GSL_CONST_MKSA_UK_TON (C macro)
GSL_CONST_MKSA_UNIFIED_ATOMIC_MASS (C macro)
GSL_CONST_MKSA_US_GALLON (C macro)
GSL_CONST_MKSA_VACUUM_PERMEABILITY (C macro)
GSL_CONST_MKSA_VACUUM_PERMITTIVITY (C macro)
GSL_CONST_MKSA_WEEK (C macro)
GSL_CONST_MKSA_YARD (C macro)
GSL_CONST_NUM_ATTO (C macro)
GSL_CONST_NUM_AVOGADRO (C macro)
GSL_CONST_NUM_EXA (C macro)
GSL_CONST_NUM_FEMTO (C macro)
GSL_CONST_NUM_FINE_STRUCTURE (C macro)
GSL_CONST_NUM_GIGA (C macro)
GSL_CONST_NUM_KILO (C macro)
GSL_CONST_NUM_MEGA (C macro)
GSL_CONST_NUM_MICRO (C macro)
GSL_CONST_NUM_MILLI (C macro)
GSL_CONST_NUM_NANO (C macro)
GSL_CONST_NUM_PETA (C macro)
GSL_CONST_NUM_PICO (C macro)
GSL_CONST_NUM_TERA (C macro)
GSL_CONST_NUM_YOCTO (C macro)
GSL_CONST_NUM_YOTTA (C macro)
GSL_CONST_NUM_ZEPTO (C macro)
GSL_CONST_NUM_ZETTA (C macro)
gsl_deriv_backward (C function)
gsl_deriv_central (C function)
gsl_deriv_forward (C function)
gsl_dht (C type)
gsl_dht_alloc (C function)
gsl_dht_apply (C function)
gsl_dht_free (C function)
gsl_dht_init (C function)
gsl_dht_k_sample (C function)
gsl_dht_new (C function)
gsl_dht_x_sample (C function)
GSL_EDOM (C var)
gsl_eigen_gen (C function)
gsl_eigen_gen_alloc (C function)
gsl_eigen_gen_free (C function)
gsl_eigen_gen_params (C function)
gsl_eigen_gen_QZ (C function)
gsl_eigen_gen_workspace (C type)
gsl_eigen_genherm (C function)
gsl_eigen_genherm_alloc (C function)
gsl_eigen_genherm_free (C function)
gsl_eigen_genherm_workspace (C type)
gsl_eigen_genhermv (C function)
gsl_eigen_genhermv_alloc (C function)
gsl_eigen_genhermv_free (C function)
gsl_eigen_genhermv_sort (C function)
gsl_eigen_genhermv_workspace (C type)
gsl_eigen_gensymm (C function)
gsl_eigen_gensymm_alloc (C function)
gsl_eigen_gensymm_free (C function)
gsl_eigen_gensymm_workspace (C type)
gsl_eigen_gensymmv (C function)
gsl_eigen_gensymmv_alloc (C function)
gsl_eigen_gensymmv_free (C function)
gsl_eigen_gensymmv_sort (C function)
gsl_eigen_gensymmv_workspace (C type)
gsl_eigen_genv (C function)
gsl_eigen_genv_alloc (C function)
gsl_eigen_genv_free (C function)
gsl_eigen_genv_QZ (C function)
gsl_eigen_genv_sort (C function)
gsl_eigen_genv_workspace (C type)
gsl_eigen_herm (C function)
gsl_eigen_herm_alloc (C function)
gsl_eigen_herm_free (C function)
gsl_eigen_herm_workspace (C type)
gsl_eigen_hermv (C function)
gsl_eigen_hermv_alloc (C function)
gsl_eigen_hermv_free (C function)
gsl_eigen_hermv_sort (C function)
gsl_eigen_hermv_workspace (C type)
gsl_eigen_nonsymm (C function)
gsl_eigen_nonsymm_alloc (C function)
gsl_eigen_nonsymm_free (C function)
gsl_eigen_nonsymm_params (C function)
gsl_eigen_nonsymm_workspace (C type)
gsl_eigen_nonsymm_Z (C function)
gsl_eigen_nonsymmv (C function)
gsl_eigen_nonsymmv_alloc (C function)
gsl_eigen_nonsymmv_free (C function)
gsl_eigen_nonsymmv_params (C function)
gsl_eigen_nonsymmv_sort (C function)
gsl_eigen_nonsymmv_workspace (C type)
gsl_eigen_nonsymmv_Z (C function)
gsl_eigen_symm (C function)
gsl_eigen_symm_alloc (C function)
gsl_eigen_symm_free (C function)
gsl_eigen_symm_workspace (C type)
gsl_eigen_symmv (C function)
gsl_eigen_symmv_alloc (C function)
gsl_eigen_symmv_free (C function)
gsl_eigen_symmv_sort (C function)
gsl_eigen_symmv_sort.gsl_eigen_sort_t (C type)
gsl_eigen_symmv_workspace (C type)
GSL_EINVAL (C var)
GSL_ENOMEM (C var)
GSL_ERANGE (C var)
GSL_ERROR (C macro)
gsl_error_handler_t (C type)
GSL_ERROR_VAL (C macro)
gsl_expm1 (C function)
gsl_fcmp (C function)
gsl_fft_complex_backward (C function)
gsl_fft_complex_forward (C function)
gsl_fft_complex_inverse (C function)
gsl_fft_complex_radix2_backward (C function)
gsl_fft_complex_radix2_dif_backward (C function)
gsl_fft_complex_radix2_dif_forward (C function)
gsl_fft_complex_radix2_dif_inverse (C function)
gsl_fft_complex_radix2_dif_transform (C function)
gsl_fft_complex_radix2_forward (C function)
gsl_fft_complex_radix2_inverse (C function)
gsl_fft_complex_radix2_transform (C function)
gsl_fft_complex_transform (C function)
gsl_fft_complex_wavetable (C type)
gsl_fft_complex_wavetable_alloc (C function)
gsl_fft_complex_wavetable_free (C function)
gsl_fft_complex_workspace (C type)
gsl_fft_complex_workspace_alloc (C function)
gsl_fft_complex_workspace_free (C function)
gsl_fft_halfcomplex_radix2_backward (C function)
gsl_fft_halfcomplex_radix2_inverse (C function)
gsl_fft_halfcomplex_radix2_unpack (C function)
gsl_fft_halfcomplex_transform (C function)
gsl_fft_halfcomplex_unpack (C function)
gsl_fft_halfcomplex_wavetable (C type)
gsl_fft_halfcomplex_wavetable_alloc (C function)
gsl_fft_halfcomplex_wavetable_free (C function)
gsl_fft_real_radix2_transform (C function)
gsl_fft_real_transform (C function)
gsl_fft_real_unpack (C function)
gsl_fft_real_wavetable (C type)
gsl_fft_real_wavetable_alloc (C function)
gsl_fft_real_wavetable_free (C function)
gsl_fft_real_workspace (C type)
gsl_fft_real_workspace_alloc (C function)
gsl_fft_real_workspace_free (C function)
gsl_filter_end_t (C type)
gsl_filter_end_t.GSL_FILTER_END_PADVALUE (C macro)
gsl_filter_end_t.GSL_FILTER_END_PADZERO (C macro)
gsl_filter_end_t.GSL_FILTER_END_TRUNCATE (C macro)
gsl_filter_gaussian (C function)
gsl_filter_gaussian_alloc (C function)
gsl_filter_gaussian_free (C function)
gsl_filter_gaussian_kernel (C function)
gsl_filter_impulse (C function)
gsl_filter_impulse_alloc (C function)
gsl_filter_impulse_free (C function)
gsl_filter_median (C function)
gsl_filter_median_alloc (C function)
gsl_filter_median_free (C function)
gsl_filter_rmedian (C function)
gsl_filter_rmedian_alloc (C function)
gsl_filter_rmedian_free (C function)
gsl_filter_scale_t (C type)
gsl_filter_scale_t.GSL_FILTER_SCALE_IQR (C macro)
gsl_filter_scale_t.GSL_FILTER_SCALE_MAD (C macro)
gsl_filter_scale_t.GSL_FILTER_SCALE_QN (C macro)
gsl_filter_scale_t.GSL_FILTER_SCALE_SN (C macro)
gsl_finite (C function)
gsl_fit_linear (C function)
gsl_fit_linear_est (C function)
gsl_fit_mul (C function)
gsl_fit_mul_est (C function)
gsl_fit_wlinear (C function)
gsl_fit_wmul (C function)
gsl_frexp (C function)
gsl_function (C type)
gsl_function_fdf (C type)
gsl_heapsort (C function)
gsl_heapsort.gsl_comparison_fn_t (C type)
gsl_heapsort_index (C function)
gsl_histogram (C type)
gsl_histogram2d (C type)
gsl_histogram2d_accumulate (C function)
gsl_histogram2d_add (C function)
gsl_histogram2d_alloc (C function)
gsl_histogram2d_clone (C function)
gsl_histogram2d_cov (C function)
gsl_histogram2d_div (C function)
gsl_histogram2d_equal_bins_p (C function)
gsl_histogram2d_find (C function)
gsl_histogram2d_fprintf (C function)
gsl_histogram2d_fread (C function)
gsl_histogram2d_free (C function)
gsl_histogram2d_fscanf (C function)
gsl_histogram2d_fwrite (C function)
gsl_histogram2d_get (C function)
gsl_histogram2d_get_xrange (C function)
gsl_histogram2d_get_yrange (C function)
gsl_histogram2d_increment (C function)
gsl_histogram2d_max_bin (C function)
gsl_histogram2d_max_val (C function)
gsl_histogram2d_memcpy (C function)
gsl_histogram2d_min_bin (C function)
gsl_histogram2d_min_val (C function)
gsl_histogram2d_mul (C function)
gsl_histogram2d_nx (C function)
gsl_histogram2d_ny (C function)
gsl_histogram2d_pdf (C type)
gsl_histogram2d_pdf_alloc (C function)
gsl_histogram2d_pdf_free (C function)
gsl_histogram2d_pdf_init (C function)
gsl_histogram2d_pdf_sample (C function)
gsl_histogram2d_reset (C function)
gsl_histogram2d_scale (C function)
gsl_histogram2d_set_ranges (C function)
gsl_histogram2d_set_ranges_uniform (C function)
gsl_histogram2d_shift (C function)
gsl_histogram2d_sub (C function)
gsl_histogram2d_sum (C function)
gsl_histogram2d_xmax (C function)
gsl_histogram2d_xmean (C function)
gsl_histogram2d_xmin (C function)
gsl_histogram2d_xsigma (C function)
gsl_histogram2d_ymax (C function)
gsl_histogram2d_ymean (C function)
gsl_histogram2d_ymin (C function)
gsl_histogram2d_ysigma (C function)
gsl_histogram_accumulate (C function)
gsl_histogram_add (C function)
gsl_histogram_alloc (C function)
gsl_histogram_bins (C function)
gsl_histogram_clone (C function)
gsl_histogram_div (C function)
gsl_histogram_equal_bins_p (C function)
gsl_histogram_find (C function)
gsl_histogram_fprintf (C function)
gsl_histogram_fread (C function)
gsl_histogram_free (C function)
gsl_histogram_fscanf (C function)
gsl_histogram_fwrite (C function)
gsl_histogram_get (C function)
gsl_histogram_get_range (C function)
gsl_histogram_increment (C function)
gsl_histogram_max (C function)
gsl_histogram_max_bin (C function)
gsl_histogram_max_val (C function)
gsl_histogram_mean (C function)
gsl_histogram_memcpy (C function)
gsl_histogram_min (C function)
gsl_histogram_min_bin (C function)
gsl_histogram_min_val (C function)
gsl_histogram_mul (C function)
gsl_histogram_pdf (C type)
gsl_histogram_pdf_alloc (C function)
gsl_histogram_pdf_free (C function)
gsl_histogram_pdf_init (C function)
gsl_histogram_pdf_sample (C function)
gsl_histogram_reset (C function)
gsl_histogram_scale (C function)
gsl_histogram_set_ranges (C function)
gsl_histogram_set_ranges_uniform (C function)
gsl_histogram_shift (C function)
gsl_histogram_sigma (C function)
gsl_histogram_sub (C function)
gsl_histogram_sum (C function)
gsl_hypot (C function)
gsl_hypot3 (C function)
gsl_ieee_env_setup (C function)
gsl_ieee_fprintf_double (C function)
gsl_ieee_fprintf_float (C function)
GSL_IEEE_MODE (C macro)
gsl_ieee_printf_double (C function)
gsl_ieee_printf_float (C function)
GSL_IMAG (C macro)
gsl_integration_cquad (C function)
gsl_integration_cquad_workspace
gsl_integration_cquad_workspace_alloc (C function)
gsl_integration_cquad_workspace_free (C function)
gsl_integration_fixed (C function)
gsl_integration_fixed_alloc (C function)
gsl_integration_fixed_alloc.gsl_integration_fixed_type (C type)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_chebyshev (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_chebyshev2 (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_exponential (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_gegenbauer (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_hermite (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_jacobi (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_laguerre (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_legendre (C var)
gsl_integration_fixed_alloc.gsl_integration_fixed_type.gsl_integration_fixed_rational (C var)
gsl_integration_fixed_free (C function)
gsl_integration_fixed_n (C function)
gsl_integration_fixed_nodes (C function)
gsl_integration_fixed_weights (C function)
gsl_integration_fixed_workspace (C type)
gsl_integration_glfixed (C function)
gsl_integration_glfixed_point (C function)
gsl_integration_glfixed_table
,
[1]
gsl_integration_glfixed_table_alloc (C function)
gsl_integration_glfixed_table_free (C function)
gsl_integration_lebedev_alloc (C function)
gsl_integration_lebedev_free (C function)
gsl_integration_lebedev_n (C function)
gsl_integration_lebedev_workspace (C type)
gsl_integration_qag (C function)
gsl_integration_qagi (C function)
gsl_integration_qagil (C function)
gsl_integration_qagiu (C function)
gsl_integration_qagp (C function)
gsl_integration_qags (C function)
gsl_integration_qawc (C function)
gsl_integration_qawf (C function)
gsl_integration_qawo (C function)
gsl_integration_qawo_table
gsl_integration_qawo_table_alloc (C function)
gsl_integration_qawo_table_alloc.GSL_INTEG_COSINE (C macro)
gsl_integration_qawo_table_alloc.GSL_INTEG_SINE (C macro)
gsl_integration_qawo_table_free (C function)
gsl_integration_qawo_table_set (C function)
gsl_integration_qawo_table_set_length (C function)
gsl_integration_qaws (C function)
gsl_integration_qaws_table (C type)
gsl_integration_qaws_table_alloc (C function)
gsl_integration_qaws_table_free (C function)
gsl_integration_qaws_table_set (C function)
gsl_integration_qng (C function)
gsl_integration_romberg (C function)
gsl_integration_romberg_alloc (C function)
gsl_integration_romberg_free (C function)
gsl_integration_workspace
(C type)
gsl_integration_workspace_alloc (C function)
gsl_integration_workspace_free (C function)
gsl_interp (C type)
gsl_interp2d (C type)
gsl_interp2d_alloc (C function)
gsl_interp2d_eval (C function)
gsl_interp2d_eval_deriv_x (C function)
gsl_interp2d_eval_deriv_x_e (C function)
gsl_interp2d_eval_deriv_xx (C function)
gsl_interp2d_eval_deriv_xx_e (C function)
gsl_interp2d_eval_deriv_xy (C function)
gsl_interp2d_eval_deriv_xy_e (C function)
gsl_interp2d_eval_deriv_y (C function)
gsl_interp2d_eval_deriv_y_e (C function)
gsl_interp2d_eval_deriv_yy (C function)
gsl_interp2d_eval_deriv_yy_e (C function)
gsl_interp2d_eval_e (C function)
gsl_interp2d_eval_extrap (C function)
gsl_interp2d_eval_extrap_e (C function)
gsl_interp2d_free (C function)
gsl_interp2d_get (C function)
gsl_interp2d_idx (C function)
gsl_interp2d_init (C function)
gsl_interp2d_min_size (C function)
gsl_interp2d_name (C function)
gsl_interp2d_set (C function)
gsl_interp2d_type (C type)
gsl_interp2d_type.gsl_interp2d_bicubic (C var)
gsl_interp2d_type.gsl_interp2d_bilinear (C var)
gsl_interp2d_type_min_size (C function)
gsl_interp_accel (C type)
gsl_interp_accel_alloc (C function)
gsl_interp_accel_find (C function)
gsl_interp_accel_free (C function)
gsl_interp_accel_reset (C function)
gsl_interp_alloc (C function)
gsl_interp_bsearch (C function)
gsl_interp_eval (C function)
gsl_interp_eval_deriv (C function)
gsl_interp_eval_deriv2 (C function)
gsl_interp_eval_deriv2_e (C function)
gsl_interp_eval_deriv_e (C function)
gsl_interp_eval_e (C function)
gsl_interp_eval_integ (C function)
gsl_interp_eval_integ_e (C function)
gsl_interp_free (C function)
gsl_interp_init (C function)
gsl_interp_min_size (C function)
gsl_interp_name (C function)
gsl_interp_type (C type)
gsl_interp_type.gsl_interp_akima (C var)
gsl_interp_type.gsl_interp_akima_periodic (C var)
gsl_interp_type.gsl_interp_cspline (C var)
gsl_interp_type.gsl_interp_cspline_periodic (C var)
gsl_interp_type.gsl_interp_linear (C var)
gsl_interp_type.gsl_interp_polynomial (C var)
gsl_interp_type.gsl_interp_steffen (C var)
gsl_interp_type_min_size (C function)
GSL_IS_EVEN (C macro)
GSL_IS_ODD (C macro)
gsl_isinf (C function)
gsl_isnan (C function)
gsl_ldexp (C function)
gsl_linalg_balance_matrix (C function)
gsl_linalg_bidiag_decomp (C function)
gsl_linalg_bidiag_unpack (C function)
gsl_linalg_bidiag_unpack2 (C function)
gsl_linalg_bidiag_unpack_B (C function)
gsl_linalg_cholesky_band_decomp (C function)
gsl_linalg_cholesky_band_invert (C function)
gsl_linalg_cholesky_band_rcond (C function)
gsl_linalg_cholesky_band_scale (C function)
gsl_linalg_cholesky_band_scale_apply (C function)
gsl_linalg_cholesky_band_solve (C function)
gsl_linalg_cholesky_band_solvem (C function)
gsl_linalg_cholesky_band_svx (C function)
gsl_linalg_cholesky_band_svxm (C function)
gsl_linalg_cholesky_band_unpack (C function)
gsl_linalg_cholesky_decomp (C function)
gsl_linalg_cholesky_decomp1 (C function)
gsl_linalg_cholesky_decomp2 (C function)
gsl_linalg_cholesky_invert (C function)
gsl_linalg_cholesky_rcond (C function)
gsl_linalg_cholesky_scale (C function)
gsl_linalg_cholesky_scale_apply (C function)
gsl_linalg_cholesky_solve (C function)
gsl_linalg_cholesky_solve2 (C function)
gsl_linalg_cholesky_svx (C function)
gsl_linalg_cholesky_svx2 (C function)
gsl_linalg_COD_decomp (C function)
gsl_linalg_COD_decomp_e (C function)
gsl_linalg_COD_lssolve (C function)
gsl_linalg_COD_lssolve2 (C function)
gsl_linalg_COD_matZ (C function)
gsl_linalg_COD_unpack (C function)
gsl_linalg_complex_cholesky_decomp (C function)
gsl_linalg_complex_cholesky_decomp2 (C function)
gsl_linalg_complex_cholesky_invert (C function)
gsl_linalg_complex_cholesky_scale (C function)
gsl_linalg_complex_cholesky_scale_apply (C function)
gsl_linalg_complex_cholesky_solve (C function)
gsl_linalg_complex_cholesky_solve2 (C function)
gsl_linalg_complex_cholesky_svx (C function)
gsl_linalg_complex_cholesky_svx2 (C function)
gsl_linalg_complex_householder_hm (C function)
gsl_linalg_complex_householder_hv (C function)
gsl_linalg_complex_householder_mh (C function)
gsl_linalg_complex_householder_transform (C function)
gsl_linalg_complex_LU_decomp (C function)
gsl_linalg_complex_LU_det (C function)
gsl_linalg_complex_LU_invert (C function)
gsl_linalg_complex_LU_invx (C function)
gsl_linalg_complex_LU_lndet (C function)
gsl_linalg_complex_LU_refine (C function)
gsl_linalg_complex_LU_sgndet (C function)
gsl_linalg_complex_LU_solve (C function)
gsl_linalg_complex_LU_svx (C function)
gsl_linalg_complex_QR_decomp (C function)
gsl_linalg_complex_QR_decomp_r (C function)
gsl_linalg_complex_QR_lssolve (C function)
gsl_linalg_complex_QR_lssolve_r (C function)
gsl_linalg_complex_QR_lssolvem_r (C function)
gsl_linalg_complex_QR_QHmat_r (C function)
gsl_linalg_complex_QR_QHvec (C function)
gsl_linalg_complex_QR_QHvec_r (C function)
gsl_linalg_complex_QR_Qvec (C function)
gsl_linalg_complex_QR_solve (C function)
gsl_linalg_complex_QR_solve_r (C function)
gsl_linalg_complex_QR_svx (C function)
gsl_linalg_complex_QR_unpack_r (C function)
gsl_linalg_complex_tri_invert (C function)
gsl_linalg_complex_tri_LHL (C function)
gsl_linalg_complex_tri_UL (C function)
gsl_linalg_givens (C function)
gsl_linalg_givens_gv (C function)
gsl_linalg_hermtd_decomp (C function)
gsl_linalg_hermtd_unpack (C function)
gsl_linalg_hermtd_unpack_T (C function)
gsl_linalg_hessenberg_decomp (C function)
gsl_linalg_hessenberg_set_zero (C function)
gsl_linalg_hessenberg_unpack (C function)
gsl_linalg_hessenberg_unpack_accum (C function)
gsl_linalg_hesstri_decomp (C function)
gsl_linalg_HH_solve (C function)
gsl_linalg_HH_svx (C function)
gsl_linalg_householder_hm (C function)
gsl_linalg_householder_hv (C function)
gsl_linalg_householder_mh (C function)
gsl_linalg_householder_transform (C function)
gsl_linalg_ldlt_band_decomp (C function)
gsl_linalg_ldlt_band_rcond (C function)
gsl_linalg_ldlt_band_solve (C function)
gsl_linalg_ldlt_band_svx (C function)
gsl_linalg_ldlt_band_unpack (C function)
gsl_linalg_ldlt_decomp (C function)
gsl_linalg_ldlt_rcond (C function)
gsl_linalg_ldlt_solve (C function)
gsl_linalg_ldlt_svx (C function)
gsl_linalg_LQ_decomp (C function)
gsl_linalg_LQ_lssolve (C function)
gsl_linalg_LQ_QTvec (C function)
gsl_linalg_LQ_unpack (C function)
gsl_linalg_LU_band_decomp (C function)
gsl_linalg_LU_band_solve (C function)
gsl_linalg_LU_band_svx (C function)
gsl_linalg_LU_band_unpack (C function)
gsl_linalg_LU_decomp (C function)
gsl_linalg_LU_det (C function)
gsl_linalg_LU_invert (C function)
gsl_linalg_LU_invx (C function)
gsl_linalg_LU_lndet (C function)
gsl_linalg_LU_refine (C function)
gsl_linalg_LU_sgndet (C function)
gsl_linalg_LU_solve (C function)
gsl_linalg_LU_svx (C function)
gsl_linalg_mcholesky_decomp (C function)
gsl_linalg_mcholesky_rcond (C function)
gsl_linalg_mcholesky_solve (C function)
gsl_linalg_mcholesky_svx (C function)
gsl_linalg_pcholesky_decomp (C function)
gsl_linalg_pcholesky_decomp2 (C function)
gsl_linalg_pcholesky_invert (C function)
gsl_linalg_pcholesky_rcond (C function)
gsl_linalg_pcholesky_solve (C function)
gsl_linalg_pcholesky_solve2 (C function)
gsl_linalg_pcholesky_svx (C function)
gsl_linalg_pcholesky_svx2 (C function)
gsl_linalg_QL_decomp (C function)
gsl_linalg_QL_unpack (C function)
gsl_linalg_QR_decomp (C function)
gsl_linalg_QR_decomp_r (C function)
gsl_linalg_QR_lssolve (C function)
gsl_linalg_QR_lssolve_r (C function)
gsl_linalg_QR_lssolvem_r (C function)
gsl_linalg_QR_QRsolve (C function)
gsl_linalg_QR_QTmat (C function)
gsl_linalg_QR_QTmat_r (C function)
gsl_linalg_QR_QTvec (C function)
gsl_linalg_QR_QTvec_r (C function)
gsl_linalg_QR_Qvec (C function)
gsl_linalg_QR_rcond (C function)
gsl_linalg_QR_Rsolve (C function)
gsl_linalg_QR_Rsvx (C function)
gsl_linalg_QR_solve (C function)
gsl_linalg_QR_solve_r (C function)
gsl_linalg_QR_svx (C function)
gsl_linalg_QR_UD_decomp (C function)
gsl_linalg_QR_UD_lssolve (C function)
gsl_linalg_QR_UD_lssvx (C function)
gsl_linalg_QR_UD_QTvec (C function)
gsl_linalg_QR_unpack (C function)
gsl_linalg_QR_unpack_r (C function)
gsl_linalg_QR_update (C function)
gsl_linalg_QR_UR_decomp (C function)
gsl_linalg_QR_UR_lssolve (C function)
gsl_linalg_QR_UR_lssvx (C function)
gsl_linalg_QR_UR_QTvec (C function)
gsl_linalg_QR_UU_decomp (C function)
gsl_linalg_QR_UU_lssolve (C function)
gsl_linalg_QR_UU_lssvx (C function)
gsl_linalg_QR_UU_QTvec (C function)
gsl_linalg_QR_UZ_decomp (C function)
gsl_linalg_QRPT_decomp (C function)
gsl_linalg_QRPT_decomp2 (C function)
gsl_linalg_QRPT_lssolve (C function)
gsl_linalg_QRPT_lssolve2 (C function)
gsl_linalg_QRPT_QRsolve (C function)
gsl_linalg_QRPT_rank (C function)
gsl_linalg_QRPT_rcond (C function)
gsl_linalg_QRPT_Rsolve (C function)
gsl_linalg_QRPT_Rsvx (C function)
gsl_linalg_QRPT_solve (C function)
gsl_linalg_QRPT_svx (C function)
gsl_linalg_QRPT_update (C function)
gsl_linalg_R_solve (C function)
gsl_linalg_R_svx (C function)
gsl_linalg_solve_cyc_tridiag (C function)
gsl_linalg_solve_symm_cyc_tridiag (C function)
gsl_linalg_solve_symm_tridiag (C function)
gsl_linalg_solve_tridiag (C function)
gsl_linalg_SV_decomp (C function)
gsl_linalg_SV_decomp_jacobi (C function)
gsl_linalg_SV_decomp_mod (C function)
gsl_linalg_SV_leverage (C function)
gsl_linalg_SV_lssolve (C function)
gsl_linalg_SV_solve (C function)
gsl_linalg_SV_solve2 (C function)
gsl_linalg_symmtd_decomp (C function)
gsl_linalg_symmtd_unpack (C function)
gsl_linalg_symmtd_unpack_T (C function)
gsl_linalg_tri_invert (C function)
gsl_linalg_tri_LTL (C function)
gsl_linalg_tri_rcond (C function)
gsl_linalg_tri_UL (C function)
gsl_log1p (C function)
gsl_matrix (C type)
gsl_matrix_add (C function)
gsl_matrix_add_constant (C function)
gsl_matrix_alloc (C function)
gsl_matrix_calloc (C function)
gsl_matrix_column (C function)
gsl_matrix_complex_conjtrans_memcpy (C function)
gsl_matrix_complex_conjugate (C function)
gsl_matrix_const_column (C function)
gsl_matrix_const_diagonal (C function)
gsl_matrix_const_ptr (C function)
gsl_matrix_const_row (C function)
gsl_matrix_const_subcolumn (C function)
gsl_matrix_const_subdiagonal (C function)
gsl_matrix_const_submatrix (C function)
gsl_matrix_const_subrow (C function)
gsl_matrix_const_superdiagonal (C function)
gsl_matrix_const_view (C type)
gsl_matrix_const_view_array (C function)
gsl_matrix_const_view_array_with_tda (C function)
gsl_matrix_const_view_vector (C function)
gsl_matrix_const_view_vector_with_tda (C function)
gsl_matrix_diagonal (C function)
gsl_matrix_div_elements (C function)
gsl_matrix_equal (C function)
gsl_matrix_fprintf (C function)
gsl_matrix_fread (C function)
gsl_matrix_free (C function)
gsl_matrix_fscanf (C function)
gsl_matrix_fwrite (C function)
gsl_matrix_get (C function)
gsl_matrix_get_col (C function)
gsl_matrix_get_row (C function)
gsl_matrix_isneg (C function)
gsl_matrix_isnonneg (C function)
gsl_matrix_isnull (C function)
gsl_matrix_ispos (C function)
gsl_matrix_max (C function)
gsl_matrix_max_index (C function)
gsl_matrix_memcpy (C function)
gsl_matrix_min (C function)
gsl_matrix_min_index (C function)
gsl_matrix_minmax (C function)
gsl_matrix_minmax_index (C function)
gsl_matrix_mul_elements (C function)
gsl_matrix_norm1 (C function)
gsl_matrix_ptr (C function)
gsl_matrix_row (C function)
gsl_matrix_scale (C function)
gsl_matrix_scale_columns (C function)
gsl_matrix_scale_rows (C function)
gsl_matrix_set (C function)
gsl_matrix_set_all (C function)
gsl_matrix_set_col (C function)
gsl_matrix_set_identity (C function)
gsl_matrix_set_row (C function)
gsl_matrix_set_zero (C function)
gsl_matrix_sub (C function)
gsl_matrix_subcolumn (C function)
gsl_matrix_subdiagonal (C function)
gsl_matrix_submatrix (C function)
gsl_matrix_subrow (C function)
gsl_matrix_superdiagonal (C function)
gsl_matrix_swap (C function)
gsl_matrix_swap_columns (C function)
gsl_matrix_swap_rowcol (C function)
gsl_matrix_swap_rows (C function)
gsl_matrix_transpose (C function)
gsl_matrix_transpose_memcpy (C function)
gsl_matrix_view (C type)
gsl_matrix_view_array (C function)
gsl_matrix_view_array_with_tda (C function)
gsl_matrix_view_vector (C function)
gsl_matrix_view_vector_with_tda (C function)
GSL_MAX (C macro)
GSL_MAX_DBL (C function)
GSL_MAX_INT (C function)
GSL_MAX_LDBL (C function)
GSL_MIN (C macro)
GSL_MIN_DBL (C function)
gsl_min_fminimizer (C type)
gsl_min_fminimizer_alloc (C function)
gsl_min_fminimizer_f_lower (C function)
gsl_min_fminimizer_f_minimum (C function)
gsl_min_fminimizer_f_upper (C function)
gsl_min_fminimizer_free (C function)
gsl_min_fminimizer_iterate (C function)
gsl_min_fminimizer_name (C function)
gsl_min_fminimizer_set (C function)
gsl_min_fminimizer_set_with_values (C function)
gsl_min_fminimizer_type (C type)
gsl_min_fminimizer_type.gsl_min_fminimizer_brent (C var)
gsl_min_fminimizer_type.gsl_min_fminimizer_goldensection (C var)
gsl_min_fminimizer_type.gsl_min_fminimizer_quad_golden (C var)
gsl_min_fminimizer_x_lower (C function)
gsl_min_fminimizer_x_minimum (C function)
gsl_min_fminimizer_x_upper (C function)
GSL_MIN_INT (C function)
GSL_MIN_LDBL (C function)
gsl_min_test_interval (C function)
gsl_mode_t (C type)
gsl_mode_t.GSL_PREC_APPROX (C macro)
gsl_mode_t.GSL_PREC_DOUBLE (C macro)
gsl_mode_t.GSL_PREC_SINGLE (C macro)
gsl_monte_function (C type)
gsl_monte_miser_alloc (C function)
gsl_monte_miser_free (C function)
gsl_monte_miser_init (C function)
gsl_monte_miser_integrate (C function)
gsl_monte_miser_params (C type)
gsl_monte_miser_params.alpha (C var)
gsl_monte_miser_params.dither (C var)
gsl_monte_miser_params.estimate_frac (C var)
gsl_monte_miser_params.min_calls (C var)
gsl_monte_miser_params.min_calls_per_bisection (C var)
gsl_monte_miser_params_get (C function)
gsl_monte_miser_params_set (C function)
gsl_monte_miser_state (C type)
gsl_monte_plain_alloc (C function)
gsl_monte_plain_free (C function)
gsl_monte_plain_init (C function)
gsl_monte_plain_integrate (C function)
gsl_monte_plain_state (C type)
gsl_monte_vegas_alloc (C function)
gsl_monte_vegas_chisq (C function)
gsl_monte_vegas_free (C function)
gsl_monte_vegas_init (C function)
gsl_monte_vegas_integrate (C function)
gsl_monte_vegas_params (C type)
gsl_monte_vegas_params.alpha (C var)
gsl_monte_vegas_params.iterations (C var)
gsl_monte_vegas_params.mode (C var)
gsl_monte_vegas_params.ostream (C var)
gsl_monte_vegas_params.stage (C var)
gsl_monte_vegas_params.verbose (C var)
gsl_monte_vegas_params_get (C function)
gsl_monte_vegas_params_set (C function)
gsl_monte_vegas_runval (C function)
gsl_monte_vegas_state (C type)
gsl_movstat_accum (C type)
gsl_movstat_accum.delete (C member)
gsl_movstat_accum.get (C member)
gsl_movstat_accum.init (C member)
gsl_movstat_accum.insert (C member)
gsl_movstat_accum.size (C member)
gsl_movstat_accum_max (C var)
gsl_movstat_accum_mean (C var)
gsl_movstat_accum_median (C var)
gsl_movstat_accum_min (C var)
gsl_movstat_accum_minmax (C var)
gsl_movstat_accum_Qn (C var)
gsl_movstat_accum_qqr (C var)
gsl_movstat_accum_sd (C var)
gsl_movstat_accum_Sn (C var)
gsl_movstat_accum_sum (C var)
gsl_movstat_accum_variance (C var)
gsl_movstat_alloc (C function)
gsl_movstat_alloc2 (C function)
gsl_movstat_apply (C function)
gsl_movstat_end_t (C type)
gsl_movstat_end_t.GSL_MOVSTAT_END_PADVALUE (C macro)
gsl_movstat_end_t.GSL_MOVSTAT_END_PADZERO (C macro)
gsl_movstat_end_t.GSL_MOVSTAT_END_TRUNCATE (C macro)
gsl_movstat_fill (C function)
gsl_movstat_free (C function)
gsl_movstat_function (C type)
gsl_movstat_function.function (C member)
gsl_movstat_function.params (C member)
gsl_movstat_mad (C function)
gsl_movstat_mad0 (C function)
gsl_movstat_max (C function)
gsl_movstat_mean (C function)
gsl_movstat_median (C function)
gsl_movstat_min (C function)
gsl_movstat_minmax (C function)
gsl_movstat_Qn (C function)
gsl_movstat_qqr (C function)
gsl_movstat_sd (C function)
gsl_movstat_Sn (C function)
gsl_movstat_sum (C function)
gsl_movstat_variance (C function)
gsl_movstat_workspace (C type)
gsl_multifit_linear (C function)
gsl_multifit_linear_alloc (C function)
gsl_multifit_linear_applyW (C function)
gsl_multifit_linear_bsvd (C function)
gsl_multifit_linear_est (C function)
gsl_multifit_linear_free (C function)
gsl_multifit_linear_gcv (C function)
gsl_multifit_linear_gcv_calc (C function)
gsl_multifit_linear_gcv_curve (C function)
gsl_multifit_linear_gcv_init (C function)
gsl_multifit_linear_gcv_min (C function)
gsl_multifit_linear_genform1 (C function)
gsl_multifit_linear_genform2 (C function)
gsl_multifit_linear_L_decomp (C function)
gsl_multifit_linear_lcorner (C function)
gsl_multifit_linear_lcorner2 (C function)
gsl_multifit_linear_lcurvature (C function)
gsl_multifit_linear_lcurvature_menger (C function)
gsl_multifit_linear_lcurve (C function)
gsl_multifit_linear_Lk (C function)
gsl_multifit_linear_lreg (C function)
gsl_multifit_linear_Lsobolev (C function)
gsl_multifit_linear_rank (C function)
gsl_multifit_linear_rcond (C function)
gsl_multifit_linear_residuals (C function)
gsl_multifit_linear_solve (C function)
gsl_multifit_linear_stdform1 (C function)
gsl_multifit_linear_stdform2 (C function)
gsl_multifit_linear_svd (C function)
gsl_multifit_linear_tsvd (C function)
gsl_multifit_linear_wgenform2 (C function)
gsl_multifit_linear_workspace (C type)
gsl_multifit_linear_wstdform1 (C function)
gsl_multifit_linear_wstdform2 (C function)
gsl_multifit_nlinear_alloc (C function)
gsl_multifit_nlinear_avratio (C function)
gsl_multifit_nlinear_covar (C function)
gsl_multifit_nlinear_default_parameters (C function)
gsl_multifit_nlinear_driver (C function)
gsl_multifit_nlinear_fdf (C type)
gsl_multifit_nlinear_fdtype (C type)
gsl_multifit_nlinear_fdtype.GSL_MULTIFIT_NLINEAR_CTRDIFF (C macro)
gsl_multifit_nlinear_fdtype.GSL_MULTIFIT_NLINEAR_FWDIFF (C macro)
gsl_multifit_nlinear_free (C function)
gsl_multifit_nlinear_init (C function)
gsl_multifit_nlinear_iterate (C function)
gsl_multifit_nlinear_jac (C function)
gsl_multifit_nlinear_name (C function)
gsl_multifit_nlinear_niter (C function)
gsl_multifit_nlinear_parameters (C type)
gsl_multifit_nlinear_position (C function)
gsl_multifit_nlinear_rcond (C function)
gsl_multifit_nlinear_residual (C function)
gsl_multifit_nlinear_scale (C type)
gsl_multifit_nlinear_solver (C type)
gsl_multifit_nlinear_test (C function)
gsl_multifit_nlinear_trs (C type)
gsl_multifit_nlinear_trs_name (C function)
gsl_multifit_nlinear_type (C type)
gsl_multifit_nlinear_type.gsl_multifit_nlinear_trust (C var)
gsl_multifit_nlinear_winit (C function)
gsl_multifit_robust (C function)
gsl_multifit_robust_alloc (C function)
gsl_multifit_robust_alloc.gsl_multifit_robust_type (C type)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_bisquare (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_cauchy (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_default (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_fair (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_huber (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_ols (C var)
gsl_multifit_robust_alloc.gsl_multifit_robust_type.gsl_multifit_robust_welsch (C var)
gsl_multifit_robust_est (C function)
gsl_multifit_robust_free (C function)
gsl_multifit_robust_maxiter (C function)
gsl_multifit_robust_name (C function)
gsl_multifit_robust_residuals (C function)
gsl_multifit_robust_statistics (C function)
gsl_multifit_robust_statistics.gsl_multifit_robust_stats (C type)
gsl_multifit_robust_tune (C function)
gsl_multifit_robust_weights (C function)
gsl_multifit_robust_workspace (C type)
gsl_multifit_wlinear (C function)
gsl_multifit_wlinear_tsvd (C function)
gsl_multilarge_linear_accumulate (C function)
gsl_multilarge_linear_alloc (C function)
gsl_multilarge_linear_alloc.gsl_multilarge_linear_type (C type)
gsl_multilarge_linear_alloc.gsl_multilarge_linear_type.gsl_multilarge_linear_normal (C var)
gsl_multilarge_linear_alloc.gsl_multilarge_linear_type.gsl_multilarge_linear_tsqr (C var)
gsl_multilarge_linear_free (C function)
gsl_multilarge_linear_genform1 (C function)
gsl_multilarge_linear_genform2 (C function)
gsl_multilarge_linear_L_decomp (C function)
gsl_multilarge_linear_lcurve (C function)
gsl_multilarge_linear_matrix_ptr (C function)
gsl_multilarge_linear_name (C function)
gsl_multilarge_linear_rcond (C function)
gsl_multilarge_linear_reset (C function)
gsl_multilarge_linear_rhs_ptr (C function)
gsl_multilarge_linear_solve (C function)
gsl_multilarge_linear_stdform1 (C function)
gsl_multilarge_linear_stdform2 (C function)
gsl_multilarge_linear_workspace (C type)
gsl_multilarge_linear_wstdform1 (C function)
gsl_multilarge_linear_wstdform2 (C function)
gsl_multilarge_nlinear_alloc (C function)
gsl_multilarge_nlinear_avratio (C function)
gsl_multilarge_nlinear_covar (C function)
gsl_multilarge_nlinear_default_parameters (C function)
gsl_multilarge_nlinear_driver (C function)
gsl_multilarge_nlinear_fdf (C type)
gsl_multilarge_nlinear_free (C function)
gsl_multilarge_nlinear_init (C function)
gsl_multilarge_nlinear_iterate (C function)
gsl_multilarge_nlinear_name (C function)
gsl_multilarge_nlinear_niter (C function)
gsl_multilarge_nlinear_parameters (C type)
gsl_multilarge_nlinear_position (C function)
gsl_multilarge_nlinear_rcond (C function)
gsl_multilarge_nlinear_residual (C function)
gsl_multilarge_nlinear_scale (C type)
gsl_multilarge_nlinear_scale.gsl_multifit_nlinear_scale_levenberg (C var)
gsl_multilarge_nlinear_scale.gsl_multifit_nlinear_scale_marquardt (C var)
gsl_multilarge_nlinear_scale.gsl_multifit_nlinear_scale_more (C var)
gsl_multilarge_nlinear_scale.gsl_multilarge_nlinear_scale_levenberg (C var)
gsl_multilarge_nlinear_scale.gsl_multilarge_nlinear_scale_marquardt (C var)
gsl_multilarge_nlinear_scale.gsl_multilarge_nlinear_scale_more (C var)
gsl_multilarge_nlinear_solver (C type)
gsl_multilarge_nlinear_solver.gsl_multifit_nlinear_solver_cholesky (C var)
gsl_multilarge_nlinear_solver.gsl_multifit_nlinear_solver_mcholesky (C var)
gsl_multilarge_nlinear_solver.gsl_multifit_nlinear_solver_qr (C var)
gsl_multilarge_nlinear_solver.gsl_multifit_nlinear_solver_svd (C var)
gsl_multilarge_nlinear_solver.gsl_multilarge_nlinear_solver_cholesky (C var)
gsl_multilarge_nlinear_solver.gsl_multilarge_nlinear_solver_mcholesky (C var)
gsl_multilarge_nlinear_test (C function)
gsl_multilarge_nlinear_trs (C type)
gsl_multilarge_nlinear_trs.gsl_multifit_nlinear_trs_ddogleg (C var)
gsl_multilarge_nlinear_trs.gsl_multifit_nlinear_trs_dogleg (C var)
gsl_multilarge_nlinear_trs.gsl_multifit_nlinear_trs_lm (C var)
gsl_multilarge_nlinear_trs.gsl_multifit_nlinear_trs_lmaccel (C var)
gsl_multilarge_nlinear_trs.gsl_multifit_nlinear_trs_subspace2D (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_cgst (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_ddogleg (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_dogleg (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_lm (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_lmaccel (C var)
gsl_multilarge_nlinear_trs.gsl_multilarge_nlinear_trs_subspace2D (C var)
gsl_multilarge_nlinear_trs_name (C function)
gsl_multimin_fdfminimizer (C type)
gsl_multimin_fdfminimizer_alloc (C function)
gsl_multimin_fdfminimizer_dx (C function)
gsl_multimin_fdfminimizer_free (C function)
gsl_multimin_fdfminimizer_gradient (C function)
gsl_multimin_fdfminimizer_iterate (C function)
gsl_multimin_fdfminimizer_minimum (C function)
gsl_multimin_fdfminimizer_name (C function)
gsl_multimin_fdfminimizer_restart (C function)
gsl_multimin_fdfminimizer_set (C function)
gsl_multimin_fdfminimizer_type (C type)
gsl_multimin_fdfminimizer_type.gsl_multimin_fdfminimizer_conjugate_fr (C var)
gsl_multimin_fdfminimizer_type.gsl_multimin_fdfminimizer_conjugate_pr (C var)
gsl_multimin_fdfminimizer_type.gsl_multimin_fdfminimizer_steepest_descent (C var)
gsl_multimin_fdfminimizer_type.gsl_multimin_fdfminimizer_vector_bfgs (C var)
gsl_multimin_fdfminimizer_type.gsl_multimin_fdfminimizer_vector_bfgs2 (C var)
gsl_multimin_fdfminimizer_x (C function)
gsl_multimin_fminimizer (C type)
gsl_multimin_fminimizer_alloc (C function)
gsl_multimin_fminimizer_free (C function)
gsl_multimin_fminimizer_iterate (C function)
gsl_multimin_fminimizer_minimum (C function)
gsl_multimin_fminimizer_name (C function)
gsl_multimin_fminimizer_set (C function)
gsl_multimin_fminimizer_size (C function)
gsl_multimin_fminimizer_type (C type)
gsl_multimin_fminimizer_type.gsl_multimin_fminimizer_nmsimplex (C var)
gsl_multimin_fminimizer_type.gsl_multimin_fminimizer_nmsimplex2 (C var)
gsl_multimin_fminimizer_type.gsl_multimin_fminimizer_nmsimplex2rand (C var)
gsl_multimin_fminimizer_x (C function)
gsl_multimin_function (C type)
gsl_multimin_function_fdf (C type)
gsl_multimin_test_gradient (C function)
gsl_multimin_test_size (C function)
gsl_multiroot_fdfsolver (C type)
gsl_multiroot_fdfsolver_alloc (C function)
gsl_multiroot_fdfsolver_dx (C function)
gsl_multiroot_fdfsolver_f (C function)
gsl_multiroot_fdfsolver_free (C function)
gsl_multiroot_fdfsolver_iterate (C function)
gsl_multiroot_fdfsolver_name (C function)
gsl_multiroot_fdfsolver_root (C function)
gsl_multiroot_fdfsolver_set (C function)
gsl_multiroot_fdfsolver_type (C type)
gsl_multiroot_fdfsolver_type.gsl_multiroot_fdfsolver_gnewton (C var)
gsl_multiroot_fdfsolver_type.gsl_multiroot_fdfsolver_hybridj (C var)
gsl_multiroot_fdfsolver_type.gsl_multiroot_fdfsolver_hybridsj (C var)
gsl_multiroot_fdfsolver_type.gsl_multiroot_fdfsolver_newton (C var)
gsl_multiroot_fsolver (C type)
gsl_multiroot_fsolver_alloc (C function)
gsl_multiroot_fsolver_dx (C function)
gsl_multiroot_fsolver_f (C function)
gsl_multiroot_fsolver_free (C function)
gsl_multiroot_fsolver_iterate (C function)
gsl_multiroot_fsolver_name (C function)
gsl_multiroot_fsolver_root (C function)
gsl_multiroot_fsolver_set (C function)
gsl_multiroot_fsolver_type (C type)
gsl_multiroot_fsolver_type.gsl_multiroot_fsolver_broyden (C var)
gsl_multiroot_fsolver_type.gsl_multiroot_fsolver_dnewton (C var)
gsl_multiroot_fsolver_type.gsl_multiroot_fsolver_hybrid (C var)
gsl_multiroot_fsolver_type.gsl_multiroot_fsolver_hybrids (C var)
gsl_multiroot_function (C type)
gsl_multiroot_function_fdf (C type)
gsl_multiroot_test_delta (C function)
gsl_multiroot_test_residual (C function)
gsl_multiset (C type)
gsl_multiset_alloc (C function)
gsl_multiset_calloc (C function)
gsl_multiset_data (C function)
gsl_multiset_fprintf (C function)
gsl_multiset_fread (C function)
gsl_multiset_free (C function)
gsl_multiset_fscanf (C function)
gsl_multiset_fwrite (C function)
gsl_multiset_get (C function)
gsl_multiset_init_first (C function)
gsl_multiset_init_last (C function)
gsl_multiset_k (C function)
gsl_multiset_memcpy (C function)
gsl_multiset_n (C function)
gsl_multiset_next (C function)
gsl_multiset_prev (C function)
gsl_multiset_valid (C function)
GSL_NAN (C macro)
GSL_NEGINF (C macro)
gsl_ntuple (C type)
gsl_ntuple_bookdata (C function)
gsl_ntuple_close (C function)
gsl_ntuple_create (C function)
gsl_ntuple_open (C function)
gsl_ntuple_project (C function)
gsl_ntuple_read (C function)
gsl_ntuple_select_fn (C type)
gsl_ntuple_value_fn (C type)
gsl_ntuple_write (C function)
gsl_odeiv2_control (C type)
gsl_odeiv2_control_alloc (C function)
gsl_odeiv2_control_errlevel (C function)
gsl_odeiv2_control_free (C function)
gsl_odeiv2_control_hadjust (C function)
gsl_odeiv2_control_init (C function)
gsl_odeiv2_control_name (C function)
gsl_odeiv2_control_scaled_new (C function)
gsl_odeiv2_control_set_driver (C function)
gsl_odeiv2_control_standard_new (C function)
gsl_odeiv2_control_type (C type)
gsl_odeiv2_control_y_new (C function)
gsl_odeiv2_control_yp_new (C function)
gsl_odeiv2_driver_alloc_scaled_new (C function)
gsl_odeiv2_driver_alloc_standard_new (C function)
gsl_odeiv2_driver_alloc_y_new (C function)
gsl_odeiv2_driver_alloc_yp_new (C function)
gsl_odeiv2_driver_apply (C function)
gsl_odeiv2_driver_apply_fixed_step (C function)
gsl_odeiv2_driver_free (C function)
gsl_odeiv2_driver_reset (C function)
gsl_odeiv2_driver_reset_hstart (C function)
gsl_odeiv2_driver_set_hmax (C function)
gsl_odeiv2_driver_set_hmin (C function)
gsl_odeiv2_driver_set_nmax (C function)
gsl_odeiv2_evolve (C type)
gsl_odeiv2_evolve_alloc (C function)
gsl_odeiv2_evolve_apply (C function)
gsl_odeiv2_evolve_apply_fixed_step (C function)
gsl_odeiv2_evolve_free (C function)
gsl_odeiv2_evolve_reset (C function)
gsl_odeiv2_evolve_set_driver (C function)
gsl_odeiv2_step (C type)
gsl_odeiv2_step_alloc (C function)
gsl_odeiv2_step_apply (C function)
gsl_odeiv2_step_free (C function)
gsl_odeiv2_step_name (C function)
gsl_odeiv2_step_order (C function)
gsl_odeiv2_step_reset (C function)
gsl_odeiv2_step_set_driver (C function)
gsl_odeiv2_step_type (C type)
gsl_odeiv2_step_type.gsl_odeiv2_step_bsimp (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_msadams (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_msbdf (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk1imp (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk2 (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk2imp (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk4 (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk4imp (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rk8pd (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rkck (C var)
gsl_odeiv2_step_type.gsl_odeiv2_step_rkf45 (C var)
gsl_odeiv2_system (C type)
gsl_permutation (C type)
gsl_permutation_alloc (C function)
gsl_permutation_calloc (C function)
gsl_permutation_canonical_cycles (C function)
gsl_permutation_canonical_to_linear (C function)
gsl_permutation_data (C function)
gsl_permutation_fprintf (C function)
gsl_permutation_fread (C function)
gsl_permutation_free (C function)
gsl_permutation_fscanf (C function)
gsl_permutation_fwrite (C function)
gsl_permutation_get (C function)
gsl_permutation_init (C function)
gsl_permutation_inverse (C function)
gsl_permutation_inversions (C function)
gsl_permutation_linear_cycles (C function)
gsl_permutation_linear_to_canonical (C function)
gsl_permutation_memcpy (C function)
gsl_permutation_mul (C function)
gsl_permutation_next (C function)
gsl_permutation_prev (C function)
gsl_permutation_reverse (C function)
gsl_permutation_size (C function)
gsl_permutation_swap (C function)
gsl_permutation_valid (C function)
gsl_permute (C function)
gsl_permute_inverse (C function)
gsl_permute_matrix (C function)
gsl_permute_vector (C function)
gsl_permute_vector_inverse (C function)
gsl_poly_complex_eval (C function)
gsl_poly_complex_solve (C function)
gsl_poly_complex_solve_cubic (C function)
gsl_poly_complex_solve_quadratic (C function)
gsl_poly_complex_workspace (C type)
gsl_poly_complex_workspace_alloc (C function)
gsl_poly_complex_workspace_free (C function)
gsl_poly_dd_eval (C function)
gsl_poly_dd_hermite_init (C function)
gsl_poly_dd_init (C function)
gsl_poly_dd_taylor (C function)
gsl_poly_eval (C function)
gsl_poly_eval_derivs (C function)
gsl_poly_solve_cubic (C function)
gsl_poly_solve_quadratic (C function)
GSL_POSINF (C macro)
gsl_pow_2 (C function)
gsl_pow_3 (C function)
gsl_pow_4 (C function)
gsl_pow_5 (C function)
gsl_pow_6 (C function)
gsl_pow_7 (C function)
gsl_pow_8 (C function)
gsl_pow_9 (C function)
gsl_pow_int (C function)
gsl_pow_uint (C function)
gsl_qrng (C type)
gsl_qrng_alloc (C function)
gsl_qrng_clone (C function)
gsl_qrng_free (C function)
gsl_qrng_get (C function)
gsl_qrng_init (C function)
gsl_qrng_memcpy (C function)
gsl_qrng_name (C function)
gsl_qrng_size (C function)
gsl_qrng_state (C function)
gsl_qrng_type (C type)
gsl_qrng_type.gsl_qrng_halton (C var)
gsl_qrng_type.gsl_qrng_niederreiter_2 (C var)
gsl_qrng_type.gsl_qrng_reversehalton (C var)
gsl_qrng_type.gsl_qrng_sobol (C var)
gsl_ran_bernoulli (C function)
gsl_ran_bernoulli_pdf (C function)
gsl_ran_beta (C function)
gsl_ran_beta_pdf (C function)
gsl_ran_binomial (C function)
gsl_ran_binomial_pdf (C function)
gsl_ran_bivariate_gaussian (C function)
gsl_ran_bivariate_gaussian_pdf (C function)
gsl_ran_cauchy (C function)
gsl_ran_cauchy_pdf (C function)
gsl_ran_chisq (C function)
gsl_ran_chisq_pdf (C function)
gsl_ran_choose (C function)
gsl_ran_dir_2d (C function)
gsl_ran_dir_2d_trig_method (C function)
gsl_ran_dir_3d (C function)
gsl_ran_dir_nd (C function)
gsl_ran_dirichlet (C function)
gsl_ran_dirichlet_lnpdf (C function)
gsl_ran_dirichlet_pdf (C function)
gsl_ran_discrete (C function)
gsl_ran_discrete_free (C function)
gsl_ran_discrete_pdf (C function)
gsl_ran_discrete_preproc (C function)
gsl_ran_discrete_t (C type)
gsl_ran_exponential (C function)
gsl_ran_exponential_pdf (C function)
gsl_ran_exppow (C function)
gsl_ran_exppow_pdf (C function)
gsl_ran_fdist (C function)
gsl_ran_fdist_pdf (C function)
gsl_ran_flat (C function)
gsl_ran_flat_pdf (C function)
gsl_ran_gamma (C function)
gsl_ran_gamma_knuth (C function)
gsl_ran_gamma_pdf (C function)
gsl_ran_gaussian (C function)
gsl_ran_gaussian_pdf (C function)
gsl_ran_gaussian_ratio_method (C function)
gsl_ran_gaussian_tail (C function)
gsl_ran_gaussian_tail_pdf (C function)
gsl_ran_gaussian_ziggurat (C function)
gsl_ran_geometric (C function)
gsl_ran_geometric_pdf (C function)
gsl_ran_gumbel1 (C function)
gsl_ran_gumbel1_pdf (C function)
gsl_ran_gumbel2 (C function)
gsl_ran_gumbel2_pdf (C function)
gsl_ran_hypergeometric (C function)
gsl_ran_hypergeometric_pdf (C function)
gsl_ran_landau (C function)
gsl_ran_landau_pdf (C function)
gsl_ran_laplace (C function)
gsl_ran_laplace_pdf (C function)
gsl_ran_levy (C function)
gsl_ran_levy_skew (C function)
gsl_ran_logarithmic (C function)
gsl_ran_logarithmic_pdf (C function)
gsl_ran_logistic (C function)
gsl_ran_logistic_pdf (C function)
gsl_ran_lognormal (C function)
gsl_ran_lognormal_pdf (C function)
gsl_ran_multinomial (C function)
gsl_ran_multinomial_lnpdf (C function)
gsl_ran_multinomial_pdf (C function)
gsl_ran_multivariate_gaussian (C function)
gsl_ran_multivariate_gaussian_log_pdf (C function)
gsl_ran_multivariate_gaussian_mean (C function)
gsl_ran_multivariate_gaussian_pdf (C function)
gsl_ran_multivariate_gaussian_vcov (C function)
gsl_ran_negative_binomial (C function)
gsl_ran_negative_binomial_pdf (C function)
gsl_ran_pareto (C function)
gsl_ran_pareto_pdf (C function)
gsl_ran_pascal (C function)
gsl_ran_pascal_pdf (C function)
gsl_ran_poisson (C function)
gsl_ran_poisson_pdf (C function)
gsl_ran_rayleigh (C function)
gsl_ran_rayleigh_pdf (C function)
gsl_ran_rayleigh_tail (C function)
gsl_ran_rayleigh_tail_pdf (C function)
gsl_ran_sample (C function)
gsl_ran_shuffle (C function)
gsl_ran_tdist (C function)
gsl_ran_tdist_pdf (C function)
gsl_ran_ugaussian (C function)
gsl_ran_ugaussian_pdf (C function)
gsl_ran_ugaussian_ratio_method (C function)
gsl_ran_ugaussian_tail (C function)
gsl_ran_ugaussian_tail_pdf (C function)
gsl_ran_weibull (C function)
gsl_ran_weibull_pdf (C function)
gsl_ran_wishart (C function)
gsl_ran_wishart_log_pdf (C function)
gsl_ran_wishart_pdf (C function)
GSL_RANGE_CHECK_OFF (C macro)
GSL_REAL (C macro)
gsl_rng (C type)
gsl_rng_alloc (C function)
gsl_rng_borosh13 (C var)
gsl_rng_clone (C function)
gsl_rng_cmrg (C var)
gsl_rng_coveyou (C var)
gsl_rng_default (C var)
gsl_rng_default_seed (C var)
gsl_rng_env_setup (C function)
gsl_rng_fishman18 (C var)
gsl_rng_fishman20 (C var)
gsl_rng_fishman2x (C var)
gsl_rng_fread (C function)
gsl_rng_free (C function)
gsl_rng_fwrite (C function)
gsl_rng_get (C function)
gsl_rng_gfsr4 (C var)
gsl_rng_knuthran (C var)
gsl_rng_knuthran2 (C var)
gsl_rng_knuthran2002 (C var)
gsl_rng_lecuyer21 (C var)
gsl_rng_max (C function)
gsl_rng_memcpy (C function)
gsl_rng_min (C function)
gsl_rng_minstd (C var)
gsl_rng_mrg (C var)
gsl_rng_mt19937 (C var)
gsl_rng_name (C function)
gsl_rng_r250 (C var)
gsl_rng_rand (C var)
gsl_rng_rand48 (C var)
gsl_rng_random_bsd (C var)
gsl_rng_random_glibc2 (C var)
gsl_rng_random_libc5 (C var)
gsl_rng_randu (C var)
gsl_rng_ranf (C var)
gsl_rng_ranlux (C var)
gsl_rng_ranlux389 (C var)
gsl_rng_ranlxd1 (C var)
gsl_rng_ranlxd2 (C var)
gsl_rng_ranlxs0 (C var)
gsl_rng_ranlxs1 (C var)
gsl_rng_ranlxs2 (C var)
gsl_rng_ranmar (C var)
GSL_RNG_SEED (C macro)
gsl_rng_set (C function)
gsl_rng_size (C function)
gsl_rng_slatec (C var)
gsl_rng_state (C function)
gsl_rng_taus (C var)
gsl_rng_taus2 (C var)
gsl_rng_transputer (C var)
gsl_rng_tt800 (C var)
GSL_RNG_TYPE (C macro)
gsl_rng_type (C type)
gsl_rng_types_setup (C function)
gsl_rng_uni (C var)
gsl_rng_uni32 (C var)
gsl_rng_uniform (C function)
gsl_rng_uniform_int (C function)
gsl_rng_uniform_pos (C function)
gsl_rng_vax (C var)
gsl_rng_waterman14 (C var)
gsl_rng_zuf (C var)
gsl_root_fdfsolver (C type)
gsl_root_fdfsolver_alloc (C function)
gsl_root_fdfsolver_free (C function)
gsl_root_fdfsolver_iterate (C function)
gsl_root_fdfsolver_name (C function)
gsl_root_fdfsolver_root (C function)
gsl_root_fdfsolver_set (C function)
gsl_root_fdfsolver_type (C type)
gsl_root_fdfsolver_type.gsl_root_fdfsolver_newton (C var)
gsl_root_fdfsolver_type.gsl_root_fdfsolver_secant (C var)
gsl_root_fdfsolver_type.gsl_root_fdfsolver_steffenson (C var)
gsl_root_fsolver (C type)
gsl_root_fsolver_alloc (C function)
gsl_root_fsolver_free (C function)
gsl_root_fsolver_iterate (C function)
gsl_root_fsolver_name (C function)
gsl_root_fsolver_root (C function)
gsl_root_fsolver_set (C function)
gsl_root_fsolver_type (C type)
gsl_root_fsolver_type.gsl_root_fsolver_bisection (C var)
gsl_root_fsolver_type.gsl_root_fsolver_brent (C var)
gsl_root_fsolver_type.gsl_root_fsolver_falsepos (C var)
gsl_root_fsolver_x_lower (C function)
gsl_root_fsolver_x_upper (C function)
gsl_root_test_delta (C function)
gsl_root_test_interval (C function)
gsl_root_test_residual (C function)
gsl_rstat_add (C function)
gsl_rstat_alloc (C function)
gsl_rstat_free (C function)
gsl_rstat_kurtosis (C function)
gsl_rstat_max (C function)
gsl_rstat_mean (C function)
gsl_rstat_median (C function)
gsl_rstat_min (C function)
gsl_rstat_n (C function)
gsl_rstat_norm (C function)
gsl_rstat_quantile_add (C function)
gsl_rstat_quantile_alloc (C function)
gsl_rstat_quantile_free (C function)
gsl_rstat_quantile_get (C function)
gsl_rstat_quantile_reset (C function)
gsl_rstat_quantile_workspace (C type)
gsl_rstat_reset (C function)
gsl_rstat_rms (C function)
gsl_rstat_sd (C function)
gsl_rstat_sd_mean (C function)
gsl_rstat_skew (C function)
gsl_rstat_variance (C function)
gsl_rstat_workspace (C type)
GSL_SET_COMPLEX (C macro)
gsl_set_error_handler (C function)
gsl_set_error_handler_off (C function)
gsl_sf_airy_Ai (C function)
gsl_sf_airy_Ai_deriv (C function)
gsl_sf_airy_Ai_deriv_e (C function)
gsl_sf_airy_Ai_deriv_scaled (C function)
gsl_sf_airy_Ai_deriv_scaled_e (C function)
gsl_sf_airy_Ai_e (C function)
gsl_sf_airy_Ai_scaled (C function)
gsl_sf_airy_Ai_scaled_e (C function)
gsl_sf_airy_Bi (C function)
gsl_sf_airy_Bi_deriv (C function)
gsl_sf_airy_Bi_deriv_e (C function)
gsl_sf_airy_Bi_deriv_scaled (C function)
gsl_sf_airy_Bi_deriv_scaled_e (C function)
gsl_sf_airy_Bi_e (C function)
gsl_sf_airy_Bi_scaled (C function)
gsl_sf_airy_Bi_scaled_e (C function)
gsl_sf_airy_zero_Ai (C function)
gsl_sf_airy_zero_Ai_deriv (C function)
gsl_sf_airy_zero_Ai_deriv_e (C function)
gsl_sf_airy_zero_Ai_e (C function)
gsl_sf_airy_zero_Bi (C function)
gsl_sf_airy_zero_Bi_deriv (C function)
gsl_sf_airy_zero_Bi_deriv_e (C function)
gsl_sf_airy_zero_Bi_e (C function)
gsl_sf_angle_restrict_pos (C function)
gsl_sf_angle_restrict_pos_e (C function)
gsl_sf_angle_restrict_symm (C function)
gsl_sf_angle_restrict_symm_e (C function)
gsl_sf_atanint (C function)
gsl_sf_atanint_e (C function)
gsl_sf_bessel_I0 (C function)
gsl_sf_bessel_I0_e (C function)
gsl_sf_bessel_I0_scaled (C function)
gsl_sf_bessel_i0_scaled (C function)
gsl_sf_bessel_I0_scaled_e (C function)
gsl_sf_bessel_i0_scaled_e (C function)
gsl_sf_bessel_I1 (C function)
gsl_sf_bessel_I1_e (C function)
gsl_sf_bessel_I1_scaled (C function)
gsl_sf_bessel_i1_scaled (C function)
gsl_sf_bessel_I1_scaled_e (C function)
gsl_sf_bessel_i1_scaled_e (C function)
gsl_sf_bessel_i2_scaled (C function)
gsl_sf_bessel_i2_scaled_e (C function)
gsl_sf_bessel_il_scaled (C function)
gsl_sf_bessel_il_scaled_array (C function)
gsl_sf_bessel_il_scaled_e (C function)
gsl_sf_bessel_In (C function)
gsl_sf_bessel_In_array (C function)
gsl_sf_bessel_In_e (C function)
gsl_sf_bessel_In_scaled (C function)
gsl_sf_bessel_In_scaled_array (C function)
gsl_sf_bessel_In_scaled_e (C function)
gsl_sf_bessel_Inu (C function)
gsl_sf_bessel_Inu_e (C function)
gsl_sf_bessel_Inu_scaled (C function)
gsl_sf_bessel_Inu_scaled_e (C function)
gsl_sf_bessel_J0 (C function)
gsl_sf_bessel_j0 (C function)
gsl_sf_bessel_J0_e (C function)
gsl_sf_bessel_j0_e (C function)
gsl_sf_bessel_J1 (C function)
gsl_sf_bessel_j1 (C function)
gsl_sf_bessel_J1_e (C function)
gsl_sf_bessel_j1_e (C function)
gsl_sf_bessel_j2 (C function)
gsl_sf_bessel_j2_e (C function)
gsl_sf_bessel_jl (C function)
gsl_sf_bessel_jl_array (C function)
gsl_sf_bessel_jl_e (C function)
gsl_sf_bessel_jl_steed_array (C function)
gsl_sf_bessel_Jn (C function)
gsl_sf_bessel_Jn_array (C function)
gsl_sf_bessel_Jn_e (C function)
gsl_sf_bessel_Jnu (C function)
gsl_sf_bessel_Jnu_e (C function)
gsl_sf_bessel_K0 (C function)
gsl_sf_bessel_K0_e (C function)
gsl_sf_bessel_K0_scaled (C function)
gsl_sf_bessel_k0_scaled (C function)
gsl_sf_bessel_K0_scaled_e (C function)
gsl_sf_bessel_k0_scaled_e (C function)
gsl_sf_bessel_K1 (C function)
gsl_sf_bessel_K1_e (C function)
gsl_sf_bessel_K1_scaled (C function)
gsl_sf_bessel_k1_scaled (C function)
gsl_sf_bessel_K1_scaled_e (C function)
gsl_sf_bessel_k1_scaled_e (C function)
gsl_sf_bessel_k2_scaled (C function)
gsl_sf_bessel_k2_scaled_e (C function)
gsl_sf_bessel_kl_scaled (C function)
gsl_sf_bessel_kl_scaled_array (C function)
gsl_sf_bessel_kl_scaled_e (C function)
gsl_sf_bessel_Kn (C function)
gsl_sf_bessel_Kn_array (C function)
gsl_sf_bessel_Kn_e (C function)
gsl_sf_bessel_Kn_scaled (C function)
gsl_sf_bessel_Kn_scaled_array (C function)
gsl_sf_bessel_Kn_scaled_e (C function)
gsl_sf_bessel_Knu (C function)
gsl_sf_bessel_Knu_e (C function)
gsl_sf_bessel_Knu_scaled (C function)
gsl_sf_bessel_Knu_scaled_e (C function)
gsl_sf_bessel_lnKnu (C function)
gsl_sf_bessel_lnKnu_e (C function)
gsl_sf_bessel_sequence_Jnu_e (C function)
gsl_sf_bessel_Y0 (C function)
gsl_sf_bessel_y0 (C function)
gsl_sf_bessel_Y0_e (C function)
gsl_sf_bessel_y0_e (C function)
gsl_sf_bessel_Y1 (C function)
gsl_sf_bessel_y1 (C function)
gsl_sf_bessel_Y1_e (C function)
gsl_sf_bessel_y1_e (C function)
gsl_sf_bessel_y2 (C function)
gsl_sf_bessel_y2_e (C function)
gsl_sf_bessel_yl (C function)
gsl_sf_bessel_yl_array (C function)
gsl_sf_bessel_yl_e (C function)
gsl_sf_bessel_Yn (C function)
gsl_sf_bessel_Yn_array (C function)
gsl_sf_bessel_Yn_e (C function)
gsl_sf_bessel_Ynu (C function)
gsl_sf_bessel_Ynu_e (C function)
gsl_sf_bessel_zero_J0 (C function)
gsl_sf_bessel_zero_J0_e (C function)
gsl_sf_bessel_zero_J1 (C function)
gsl_sf_bessel_zero_J1_e (C function)
gsl_sf_bessel_zero_Jnu (C function)
gsl_sf_bessel_zero_Jnu_e (C function)
gsl_sf_beta (C function)
gsl_sf_beta_e (C function)
gsl_sf_beta_inc (C function)
gsl_sf_beta_inc_e (C function)
gsl_sf_Chi (C function)
gsl_sf_Chi_e (C function)
gsl_sf_choose (C function)
gsl_sf_choose_e (C function)
gsl_sf_Ci (C function)
gsl_sf_Ci_e (C function)
gsl_sf_clausen (C function)
gsl_sf_clausen_e (C function)
gsl_sf_complex_cos_e (C function)
gsl_sf_complex_dilog_e (C function)
gsl_sf_complex_log_e (C function)
gsl_sf_complex_logsin_e (C function)
gsl_sf_complex_sin_e (C function)
gsl_sf_conicalP_0 (C function)
gsl_sf_conicalP_0_e (C function)
gsl_sf_conicalP_1 (C function)
gsl_sf_conicalP_1_e (C function)
gsl_sf_conicalP_cyl_reg (C function)
gsl_sf_conicalP_cyl_reg_e (C function)
gsl_sf_conicalP_half (C function)
gsl_sf_conicalP_half_e (C function)
gsl_sf_conicalP_mhalf (C function)
gsl_sf_conicalP_mhalf_e (C function)
gsl_sf_conicalP_sph_reg (C function)
gsl_sf_conicalP_sph_reg_e (C function)
gsl_sf_cos (C function)
gsl_sf_cos_e (C function)
gsl_sf_cos_err_e (C function)
gsl_sf_coulomb_CL_array (C function)
gsl_sf_coulomb_CL_e (C function)
gsl_sf_coulomb_wave_F_array (C function)
gsl_sf_coulomb_wave_FG_array (C function)
gsl_sf_coulomb_wave_FG_e (C function)
gsl_sf_coulomb_wave_FGp_array (C function)
gsl_sf_coulomb_wave_sphF_array (C function)
gsl_sf_coupling_3j (C function)
gsl_sf_coupling_3j_e (C function)
gsl_sf_coupling_6j (C function)
gsl_sf_coupling_6j_e (C function)
gsl_sf_coupling_9j (C function)
gsl_sf_coupling_9j_e (C function)
gsl_sf_dawson (C function)
gsl_sf_dawson_e (C function)
gsl_sf_debye_1 (C function)
gsl_sf_debye_1_e (C function)
gsl_sf_debye_2 (C function)
gsl_sf_debye_2_e (C function)
gsl_sf_debye_3 (C function)
gsl_sf_debye_3_e (C function)
gsl_sf_debye_4 (C function)
gsl_sf_debye_4_e (C function)
gsl_sf_debye_5 (C function)
gsl_sf_debye_5_e (C function)
gsl_sf_debye_6 (C function)
gsl_sf_debye_6_e (C function)
gsl_sf_dilog (C function)
gsl_sf_dilog_e (C function)
gsl_sf_doublefact (C function)
gsl_sf_doublefact_e (C function)
gsl_sf_ellint_D (C function)
gsl_sf_ellint_D_e (C function)
gsl_sf_ellint_E (C function)
gsl_sf_ellint_E_e (C function)
gsl_sf_ellint_Ecomp (C function)
gsl_sf_ellint_Ecomp_e (C function)
gsl_sf_ellint_F (C function)
gsl_sf_ellint_F_e (C function)
gsl_sf_ellint_Kcomp (C function)
gsl_sf_ellint_Kcomp_e (C function)
gsl_sf_ellint_P (C function)
gsl_sf_ellint_P_e (C function)
gsl_sf_ellint_Pcomp (C function)
gsl_sf_ellint_Pcomp_e (C function)
gsl_sf_ellint_RC (C function)
gsl_sf_ellint_RC_e (C function)
gsl_sf_ellint_RD (C function)
gsl_sf_ellint_RD_e (C function)
gsl_sf_ellint_RF (C function)
gsl_sf_ellint_RF_e (C function)
gsl_sf_ellint_RJ (C function)
gsl_sf_ellint_RJ_e (C function)
gsl_sf_elljac_e (C function)
gsl_sf_erf (C function)
gsl_sf_erf_e (C function)
gsl_sf_erf_Q (C function)
gsl_sf_erf_Q_e (C function)
gsl_sf_erf_Z (C function)
gsl_sf_erf_Z_e (C function)
gsl_sf_erfc (C function)
gsl_sf_erfc_e (C function)
gsl_sf_eta (C function)
gsl_sf_eta_e (C function)
gsl_sf_eta_int (C function)
gsl_sf_eta_int_e (C function)
gsl_sf_exp (C function)
gsl_sf_exp_e (C function)
gsl_sf_exp_e10_e (C function)
gsl_sf_exp_err_e (C function)
gsl_sf_exp_err_e10_e (C function)
gsl_sf_exp_mult (C function)
gsl_sf_exp_mult_e (C function)
gsl_sf_exp_mult_e10_e (C function)
gsl_sf_exp_mult_err_e (C function)
gsl_sf_exp_mult_err_e10_e (C function)
gsl_sf_expint_3 (C function)
gsl_sf_expint_3_e (C function)
gsl_sf_expint_E1 (C function)
gsl_sf_expint_E1_e (C function)
gsl_sf_expint_E2 (C function)
gsl_sf_expint_E2_e (C function)
gsl_sf_expint_Ei (C function)
gsl_sf_expint_Ei_e (C function)
gsl_sf_expint_En (C function)
gsl_sf_expint_En_e (C function)
gsl_sf_expm1 (C function)
gsl_sf_expm1_e (C function)
gsl_sf_exprel (C function)
gsl_sf_exprel_2 (C function)
gsl_sf_exprel_2_e (C function)
gsl_sf_exprel_e (C function)
gsl_sf_exprel_n (C function)
gsl_sf_exprel_n_e (C function)
gsl_sf_fact (C function)
gsl_sf_fact_e (C function)
gsl_sf_fermi_dirac_0 (C function)
gsl_sf_fermi_dirac_0_e (C function)
gsl_sf_fermi_dirac_1 (C function)
gsl_sf_fermi_dirac_1_e (C function)
gsl_sf_fermi_dirac_2 (C function)
gsl_sf_fermi_dirac_2_e (C function)
gsl_sf_fermi_dirac_3half (C function)
gsl_sf_fermi_dirac_3half_e (C function)
gsl_sf_fermi_dirac_half (C function)
gsl_sf_fermi_dirac_half_e (C function)
gsl_sf_fermi_dirac_inc_0 (C function)
gsl_sf_fermi_dirac_inc_0_e (C function)
gsl_sf_fermi_dirac_int (C function)
gsl_sf_fermi_dirac_int_e (C function)
gsl_sf_fermi_dirac_m1 (C function)
gsl_sf_fermi_dirac_m1_e (C function)
gsl_sf_fermi_dirac_mhalf (C function)
gsl_sf_fermi_dirac_mhalf_e (C function)
gsl_sf_gamma (C function)
gsl_sf_gamma_e (C function)
gsl_sf_gamma_inc (C function)
gsl_sf_gamma_inc_e (C function)
gsl_sf_gamma_inc_P (C function)
gsl_sf_gamma_inc_P_e (C function)
gsl_sf_gamma_inc_Q (C function)
gsl_sf_gamma_inc_Q_e (C function)
gsl_sf_gammainv (C function)
gsl_sf_gammainv_e (C function)
gsl_sf_gammastar (C function)
gsl_sf_gammastar_e (C function)
gsl_sf_gegenpoly_1 (C function)
gsl_sf_gegenpoly_1_e (C function)
gsl_sf_gegenpoly_2 (C function)
gsl_sf_gegenpoly_2_e (C function)
gsl_sf_gegenpoly_3 (C function)
gsl_sf_gegenpoly_3_e (C function)
gsl_sf_gegenpoly_array (C function)
gsl_sf_gegenpoly_n (C function)
gsl_sf_gegenpoly_n_e (C function)
gsl_sf_hazard (C function)
gsl_sf_hazard_e (C function)
gsl_sf_hermite (C function)
gsl_sf_hermite_array (C function)
gsl_sf_hermite_array_deriv (C function)
gsl_sf_hermite_deriv (C function)
gsl_sf_hermite_deriv_array (C function)
gsl_sf_hermite_deriv_e (C function)
gsl_sf_hermite_e (C function)
gsl_sf_hermite_func (C function)
gsl_sf_hermite_func_array (C function)
gsl_sf_hermite_func_der (C function)
gsl_sf_hermite_func_der_e (C function)
gsl_sf_hermite_func_e (C function)
gsl_sf_hermite_func_fast (C function)
gsl_sf_hermite_func_fast_e (C function)
gsl_sf_hermite_func_series (C function)
gsl_sf_hermite_func_series_e (C function)
gsl_sf_hermite_func_zero (C function)
gsl_sf_hermite_func_zero_e (C function)
gsl_sf_hermite_prob (C function)
gsl_sf_hermite_prob_array (C function)
gsl_sf_hermite_prob_array_deriv (C function)
gsl_sf_hermite_prob_deriv (C function)
gsl_sf_hermite_prob_deriv_array (C function)
gsl_sf_hermite_prob_deriv_e (C function)
gsl_sf_hermite_prob_e (C function)
gsl_sf_hermite_prob_series (C function)
gsl_sf_hermite_prob_series_e (C function)
gsl_sf_hermite_prob_zero (C function)
gsl_sf_hermite_prob_zero_e (C function)
gsl_sf_hermite_series (C function)
gsl_sf_hermite_series_e (C function)
gsl_sf_hermite_zero (C function)
gsl_sf_hermite_zero_e (C function)
gsl_sf_hydrogenicR (C function)
gsl_sf_hydrogenicR_1 (C function)
gsl_sf_hydrogenicR_1_e (C function)
gsl_sf_hydrogenicR_e (C function)
gsl_sf_hyperg_0F1 (C function)
gsl_sf_hyperg_0F1_e (C function)
gsl_sf_hyperg_1F1 (C function)
gsl_sf_hyperg_1F1_e (C function)
gsl_sf_hyperg_1F1_int (C function)
gsl_sf_hyperg_1F1_int_e (C function)
gsl_sf_hyperg_2F0 (C function)
gsl_sf_hyperg_2F0_e (C function)
gsl_sf_hyperg_2F1 (C function)
gsl_sf_hyperg_2F1_conj (C function)
gsl_sf_hyperg_2F1_conj_e (C function)
gsl_sf_hyperg_2F1_conj_renorm (C function)
gsl_sf_hyperg_2F1_conj_renorm_e (C function)
gsl_sf_hyperg_2F1_e (C function)
gsl_sf_hyperg_2F1_renorm (C function)
gsl_sf_hyperg_2F1_renorm_e (C function)
gsl_sf_hyperg_U (C function)
gsl_sf_hyperg_U_e (C function)
gsl_sf_hyperg_U_e10_e (C function)
gsl_sf_hyperg_U_int (C function)
gsl_sf_hyperg_U_int_e (C function)
gsl_sf_hyperg_U_int_e10_e (C function)
gsl_sf_hypot (C function)
gsl_sf_hypot_e (C function)
gsl_sf_hzeta (C function)
gsl_sf_hzeta_e (C function)
gsl_sf_laguerre_1 (C function)
gsl_sf_laguerre_1_e (C function)
gsl_sf_laguerre_2 (C function)
gsl_sf_laguerre_2_e (C function)
gsl_sf_laguerre_3 (C function)
gsl_sf_laguerre_3_e (C function)
gsl_sf_laguerre_n (C function)
gsl_sf_laguerre_n_e (C function)
gsl_sf_lambert_W0 (C function)
gsl_sf_lambert_W0_e (C function)
gsl_sf_lambert_Wm1 (C function)
gsl_sf_lambert_Wm1_e (C function)
gsl_sf_legendre_array (C function)
gsl_sf_legendre_array_e (C function)
gsl_sf_legendre_array_index (C function)
gsl_sf_legendre_array_n (C function)
gsl_sf_legendre_array_size (C function)
gsl_sf_legendre_deriv2_alt_array (C function)
gsl_sf_legendre_deriv2_alt_array_e (C function)
gsl_sf_legendre_deriv2_array (C function)
gsl_sf_legendre_deriv2_array_e (C function)
gsl_sf_legendre_deriv_alt_array (C function)
gsl_sf_legendre_deriv_alt_array_e (C function)
gsl_sf_legendre_deriv_array (C function)
gsl_sf_legendre_deriv_array_e (C function)
gsl_sf_legendre_H3d (C function)
gsl_sf_legendre_H3d_0 (C function)
gsl_sf_legendre_H3d_0_e (C function)
gsl_sf_legendre_H3d_1 (C function)
gsl_sf_legendre_H3d_1_e (C function)
gsl_sf_legendre_H3d_array (C function)
gsl_sf_legendre_H3d_e (C function)
gsl_sf_legendre_nlm (C function)
gsl_sf_legendre_P1 (C function)
gsl_sf_legendre_P1_e (C function)
gsl_sf_legendre_P2 (C function)
gsl_sf_legendre_P2_e (C function)
gsl_sf_legendre_P3 (C function)
gsl_sf_legendre_P3_e (C function)
gsl_sf_legendre_Pl (C function)
gsl_sf_legendre_Pl_array (C function)
gsl_sf_legendre_Pl_deriv_array (C function)
gsl_sf_legendre_Pl_e (C function)
gsl_sf_legendre_Plm (C function)
gsl_sf_legendre_Plm_array (C function)
gsl_sf_legendre_Plm_deriv_array (C function)
gsl_sf_legendre_Plm_e (C function)
gsl_sf_legendre_Q0 (C function)
gsl_sf_legendre_Q0_e (C function)
gsl_sf_legendre_Q1 (C function)
gsl_sf_legendre_Q1_e (C function)
gsl_sf_legendre_Ql (C function)
gsl_sf_legendre_Ql_e (C function)
gsl_sf_legendre_sphPlm (C function)
gsl_sf_legendre_sphPlm_array (C function)
gsl_sf_legendre_sphPlm_deriv_array (C function)
gsl_sf_legendre_sphPlm_e (C function)
gsl_sf_legendre_t (C type)
gsl_sf_lnbeta (C function)
gsl_sf_lnbeta_e (C function)
gsl_sf_lnchoose (C function)
gsl_sf_lnchoose_e (C function)
gsl_sf_lncosh (C function)
gsl_sf_lncosh_e (C function)
gsl_sf_lndoublefact (C function)
gsl_sf_lndoublefact_e (C function)
gsl_sf_lnfact (C function)
gsl_sf_lnfact_e (C function)
gsl_sf_lngamma (C function)
gsl_sf_lngamma_complex_e (C function)
gsl_sf_lngamma_e (C function)
gsl_sf_lngamma_sgn_e (C function)
gsl_sf_lnpoch (C function)
gsl_sf_lnpoch_e (C function)
gsl_sf_lnpoch_sgn_e (C function)
gsl_sf_lnsinh (C function)
gsl_sf_lnsinh_e (C function)
gsl_sf_log (C function)
gsl_sf_log_1plusx (C function)
gsl_sf_log_1plusx_e (C function)
gsl_sf_log_1plusx_mx (C function)
gsl_sf_log_1plusx_mx_e (C function)
gsl_sf_log_abs (C function)
gsl_sf_log_abs_e (C function)
gsl_sf_log_e (C function)
gsl_sf_log_erfc (C function)
gsl_sf_log_erfc_e (C function)
gsl_sf_mathieu_a (C function)
gsl_sf_mathieu_a_array (C function)
gsl_sf_mathieu_a_e (C function)
gsl_sf_mathieu_alloc (C function)
gsl_sf_mathieu_b (C function)
gsl_sf_mathieu_b_array (C function)
gsl_sf_mathieu_b_e (C function)
gsl_sf_mathieu_ce (C function)
gsl_sf_mathieu_ce_array (C function)
gsl_sf_mathieu_ce_e (C function)
gsl_sf_mathieu_free (C function)
gsl_sf_mathieu_Mc (C function)
gsl_sf_mathieu_Mc_array (C function)
gsl_sf_mathieu_Mc_e (C function)
gsl_sf_mathieu_Ms (C function)
gsl_sf_mathieu_Ms_array (C function)
gsl_sf_mathieu_Ms_e (C function)
gsl_sf_mathieu_se (C function)
gsl_sf_mathieu_se_array (C function)
gsl_sf_mathieu_se_e (C function)
gsl_sf_mathieu_workspace (C type)
gsl_sf_multiply (C function)
gsl_sf_multiply_e (C function)
gsl_sf_multiply_err_e (C function)
gsl_sf_poch (C function)
gsl_sf_poch_e (C function)
gsl_sf_pochrel (C function)
gsl_sf_pochrel_e (C function)
gsl_sf_polar_to_rect (C function)
gsl_sf_pow_int (C function)
gsl_sf_pow_int_e (C function)
gsl_sf_psi (C function)
gsl_sf_psi_1 (C function)
gsl_sf_psi_1_e (C function)
gsl_sf_psi_1_int (C function)
gsl_sf_psi_1_int_e (C function)
gsl_sf_psi_1piy (C function)
gsl_sf_psi_1piy_e (C function)
gsl_sf_psi_e (C function)
gsl_sf_psi_int (C function)
gsl_sf_psi_int_e (C function)
gsl_sf_psi_n (C function)
gsl_sf_psi_n_e (C function)
gsl_sf_rect_to_polar (C function)
gsl_sf_result (C type)
gsl_sf_result_e10 (C type)
gsl_sf_Shi (C function)
gsl_sf_Shi_e (C function)
gsl_sf_Si (C function)
gsl_sf_Si_e (C function)
gsl_sf_sin (C function)
gsl_sf_sin_e (C function)
gsl_sf_sin_err_e (C function)
gsl_sf_sinc (C function)
gsl_sf_sinc_e (C function)
gsl_sf_synchrotron_1 (C function)
gsl_sf_synchrotron_1_e (C function)
gsl_sf_synchrotron_2 (C function)
gsl_sf_synchrotron_2_e (C function)
gsl_sf_taylorcoeff (C function)
gsl_sf_taylorcoeff_e (C function)
gsl_sf_transport_2 (C function)
gsl_sf_transport_2_e (C function)
gsl_sf_transport_3 (C function)
gsl_sf_transport_3_e (C function)
gsl_sf_transport_4 (C function)
gsl_sf_transport_4_e (C function)
gsl_sf_transport_5 (C function)
gsl_sf_transport_5_e (C function)
gsl_sf_zeta (C function)
gsl_sf_zeta_e (C function)
gsl_sf_zeta_int (C function)
gsl_sf_zeta_int_e (C function)
gsl_sf_zetam1 (C function)
gsl_sf_zetam1_e (C function)
gsl_sf_zetam1_int (C function)
gsl_sf_zetam1_int_e (C function)
GSL_SIGN (C macro)
gsl_siman_copy_construct_t (C type)
gsl_siman_copy_t (C type)
gsl_siman_destroy_t (C type)
gsl_siman_Efunc_t (C type)
gsl_siman_metric_t (C type)
gsl_siman_params_t (C type)
gsl_siman_print_t (C type)
gsl_siman_solve (C function)
gsl_siman_step_t (C type)
gsl_sort (C function)
gsl_sort2 (C function)
gsl_sort_index (C function)
gsl_sort_largest (C function)
gsl_sort_largest_index (C function)
gsl_sort_smallest (C function)
gsl_sort_smallest_index (C function)
gsl_sort_vector (C function)
gsl_sort_vector2 (C function)
gsl_sort_vector_index (C function)
gsl_sort_vector_largest (C function)
gsl_sort_vector_largest_index (C function)
gsl_sort_vector_smallest (C function)
gsl_sort_vector_smallest_index (C function)
gsl_spblas_dgemm (C function)
gsl_spblas_dgemv (C function)
gsl_splinalg_itersolve_alloc (C function)
gsl_splinalg_itersolve_free (C function)
gsl_splinalg_itersolve_iterate (C function)
gsl_splinalg_itersolve_name (C function)
gsl_splinalg_itersolve_normr (C function)
gsl_splinalg_itersolve_type (C type)
gsl_splinalg_itersolve_type.gsl_splinalg_itersolve_gmres (C var)
gsl_spline (C type)
gsl_spline2d (C type)
gsl_spline2d_alloc (C function)
gsl_spline2d_eval (C function)
gsl_spline2d_eval_deriv_x (C function)
gsl_spline2d_eval_deriv_x_e (C function)
gsl_spline2d_eval_deriv_xx (C function)
gsl_spline2d_eval_deriv_xx_e (C function)
gsl_spline2d_eval_deriv_xy (C function)
gsl_spline2d_eval_deriv_xy_e (C function)
gsl_spline2d_eval_deriv_y (C function)
gsl_spline2d_eval_deriv_y_e (C function)
gsl_spline2d_eval_deriv_yy (C function)
gsl_spline2d_eval_deriv_yy_e (C function)
gsl_spline2d_eval_e (C function)
gsl_spline2d_eval_extrap (C function)
gsl_spline2d_eval_extrap_e (C function)
gsl_spline2d_free (C function)
gsl_spline2d_get (C function)
gsl_spline2d_init (C function)
gsl_spline2d_min_size (C function)
gsl_spline2d_name (C function)
gsl_spline2d_set (C function)
gsl_spline_alloc (C function)
gsl_spline_eval (C function)
gsl_spline_eval_deriv (C function)
gsl_spline_eval_deriv2 (C function)
gsl_spline_eval_deriv2_e (C function)
gsl_spline_eval_deriv_e (C function)
gsl_spline_eval_e (C function)
gsl_spline_eval_integ (C function)
gsl_spline_eval_integ_e (C function)
gsl_spline_free (C function)
gsl_spline_init (C function)
gsl_spline_min_size (C function)
gsl_spline_name (C function)
gsl_spmatrix (C type)
gsl_spmatrix_add (C function)
gsl_spmatrix_alloc (C function)
gsl_spmatrix_alloc_nzmax (C function)
gsl_spmatrix_alloc_nzmax.GSL_SPMATRIX_COO (C macro)
gsl_spmatrix_alloc_nzmax.GSL_SPMATRIX_CSC (C macro)
gsl_spmatrix_alloc_nzmax.GSL_SPMATRIX_CSR (C macro)
gsl_spmatrix_compress (C function)
gsl_spmatrix_csc (C function)
gsl_spmatrix_csr (C function)
gsl_spmatrix_d2sp (C function)
gsl_spmatrix_dense_add (C function)
gsl_spmatrix_dense_sub (C function)
gsl_spmatrix_equal (C function)
gsl_spmatrix_fprintf (C function)
gsl_spmatrix_fread (C function)
gsl_spmatrix_free (C function)
gsl_spmatrix_fscanf (C function)
gsl_spmatrix_fwrite (C function)
gsl_spmatrix_get (C function)
gsl_spmatrix_memcpy (C function)
gsl_spmatrix_min_index (C function)
gsl_spmatrix_minmax (C function)
gsl_spmatrix_nnz (C function)
gsl_spmatrix_norm1 (C function)
gsl_spmatrix_ptr (C function)
gsl_spmatrix_realloc (C function)
gsl_spmatrix_scale (C function)
gsl_spmatrix_scale_columns (C function)
gsl_spmatrix_scale_rows (C function)
gsl_spmatrix_set (C function)
gsl_spmatrix_set_zero (C function)
gsl_spmatrix_sp2d (C function)
gsl_spmatrix_transpose (C function)
gsl_spmatrix_transpose_memcpy (C function)
gsl_spmatrix_type (C function)
gsl_stats_absdev (C function)
gsl_stats_absdev_m (C function)
gsl_stats_correlation (C function)
gsl_stats_covariance (C function)
gsl_stats_covariance_m (C function)
gsl_stats_gastwirth_from_sorted_data (C function)
gsl_stats_kurtosis (C function)
gsl_stats_kurtosis_m_sd (C function)
gsl_stats_lag1_autocorrelation (C function)
gsl_stats_lag1_autocorrelation_m (C function)
gsl_stats_mad (C function)
gsl_stats_mad0 (C function)
gsl_stats_max (C function)
gsl_stats_max_index (C function)
gsl_stats_mean (C function)
gsl_stats_median (C function)
gsl_stats_median_from_sorted_data (C function)
gsl_stats_min (C function)
gsl_stats_min_index (C function)
gsl_stats_minmax (C function)
gsl_stats_minmax_index (C function)
gsl_stats_Qn0_from_sorted_data (C function)
gsl_stats_Qn_from_sorted_data (C function)
gsl_stats_quantile_from_sorted_data (C function)
gsl_stats_sd (C function)
gsl_stats_sd_m (C function)
gsl_stats_sd_with_fixed_mean (C function)
gsl_stats_select (C function)
gsl_stats_skew (C function)
gsl_stats_skew_m_sd (C function)
gsl_stats_Sn0_from_sorted_data (C function)
gsl_stats_Sn_from_sorted_data (C function)
gsl_stats_spearman (C function)
gsl_stats_trmean_from_sorted_data (C function)
gsl_stats_tss (C function)
gsl_stats_tss_m (C function)
gsl_stats_variance (C function)
gsl_stats_variance_m (C function)
gsl_stats_variance_with_fixed_mean (C function)
gsl_stats_wabsdev (C function)
gsl_stats_wabsdev_m (C function)
gsl_stats_wkurtosis (C function)
gsl_stats_wkurtosis_m_sd (C function)
gsl_stats_wmean (C function)
gsl_stats_wsd (C function)
gsl_stats_wsd_m (C function)
gsl_stats_wsd_with_fixed_mean (C function)
gsl_stats_wskew (C function)
gsl_stats_wskew_m_sd (C function)
gsl_stats_wtss (C function)
gsl_stats_wtss_m (C function)
gsl_stats_wvariance (C function)
gsl_stats_wvariance_m (C function)
gsl_stats_wvariance_with_fixed_mean (C function)
gsl_strerror (C function)
gsl_sum_levin_u_accel (C function)
gsl_sum_levin_u_alloc (C function)
gsl_sum_levin_u_free (C function)
gsl_sum_levin_u_workspace (C type)
gsl_sum_levin_utrunc_accel (C function)
gsl_sum_levin_utrunc_alloc (C function)
gsl_sum_levin_utrunc_free (C function)
gsl_sum_levin_utrunc_workspace (C type)
gsl_vector (C type)
gsl_vector_add (C function)
gsl_vector_add_constant (C function)
gsl_vector_alloc (C function)
gsl_vector_axpby (C function)
gsl_vector_calloc (C function)
gsl_vector_complex_conj_memcpy (C function)
gsl_vector_complex_const_imag (C function)
gsl_vector_complex_const_real (C function)
gsl_vector_complex_div_real (C function)
gsl_vector_complex_imag (C function)
gsl_vector_complex_real (C function)
gsl_vector_const_ptr (C function)
gsl_vector_const_subvector (C function)
gsl_vector_const_subvector_with_stride (C function)
gsl_vector_const_view (C type)
gsl_vector_const_view_array (C function)
gsl_vector_const_view_array_with_stride (C function)
gsl_vector_div (C function)
gsl_vector_equal (C function)
gsl_vector_fprintf (C function)
gsl_vector_fread (C function)
gsl_vector_free (C function)
gsl_vector_fscanf (C function)
gsl_vector_fwrite (C function)
gsl_vector_get (C function)
gsl_vector_isneg (C function)
gsl_vector_isnonneg (C function)
gsl_vector_isnull (C function)
gsl_vector_ispos (C function)
gsl_vector_max (C function)
gsl_vector_max_index (C function)
gsl_vector_memcpy (C function)
gsl_vector_min (C function)
gsl_vector_min_index (C function)
gsl_vector_minmax (C function)
gsl_vector_minmax_index (C function)
gsl_vector_mul (C function)
gsl_vector_ptr (C function)
gsl_vector_reverse (C function)
gsl_vector_scale (C function)
gsl_vector_set (C function)
gsl_vector_set_all (C function)
gsl_vector_set_basis (C function)
gsl_vector_set_zero (C function)
gsl_vector_sub (C function)
gsl_vector_subvector (C function)
gsl_vector_subvector_with_stride (C function)
gsl_vector_sum (C function)
gsl_vector_swap (C function)
gsl_vector_swap_elements (C function)
gsl_vector_view (C type)
gsl_vector_view_array (C function)
gsl_vector_view_array_with_stride (C function)
gsl_wavelet (C type)
gsl_wavelet2d_nstransform (C function)
gsl_wavelet2d_nstransform_forward (C function)
gsl_wavelet2d_nstransform_inverse (C function)
gsl_wavelet2d_nstransform_matrix (C function)
gsl_wavelet2d_nstransform_matrix_forward (C function)
gsl_wavelet2d_nstransform_matrix_inverse (C function)
gsl_wavelet2d_transform (C function)
gsl_wavelet2d_transform_forward (C function)
gsl_wavelet2d_transform_inverse (C function)
gsl_wavelet2d_transform_matrix (C function)
gsl_wavelet2d_transform_matrix_forward (C function)
gsl_wavelet2d_transform_matrix_inverse (C function)
gsl_wavelet_alloc (C function)
gsl_wavelet_free (C function)
gsl_wavelet_name (C function)
gsl_wavelet_transform (C function)
gsl_wavelet_transform_forward (C function)
gsl_wavelet_transform_inverse (C function)
gsl_wavelet_type (C type)
gsl_wavelet_type.gsl_wavelet_bspline (C var)
gsl_wavelet_type.gsl_wavelet_bspline_centered (C var)
gsl_wavelet_type.gsl_wavelet_daubechies (C var)
gsl_wavelet_type.gsl_wavelet_daubechies_centered (C var)
gsl_wavelet_type.gsl_wavelet_haar (C var)
gsl_wavelet_type.gsl_wavelet_haar_centered (C var)
gsl_wavelet_workspace (C type)
gsl_wavelet_workspace_alloc (C function)
gsl_wavelet_workspace_free (C function)
Gumbel distribution (Type 1)
(Type 2)
H
Haar wavelets
Hankel transforms, discrete
HAVE_INLINE
hazard function, normal distribution
HBOOK
header files, including
heapsort
HEMM, Level-3 BLAS
HEMV, Level-2 BLAS
HER, Level-2 BLAS
HER2, Level-2 BLAS
HER2K, Level-3 BLAS
HERK, Level-3 BLAS
Hermite functions
Hermite functions, derivatives
Hermite functions, zeros
Hermite polynomials
Hermite polynomials, derivatives
Hermite polynomials, zeros
hermitian matrix, complex, eigensystem
Hessenberg decomposition
Hessenberg triangular decomposition
histogram statistics
histogram, from ntuple
histograms
histograms, random sampling from
Householder linear solver
Householder matrix
Householder transformation
how to report
Hurwitz Zeta Function
HYBRID algorithm, unscaled without derivatives
HYBRID algorithms for nonlinear systems
HYBRIDJ algorithm
HYBRIDS algorithm, scaled without derivatives
HYBRIDSJ algorithm
hydrogen atom
hyperbolic cosine, inverse
hyperbolic functions, complex numbers
hyperbolic integrals
hyperbolic sine, inverse
hyperbolic space
hyperbolic tangent, inverse
hypergeometric functions
hypergeometric random variates
hypot
hypot function, special functions
I
I(x), Bessel Functions
i(x), Bessel Functions
identity matrix
identity permutation
IEEE exceptions
IEEE floating point
IEEE format for floating point numbers
IEEE infinity, defined as a macro
IEEE NaN, defined as a macro
illumination, units of
imperial units
Implicit Euler method
Implicit Runge-Kutta method
importance sampling, VEGAS
including GSL header files
incomplete Beta function, normalized
incomplete Fermi-Dirac integral
incomplete Gamma function
indirect sorting
indirect sorting, of vector elements
infinity, defined as a macro
infinity, IEEE format
info-gsl mailing list
initial value problems, differential equations
initializing matrices
initializing vectors
inline functions
integer powers
integrals, exponential
integration, numerical (quadrature)
interpolating quadrature
interpolation
interpolation, using Chebyshev polynomials
inverse complex trigonometric functions
inverse cumulative distribution functions
inverse hyperbolic cosine
inverse hyperbolic functions, complex numbers
inverse hyperbolic sine
inverse hyperbolic tangent
inverse of a matrix, by LU decomposition
inverting a permutation
Irregular Cylindrical Bessel Functions
Irregular Modified Bessel Functions, Fractional Order
Irregular Modified Cylindrical Bessel Functions
Irregular Modified Spherical Bessel Functions
Irregular Spherical Bessel Functions
iterating through combinations
iterating through multisets
iterating through permutations
iterative refinement of solutions in linear systems
J
J(x), Bessel Functions
j(x), Bessel Functions
Jacobi elliptic functions
Jacobi orthogonalization
Jacobian matrix, ODEs
Jacobian matrix, root finding
K
K(x), Bessel Functions
k(x), Bessel Functions
knots, basis splines
kurtosis
L
Laguerre functions
Lambert function
Landau distribution
LAPACK
Laplace distribution
large dense linear least squares
large linear least squares, normal equations
large linear least squares, routines
large linear least squares, steps
large linear least squares, TSQR
LD_LIBRARY_PATH
ldexp
LDL decomposition
LDLT decomposition
LDLT decomposition, banded
leading dimension, matrices
least squares fit
least squares troubleshooting
least squares, covariance of best-fit parameters
least squares, nonlinear
least squares, regularized
least squares, robust
Legendre forms of elliptic integrals
Legendre functions
Legendre polynomials
length, computed accurately using hypot
length, computed accurately using hypot3
Levenberg-Marquardt algorithm
Levenberg-Marquardt algorithm, geodesic acceleration
Levin u-transform
Levy distribution
Levy distribution, skew
libraries, linking with
libraries, shared
license of GSL
light, units of
linear algebra
linear algebra, BLAS
linear algebra, sparse
linear interpolation
linear least squares, large
linear regression
linear systems
linear systems, refinement of solutions
linking with GSL libraries
location estimation
log1p
logarithm and related functions
logarithm of Beta function
logarithm of combinatorial factor C(m
logarithm of complex number
logarithm of cosh function, special functions
logarithm of double factorial
logarithm of factorial
logarithm of Gamma function
logarithm of Pochhammer symbol
logarithm of sinh function
logarithm of the determinant of a matrix
logarithm, computed accurately near 1
Logarithmic random variates
Logistic distribution
Lognormal distribution
low discrepancy sequences
Low-level CBLAS
LQ decomposition
LU decomposition
LU decomposition, banded
M
macros for mathematical constants
magnitude of complex number
mailing list
mailing list archives
mailing list for GSL announcements
mantissa, IEEE format
mass, units of
mathematical constants, defined as macros
mathematical functions, elementary
Mathieu Function Characteristic Values
Mathieu functions
matrices
matrices, banded
matrices, initializing
matrices, range-checking
matrices, sparse
matrix determinant
matrix diagonal
matrix factorization
matrix inverse
matrix square root, Cholesky decomposition
matrix subdiagonal
matrix superdiagonal
matrix, constant
matrix, identity
matrix, operations
matrix, zero
max
maximal phase, Daubechies wavelets
maximization, see minimization
maximum of two numbers
maximum value, from histogram
mean
mean value, from histogram
mean, trimmed
mean, truncated
median absolute deviation
Mills' ratio, inverse
min
minimization, BFGS algorithm
minimization, caveats
minimization, conjugate gradient algorithm
minimization, multidimensional
minimization, one-dimensional
minimization, overview
minimization, Polak-Ribiere algorithm
minimization, providing a function to minimize
minimization, simplex algorithm
minimization, steepest descent algorithm
minimization, stopping parameters
minimum finding, Brent's method
minimum finding, golden section algorithm
minimum of two numbers
minimum value, from histogram
MINPACK, minimization algorithms
MISCFUN
MISER monte carlo integration
Mixed-radix FFT, complex data
Mixed-radix FFT, real data
Modified Bessel Functions, Fractional Order
Modified Cholesky Decomposition
Modified Clenshaw-Curtis quadrature
Modified Cylindrical Bessel Functions
Modified Givens Rotation, BLAS
Modified Newton's method for nonlinear systems
Modified Spherical Bessel Functions
Monte Carlo integration
moving maximum
moving mean
moving median
moving median absolute deviation
moving minimum
moving quantile range
moving standard deviation
moving sum
moving variance
moving window accumulators
moving window statistics
moving window, allocation
MRG, multiple recursive random number generator
MT19937 random number generator
multi-parameter regression
multidimensional integration
multidimensional root finding, Broyden algorithm
multidimensional root finding, overview
multidimensional root finding, providing a function to solve
Multimin, caveats
Multinomial distribution
multiplication
multisets
multistep methods, ODEs
N
n)
,
[1]
N-dimensional random direction vector
NaN, defined as a macro
nautical units
Negative Binomial distribution, random variates
Nelder-Mead simplex algorithm for minimization
Newton algorithm, discrete
Newton algorithm, globally convergent
Newton's method for finding roots
Newton's method for systems of nonlinear equations
Niederreiter sequence
NIST Statistical Reference Datasets
non-normalized incomplete Gamma function
nonlinear equation, solutions of
nonlinear fitting, stopping parameters, convergence
nonlinear functions, minimization
nonlinear least squares
nonlinear least squares, dogleg
nonlinear least squares, double dogleg
nonlinear least squares, levenberg-marquardt
nonlinear least squares, levenberg-marquardt, geodesic acceleration
nonlinear least squares, overview
nonlinear systems of equations, solution of
nonsymmetric matrix, real, eigensystem
Nordsieck form
normalized form, IEEE format
normalized incomplete Beta function
Not-a-number, defined as a macro
NRM2, Level-1 BLAS
ntuples
nuclear physics, constants
numerical constants, defined as macros
numerical derivatives
numerical integration (quadrature)
O
obtaining GSL
ODEs, initial value problems
online statistics
,
[1]
optimization, combinatorial
optimization, see minimization
optimized functions, alternatives
ordering, matrix elements
ordinary differential equations, initial value problem
oscillatory functions, numerical integration of
overflow, IEEE exceptions
P
Pareto distribution
PAW
permutations
physical constants
physical dimension, matrices
pi, defined as a macro
Pivoted Cholesky Decomposition
plain Monte Carlo
Pochhammer symbol
Poisson random numbers
Polak-Ribiere algorithm, minimization
polar form of complex numbers
polar to rectangular conversion
polygamma functions
polynomial evaluation
polynomial interpolation
polynomials, roots of
power function
power of complex number
power, units of
precision, IEEE arithmetic
predictor-corrector method, ODEs
prefixes
pressure
Prince-Dormand, Runge-Kutta method
printers units
probability distribution, from histogram
probability distributions, from histograms
projection of ntuples
psi function
Q
QAG quadrature algorithm
QAGI quadrature algorithm
QAGP quadrature algorithm
QAGS quadrature algorithm
QAWC quadrature algorithm
QAWF quadrature algorithm
QAWO quadrature algorithm
QAWS quadrature algorithm
QL decomposition
Qn statistic
QNG quadrature algorithm
QR decomposition
QR decomposition with column pivoting
QUADPACK
quadratic equation, solving
quadrature
quadrature, fixed point
quadrature, interpolating
quadrature, Lebedev
quadrature, on unit sphere
quantile functions
quasi-random sequences
R
R250 shift-register random number generator
Racah coefficients
Radial Mathieu Functions
radioactivity
Radix-2 FFT for real data
Radix-2 FFT, complex data
rand, BSD random number generator
rand48 random number generator
random number distributions
random number generators
random sampling from histograms
RANDU random number generator
RANF random number generator
range
range-checking for matrices
range-checking for vectors
RANLUX random number generator
RANLXD random number generator
RANLXS random number generator
RANMAR random number generator
,
[1]
Rayleigh distribution
Rayleigh Tail distribution
real nonsymmetric matrix, eigensystem
real symmetric matrix, eigensystem
Reciprocal Gamma function
rectangular to polar conversion
recursive stratified sampling, MISER
reduction of angular variables
refinement of solutions in linear systems
regression, least squares
regression, ridge
regression, robust
regression, Tikhonov
Regular Bessel Functions, Fractional Order
Regular Bessel Functions, Zeros of
Regular Cylindrical Bessel Functions
Regular Modified Bessel Functions, Fractional Order
Regular Modified Cylindrical Bessel Functions
Regular Modified Spherical Bessel Functions
Regular Spherical Bessel Functions
Regulated Gamma function
relative Pochhammer symbol
reporting bugs in GSL
representations of complex numbers
resampling from histograms
residual, in nonlinear systems of equations
reversing a permutation
ridge regression
Riemann Zeta Function
RK2, Runge-Kutta method
RK4, Runge-Kutta method
RKF45, Runge-Kutta-Fehlberg method
robust location estimators
robust regression
robust scale estimators
rolling maximum
rolling mean
rolling median
rolling median absolute deviation
rolling minimum
rolling quantile range
rolling standard deviation
rolling sum
rolling variance
rolling window accumulators
root finding
root finding, bisection algorithm
root finding, Brent's method
root finding, caveats
root finding, false position algorithm
root finding, initial guess
root finding, Newton's method
root finding, overview
root finding, providing a function to solve
root finding, search bounds
root finding, secant method
root finding, Steffenson's method
root finding, stopping parameters
,
[1]
roots
ROTG, Level-1 BLAS
rounding mode
Runge-Kutta Cash-Karp method
Runge-Kutta methods, ordinary differential equations
Runge-Kutta Prince-Dormand method
running statistics
S
safe comparison of floating point numbers
safeguarded step-length algorithm
sampling from histograms
,
[1]
SAXPY, Level-1 BLAS
SCAL, Level-1 BLAS
scale estimation
schedule, cooling
se(q,x), Mathieu function
secant method for finding roots
selection function, ntuples
series, acceleration
shared libraries
shell prompt
Shi(x)
shift-register random number generator
Si(x)
sign bit, IEEE format
sign of the determinant of a matrix
simplex algorithm, minimization
simulated annealing
sin, of complex number
sine function, special functions
single precision, IEEE format
singular functions, numerical integration of
singular points, specifying positions in quadrature
singular value decomposition
Skew Levy distribution
skewness
slope, see numerical derivative
Sn statistic
Sobol sequence
solution of
solution of linear system by Householder transformations
solution of linear systems, Ax=b
solving a nonlinear equation
solving nonlinear systems of equations
sorting
sorting eigenvalues and eigenvectors
sorting vector elements
source code, reuse in applications
sparse BLAS
sparse BLAS, references
sparse linear algebra
sparse linear algebra, examples
sparse linear algebra, iterative solvers
sparse linear algebra, overview
sparse linear algebra, references
sparse matrices
sparse matrices, accessing elements
sparse matrices, allocation
sparse matrices, BLAS operations
sparse matrices, compressed column storage
sparse matrices, compressed row storage
sparse matrices, compressed sparse column
sparse matrices, compressed sparse row
sparse matrices, compression
sparse matrices, conversion
sparse matrices, coordinate format
sparse matrices, copying
sparse matrices, data types
sparse matrices, examples
sparse matrices, exchanging rows and columns
sparse matrices, initializing elements
sparse matrices, iterative solvers
sparse matrices, min/max elements
sparse matrices, operations
sparse matrices, overview
sparse matrices, properties
sparse matrices, reading
sparse matrices, references
sparse matrices, storage formats
sparse matrices, triplet format
sparse matrices, writing
sparse, iterative solvers
special functions
,
[1]
Spherical Bessel Functions
spherical harmonics
spherical random variates, 2D
spherical random variates, 3D
spherical random variates, N-dimensional
spline
splines, basis
square root of a matrix, Cholesky decomposition
square root of complex number
standard deviation
standard deviation, from histogram
standards conformance, ANSI C
Statistical Reference Datasets (StRD)
statistics
statistics, from histogram
statistics, moving window
steepest descent algorithm, minimization
Steffenson's method for finding roots
stratified sampling in Monte Carlo integration
stride, of vector index
Student t-distribution
subdiagonal, of a matrix
summation, acceleration
superdiagonal, matrix
SVD
SWAP, Level-1 BLAS
swapping permutation elements
SYMM, Level-3 BLAS
symmetric matrices, banded
symmetric matrix, real, eigensystem
SYMV, Level-2 BLAS
synchrotron functions
SYR, Level-2 BLAS
SYR2, Level-2 BLAS
SYR2K, Level-3 BLAS
SYRK, Level-3 BLAS
systems of equations, nonlinear
T
t-distribution
t-test
tangent of complex number
Tausworthe random number generator
Taylor coefficients, computation of
testing combination for validity
testing multiset for validity
testing permutation for validity
thermal energy, units of
Tikhonov regression
time units
trailing dimension, matrices
transformation, Householder
transforms, Hankel
transforms, wavelet
transport functions
traveling salesman problem
triangular systems
tridiagonal decomposition
,
[1]
tridiagonal systems
trigonometric functions
trigonometric functions of complex numbers
trigonometric integrals
trimmed mean
TRMM, Level-3 BLAS
TRMV, Level-2 BLAS
TRSM, Level-3 BLAS
TRSV, Level-2 BLAS
truncated mean
TSP
TT800 random number generator
two dimensional Gaussian distribution
,
[1]
two dimensional histograms
two-sided exponential distribution
Type 1 Gumbel distribution, random variates
Type 2 Gumbel distribution
U
u-transform for series
underflow, IEEE exceptions
uniform distribution
units of
,
[1]
,
[2]
,
[3]
units, conversion of
units, imperial
Unix random number generators, rand
Unix random number generators, rand48
unnormalized incomplete Gamma function
unweighted linear fits
V
value function, ntuples
Van der Pol oscillator, example
variance
variance, from histogram
variance-covariance matrix, linear fits
VAX random number generator
vector, operations
vector, sorting elements of
vectors
vectors, initializing
vectors, range-checking
VEGAS Monte Carlo integration
viscosity
volume units
W
W function
warning options
warranty (none)
wavelet transforms
website, developer information
Weibull distribution
weight, units of
weighted linear fits
Wigner coefficients
Wishart random variates
Y
Y(x), Bessel Functions
y(x), Bessel Functions
Z
zero finding
zero matrix
zero, IEEE format
Zeros of Regular Bessel Functions
Zeta functions
Ziggurat method