Update GSL to version 1.15
New in gsl-1.15:
** Added Tuomo Keskitalo's new ode branch ode-initval2 with a
gsl_odeiv2 prefix. This provides proper support for implicit
solvers. It is intended to be the new default for differential
equations. The existing gsl_odeiv routines will be retained for
binary compatibility but their interface will be deprecated.
** Added new gsl_integrate_cquad routines for robust integration of
difficult functions using the doubly-adaptive CQUAD algorithm
(Pedro Gonnet).
** Added error checking to CBLAS functions (Jose Luis Garcia Pallero)
** Added a new function gsl_integration_glfixed_point to return
ordered Gauss-Legendre points and weights contained within a
gsl_integration_glfixed_table [bug #32237].
** Added a new function gsl_interp_type_min_size to return the size of
an interpolation type.
** Added a function gsl_pow_uint(x,n) to compute x^n for unsigned
exponents (needed when n exceeds the range of signed integers).
** Added new routine gsl_linalg_complex_cholesky_invert to handle the
matrix inversion for complex Cholesky decompositions (Huan Wu).
** Added the functions gsl_vector_equal(x,y) and gsl_matrix_equal(x,y)
for testing equality of two vectors or matrices.
** Added function gsl_eigen_nonsymmv_params to control the balancing
transformation for eigenvector calculations. Balancing is now
turned off by default for gsl_eigen_nonsymmv.
** It is now possible to choose an alternative cblas library via
pkg-config using the GSL_CBLAS_LIB environment variable or
the pkg-config --define-variable option.
** The jacobi method gsl_eigen_jacobi now uses the norm of the
off-diagonal elements for its convergence criterion, as in
algorithm 8.4.3 of Golub and van Loan.
** The newton multiroot solvers now return an error when a singular
jacobian is detected.
** The interpolation functions now return NaN and when x is out of range,
instead of extrapolating.
** The gsl_multimin_fdfsolver multidimensional minimisers now return
GSL_ENOPROG immediately if the generated trial point does not
differ from the initial point (to machine precision), avoiding
unnecessary further iterations.
** Extended the range of gsl_sf_bessel_lnKnu_e by rescaling
intermediate results to avoid internal overflows [bug #31528].
** Improved the result of gsl_sf_atanint_e for large arguments by
adding the first order 1/x correction term. [bug #29562]
** Fixed the gsl_rng_ranlxs generators to enforce a maximum seed value
of 2^31-1. Larger seed values caused out of range values to be
returned.
** Fixed gsl_ran_chisq_pdf(x,nu) to return correct result of 1/2
instead of 0 when x=0 and nu=2, and +inf when x=0 and nu<2.
** Fixed gsl_pow_int(x,n) to avoid an infinite loop when n=INT_MIN due
to wrapping of signed integers.
** Fixed gsl_sf_hyperg_2F1(a,b,c,x) to avoid returning NaN for
arguments |a|>10. [bug #24812]
** Avoid spurious underflow return code in gsl_sf_beta_inc_e when
intermediate underflow does not affect the result. [bug #30933]
** Avoid segfault in Chebyshev series derivatives gsl_cheb_calc_deriv
for n=1. [bug #29139]
2011-05-08 22:35:25 +02:00
|
|
|
@comment $NetBSD: PLIST,v 1.18 2011/05/08 20:35:25 asau Exp $
|
2000-02-08 13:05:02 +01:00
|
|
|
bin/gsl-config
|
2001-03-28 23:49:41 +02:00
|
|
|
bin/gsl-histogram
|
|
|
|
bin/gsl-randist
|
|
|
|
include/gsl/gsl_blas.h
|
|
|
|
include/gsl/gsl_blas_types.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_block.h
|
|
|
|
include/gsl/gsl_block_char.h
|
|
|
|
include/gsl/gsl_block_complex_double.h
|
|
|
|
include/gsl/gsl_block_complex_float.h
|
|
|
|
include/gsl/gsl_block_complex_long_double.h
|
|
|
|
include/gsl/gsl_block_double.h
|
|
|
|
include/gsl/gsl_block_float.h
|
|
|
|
include/gsl/gsl_block_int.h
|
|
|
|
include/gsl/gsl_block_long.h
|
|
|
|
include/gsl/gsl_block_long_double.h
|
|
|
|
include/gsl/gsl_block_short.h
|
|
|
|
include/gsl/gsl_block_uchar.h
|
|
|
|
include/gsl/gsl_block_uint.h
|
|
|
|
include/gsl/gsl_block_ulong.h
|
|
|
|
include/gsl/gsl_block_ushort.h
|
Update to 1.9:
* What is new in gsl-1.9:
** Fixed the elliptic integrals F,E,P,D so that they have the correct
behavior for phi > pi/2 and phi < 0. The angular argument is now
valid for all phi. Also added the complete elliptic integral
gsl_sf_ellint_Pcomp.
** Added a new BFGS minimisation method gsl_multimin_fdfminimizer_vector_bfgs2
based on the algorithm given by R.Fletcher in "Practical Methods of
Optimisation" (Second edition). This requires substantially fewer
function and gradient evaluations, and supercedes the existing BFGS
minimiser.
** The beta functions gsl_sf_beta_e(a,b) and gsl_sf_lnbeta_e(a,b) now
handle negative arguments a,b. Added new function gsl_sf_lnbeta_sgn_e
for computing magnitude and sign of negative beta values, analagous to
gsl_sf_lngamma_sgn_e.
** gsl_cheb_eval_mode now uses the same error estimate as
gsl_cheb_eval_err.
** Improved gsl_sf_legendre_sphPlm_e to avoid underflow with large
arguments.
** Added updated Knuth generator, gsl_rng_knuthran2002, from 9th
printing of "The Art of Computer Programming". Fixes various
weaknesses in the earlier version gsl_rng_knuthran. See
http://www-cs-faculty.stanford.edu/~knuth/news02.htm
** The functions gsl_multifit_fsolver_set, gsl_multifit_fdfsolver_set
and gsl_multiroot_fsolver_set, gsl_multiroot_fdfsolver_set now have a
const qualifier for the input vector x, reflecting their actual usage.
** gsl_sf_expint_E2(x) now returns the correct value 1 for x==0,
instead of NaN.
** The gsl_ran_gamma function now uses the Marsaglia-Tsang fast gamma
method of gsl_ran_gamma_mt by default.
** The matrix and vector min/max functions now always propagate any
NaNs in their input.
** Prevented NaN occuring for extreme parameters in
gsl_cdf_fdist_{P,Q}inv and gsl_cdf_beta_{P,Q}inv
** Corrected error estimates for the angular reduction functions
gsl_sf_angle_restrict_symm_err and gsl_sf_angle_restrict_pos_err.
Fixed gsl_sf_angle_restrict_pos to avoid possibility of returning
small negative values. Errors are now reported for out of range
negative arguments as well as positive. These functions now return
NaN when there would be significant loss of precision.
** Corrected an error in the higher digits of M_PI_4 (this was beyond
the limit of double precision, so double precision results are not
affected).
** gsl_root_test_delta now always returns success if two iterates are
the same, x1==x0.
** A Japanese translation of the reference manual is now available
from the GSL webpage at http://www.gnu.org/software/gsl/ thanks to
Daisuke TOMINAGA.
** Added new functions for basis splines, see the "Basis Splines"
chapter in the GSL Reference Manual for details.
** Added new functions for testing the sign of vectors and matrices,
gsl_vector_ispos, gsl_vector_isneg, gsl_matrix_ispos and
gsl_matrix_isneg.
** Fixed a bug in gsl_sf_lnpoch_e and gsl_sf_lnpoch_sgn_e which caused
the incorrect value 1.0 instead of 0.0 to be returned for x==0.
** Fixed cancellation error in gsl_sf_laguerre_n for n > 1e7 so that
larger arguments can be calculated without loss of precision.
** Improved gsl_sf_zeta_e to return exactly zero for negative even
integers, avoiding less accurate trigonometric reduction.
** Fixed a bug in gsl_sf_zetam1_int_e where 0 was returned instead of
-1 for negative even integer arguments.
** When the differential equation solver gsl_odeiv_apply encounters a
singularity it returns the step-size which caused the error code from
the user-defined function, as opposed to leaving the step-size
unchanged.
** Added support for nonsymmetric eigensystems
** Added Mathieu functions
2007-02-26 09:05:15 +01:00
|
|
|
include/gsl/gsl_bspline.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_cblas.h
|
Update to version 1.4.
* What is new in gsl-1.4:
** Added cumulative distribution functions and their inverses for the
continuous random distributions including: gaussian, lognormal, gamma,
beta, cauchy, laplace, chisq, exponential, gumbel, weibull,
F-distribution, t-distribution, logistic, pareto and rayleigh.
** Added faster binomial random variates using the TPE rejection
algorithm, in the function gsl_randist_binomial_tpe.
** Added new functions gsl_rng_fwrite and gsl_rnd_fread for storing
the state of random number generators in a file.
** Added a new function gsl_combination_memcpy()
** Corrected values of electrical constants in CGS units. To take
account of different electrical systems of units the values are now
prefixed by GSL_CONST_MKSA (for the SI Metre, Kilogram, Second, Ampere
system) or GSL_CONST_CGSM (for the Centimetre, Gram, Second, Magnetic
system with the Gauss as the fundamental unit of magnetic field
strength). The previous GSL_CONST_MKS and GSL_CONST_CGS prefixes have
been removed, as have the permeability and permittivity constants in
the CGS system since this uses different defining equations.
** Fixed bugs in the random number generators gsl_rng_fishman18,
gsl_rng_fishman2x, and gsl_rng_knuthran2 which caused them to return
incorrect results. Minor corrections were made to the parameters in
the other Knuth generators borosh13, coveyou, fishman20, lecuyer21,
and waterman14.
** Fixed a missing transpose bug in the gsl_linalg_QR_QRsolve
and gsl_linalg_QRPT_QRsolve routines which were computing the
solution to Q^T R x = b instead of Q R x = b.
** Fixed gsl_sf_gammainv to return zero instead of a domain
error for arguments corresponding to singularities in gamma.
** Fixed a bug in the simplex minimization algorithm which
caused it to fail to find the second highest point correctly
when searching the set of simplex points.
** Fixed a bug in the conjugate gradient minimizers conjugate_pr,
conjugate_fr and vector_bgfs which caused the search
directions to be updated incorrectly.
** Fixed a bug in gsl_sf_psi_1_int(1) which caused it to
return the incorrect sign for psi(1,1).
** Fixed the simulated annealing routine gsl_siman_solve to use the
parameter iters_fixed_T for the number of iterations at fixed
temperature instead of n_tries.
** Fixed a bug in gsl_combination_valid which caused it to return the
incorrect status.
** Fixed a bug in gsl_permutation_canonical_to_linear which caused the
output to always be zero, and the input permutation to be incorrectly
replaced by the output.
** Fixed a bug is gsl_ran_discrete which could cause uninitialised
data to be returned for some distributions.
** Fixed the dependencies for gsl_chebyshev.h to include gsl_math.h.
** Fixed a bug in gsl_complex_arccsc_real which caused it to return
the incorrect sign for the imaginary part when -1<x<0.
** Fixed a bug in the QAWC Cauchy integration routine which could
allow the singularity to fall on an interval boundary, leading to
division by zero.
** Improved gsl_sf_gamma_inc_P(a,x) to avoid a domain error for x<<a
when a>10.
** Improved the accuracy of gsl_sf_coupling_3j for large arguments.
** Improved the performance of gsl_sf_choose(m,n) by separating the
calculations for small and large arguments.
** On platforms without IEEE comparisons gsl_{isnan,isinf,finite} will
fall back to the system versions of isnan, isinf and finite if
available.
** gsl_linalg_householder_hv now uses BLAS routines internally
** The script configure.in is now compatible with autoconf-2.50 and
later.
** Reduced the memory usage of the multifit algorithms from MxM to MxN
for large M by performing the QR decomposition of the Jacobian
in-place.
** IEEE modes now use the C99 fenv.h functions when platform spectific
functions are not available.
2003-08-30 23:50:59 +02:00
|
|
|
include/gsl/gsl_cdf.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_chebyshev.h
|
Update to version 1.4.
* What is new in gsl-1.4:
** Added cumulative distribution functions and their inverses for the
continuous random distributions including: gaussian, lognormal, gamma,
beta, cauchy, laplace, chisq, exponential, gumbel, weibull,
F-distribution, t-distribution, logistic, pareto and rayleigh.
** Added faster binomial random variates using the TPE rejection
algorithm, in the function gsl_randist_binomial_tpe.
** Added new functions gsl_rng_fwrite and gsl_rnd_fread for storing
the state of random number generators in a file.
** Added a new function gsl_combination_memcpy()
** Corrected values of electrical constants in CGS units. To take
account of different electrical systems of units the values are now
prefixed by GSL_CONST_MKSA (for the SI Metre, Kilogram, Second, Ampere
system) or GSL_CONST_CGSM (for the Centimetre, Gram, Second, Magnetic
system with the Gauss as the fundamental unit of magnetic field
strength). The previous GSL_CONST_MKS and GSL_CONST_CGS prefixes have
been removed, as have the permeability and permittivity constants in
the CGS system since this uses different defining equations.
** Fixed bugs in the random number generators gsl_rng_fishman18,
gsl_rng_fishman2x, and gsl_rng_knuthran2 which caused them to return
incorrect results. Minor corrections were made to the parameters in
the other Knuth generators borosh13, coveyou, fishman20, lecuyer21,
and waterman14.
** Fixed a missing transpose bug in the gsl_linalg_QR_QRsolve
and gsl_linalg_QRPT_QRsolve routines which were computing the
solution to Q^T R x = b instead of Q R x = b.
** Fixed gsl_sf_gammainv to return zero instead of a domain
error for arguments corresponding to singularities in gamma.
** Fixed a bug in the simplex minimization algorithm which
caused it to fail to find the second highest point correctly
when searching the set of simplex points.
** Fixed a bug in the conjugate gradient minimizers conjugate_pr,
conjugate_fr and vector_bgfs which caused the search
directions to be updated incorrectly.
** Fixed a bug in gsl_sf_psi_1_int(1) which caused it to
return the incorrect sign for psi(1,1).
** Fixed the simulated annealing routine gsl_siman_solve to use the
parameter iters_fixed_T for the number of iterations at fixed
temperature instead of n_tries.
** Fixed a bug in gsl_combination_valid which caused it to return the
incorrect status.
** Fixed a bug in gsl_permutation_canonical_to_linear which caused the
output to always be zero, and the input permutation to be incorrectly
replaced by the output.
** Fixed a bug is gsl_ran_discrete which could cause uninitialised
data to be returned for some distributions.
** Fixed the dependencies for gsl_chebyshev.h to include gsl_math.h.
** Fixed a bug in gsl_complex_arccsc_real which caused it to return
the incorrect sign for the imaginary part when -1<x<0.
** Fixed a bug in the QAWC Cauchy integration routine which could
allow the singularity to fall on an interval boundary, leading to
division by zero.
** Improved gsl_sf_gamma_inc_P(a,x) to avoid a domain error for x<<a
when a>10.
** Improved the accuracy of gsl_sf_coupling_3j for large arguments.
** Improved the performance of gsl_sf_choose(m,n) by separating the
calculations for small and large arguments.
** On platforms without IEEE comparisons gsl_{isnan,isinf,finite} will
fall back to the system versions of isnan, isinf and finite if
available.
** gsl_linalg_householder_hv now uses BLAS routines internally
** The script configure.in is now compatible with autoconf-2.50 and
later.
** Reduced the memory usage of the multifit algorithms from MxM to MxN
for large M by performing the QR decomposition of the Jacobian
in-place.
** IEEE modes now use the C99 fenv.h functions when platform spectific
functions are not available.
2003-08-30 23:50:59 +02:00
|
|
|
include/gsl/gsl_check_range.h
|
Update to version 1.1.1. From the NEWS file:
* What is new in gsl-1.1.1:
** Fixes to histogram2d stat functions
** Added missing prototypes for complex LU determinant functions
** Improved error handling in multifit routines
** Added check to avoid division by zero for rank-deficient matrix in
multifit iteration
* What was new in gsl-1.1:
** The permutation module now includes a copy function
gsl_permutation_memcpy
** The implementation of gsl_sf_gamma_inc has been improved and now
avoids problems caused by internal singularities which occurred in the
series expansion for some combinations of parameters.
** IEEE comparisons of infinities and NaNs are tested during the
configure stage and the functions gsl_isnan, gsl_isinf and gsl_finite
are only compiled on platforms which support the necessary tests.
** The histogram routines now include a sum function,
gsl_histogram_sum for computing the total bin sum, and additional
statistics functions for 2d histograms.
** Internal error checking of user-defined functions has been improved
in the multiroots functions.
** Constants now include the Bohr Radius and Vacuum Permittivity.
** Range checking is now turned off when building the library, but is
still on by default when compiling user applications.
** A combinations directory has been added for generating combinations (n,k).
** The gamma function now returns exact values for integer arguments.
** Fixed bugs in gsl_sf_hyperg_1F1_int and gsl_sf_hyperg_1F1.
** Fixed internal error handling in gsl_sf_laguerre_n to allow
recovery from overflow.
** Several routines for handling divided difference polynomials have
been added to the poly/ directory.
** The interpolation routines now include polynomial interpolation,
based on divided-differences.
** Added new random number generators from Knuth's Seminumerical
Algorithms, 3rd Edition: borosh13, coveyou, fishman18, fishman20,
fishman2x, knuthran, knuthran2, lecuyer21, waterman14.
** Changed divisor in random number generator gfsr4 from 2^32-1 to
2^32 to prevent exact value of 1.0 from being returned, as specified
in the documentation.
2002-05-03 23:41:31 +02:00
|
|
|
include/gsl/gsl_combination.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_complex.h
|
|
|
|
include/gsl/gsl_complex_math.h
|
|
|
|
include/gsl/gsl_const.h
|
update to 1.5
notable changes besides bugfixes are:
** Multifit routines now handle iterations where |f| is already
minimised to zero, without division by zero.
** Numerical derivatives should now be calculated using the
gsl_deriv_forward, gsl_deriv_central and gsl_deriv_backward functions,
which accept a step-size argument in addition to the position x. The
original gsl_diff functions (without the step-size) are deprecated.
** The tridiagonal matrix solvers gsl_linalg_solve_symm_tridiag,
gsl_linalg_solve_tridiag, gsl_linalg_solve_symm_cyc_tridiag,
gsl_linalg_solve_cyc_tridiag now use the GSL_ERROR macro to report
errors, instead of simply returning an error code. The arguments to
these functions must now use exact lengths with no additional
elements. For cyclic systems all vectors must be of length N, for
tridiagonal systems the offdiagonal elements must be of length N-1.
** The singular value decomposition routines gsl_linalg_SV_decomp and
gsl_linalg_SV_decomp_mod now handle the SVD of a column vector (N=1,
arbitrary M), which can occur in linear fitting.
** Added Stefan-Boltzmann constant and Thomson cross section to
physical constants
2004-08-06 21:29:49 +02:00
|
|
|
include/gsl/gsl_const_cgs.h
|
Update to version 1.4.
* What is new in gsl-1.4:
** Added cumulative distribution functions and their inverses for the
continuous random distributions including: gaussian, lognormal, gamma,
beta, cauchy, laplace, chisq, exponential, gumbel, weibull,
F-distribution, t-distribution, logistic, pareto and rayleigh.
** Added faster binomial random variates using the TPE rejection
algorithm, in the function gsl_randist_binomial_tpe.
** Added new functions gsl_rng_fwrite and gsl_rnd_fread for storing
the state of random number generators in a file.
** Added a new function gsl_combination_memcpy()
** Corrected values of electrical constants in CGS units. To take
account of different electrical systems of units the values are now
prefixed by GSL_CONST_MKSA (for the SI Metre, Kilogram, Second, Ampere
system) or GSL_CONST_CGSM (for the Centimetre, Gram, Second, Magnetic
system with the Gauss as the fundamental unit of magnetic field
strength). The previous GSL_CONST_MKS and GSL_CONST_CGS prefixes have
been removed, as have the permeability and permittivity constants in
the CGS system since this uses different defining equations.
** Fixed bugs in the random number generators gsl_rng_fishman18,
gsl_rng_fishman2x, and gsl_rng_knuthran2 which caused them to return
incorrect results. Minor corrections were made to the parameters in
the other Knuth generators borosh13, coveyou, fishman20, lecuyer21,
and waterman14.
** Fixed a missing transpose bug in the gsl_linalg_QR_QRsolve
and gsl_linalg_QRPT_QRsolve routines which were computing the
solution to Q^T R x = b instead of Q R x = b.
** Fixed gsl_sf_gammainv to return zero instead of a domain
error for arguments corresponding to singularities in gamma.
** Fixed a bug in the simplex minimization algorithm which
caused it to fail to find the second highest point correctly
when searching the set of simplex points.
** Fixed a bug in the conjugate gradient minimizers conjugate_pr,
conjugate_fr and vector_bgfs which caused the search
directions to be updated incorrectly.
** Fixed a bug in gsl_sf_psi_1_int(1) which caused it to
return the incorrect sign for psi(1,1).
** Fixed the simulated annealing routine gsl_siman_solve to use the
parameter iters_fixed_T for the number of iterations at fixed
temperature instead of n_tries.
** Fixed a bug in gsl_combination_valid which caused it to return the
incorrect status.
** Fixed a bug in gsl_permutation_canonical_to_linear which caused the
output to always be zero, and the input permutation to be incorrectly
replaced by the output.
** Fixed a bug is gsl_ran_discrete which could cause uninitialised
data to be returned for some distributions.
** Fixed the dependencies for gsl_chebyshev.h to include gsl_math.h.
** Fixed a bug in gsl_complex_arccsc_real which caused it to return
the incorrect sign for the imaginary part when -1<x<0.
** Fixed a bug in the QAWC Cauchy integration routine which could
allow the singularity to fall on an interval boundary, leading to
division by zero.
** Improved gsl_sf_gamma_inc_P(a,x) to avoid a domain error for x<<a
when a>10.
** Improved the accuracy of gsl_sf_coupling_3j for large arguments.
** Improved the performance of gsl_sf_choose(m,n) by separating the
calculations for small and large arguments.
** On platforms without IEEE comparisons gsl_{isnan,isinf,finite} will
fall back to the system versions of isnan, isinf and finite if
available.
** gsl_linalg_householder_hv now uses BLAS routines internally
** The script configure.in is now compatible with autoconf-2.50 and
later.
** Reduced the memory usage of the multifit algorithms from MxM to MxN
for large M by performing the QR decomposition of the Jacobian
in-place.
** IEEE modes now use the C99 fenv.h functions when platform spectific
functions are not available.
2003-08-30 23:50:59 +02:00
|
|
|
include/gsl/gsl_const_cgsm.h
|
update to 1.5
notable changes besides bugfixes are:
** Multifit routines now handle iterations where |f| is already
minimised to zero, without division by zero.
** Numerical derivatives should now be calculated using the
gsl_deriv_forward, gsl_deriv_central and gsl_deriv_backward functions,
which accept a step-size argument in addition to the position x. The
original gsl_diff functions (without the step-size) are deprecated.
** The tridiagonal matrix solvers gsl_linalg_solve_symm_tridiag,
gsl_linalg_solve_tridiag, gsl_linalg_solve_symm_cyc_tridiag,
gsl_linalg_solve_cyc_tridiag now use the GSL_ERROR macro to report
errors, instead of simply returning an error code. The arguments to
these functions must now use exact lengths with no additional
elements. For cyclic systems all vectors must be of length N, for
tridiagonal systems the offdiagonal elements must be of length N-1.
** The singular value decomposition routines gsl_linalg_SV_decomp and
gsl_linalg_SV_decomp_mod now handle the SVD of a column vector (N=1,
arbitrary M), which can occur in linear fitting.
** Added Stefan-Boltzmann constant and Thomson cross section to
physical constants
2004-08-06 21:29:49 +02:00
|
|
|
include/gsl/gsl_const_mks.h
|
Update to version 1.4.
* What is new in gsl-1.4:
** Added cumulative distribution functions and their inverses for the
continuous random distributions including: gaussian, lognormal, gamma,
beta, cauchy, laplace, chisq, exponential, gumbel, weibull,
F-distribution, t-distribution, logistic, pareto and rayleigh.
** Added faster binomial random variates using the TPE rejection
algorithm, in the function gsl_randist_binomial_tpe.
** Added new functions gsl_rng_fwrite and gsl_rnd_fread for storing
the state of random number generators in a file.
** Added a new function gsl_combination_memcpy()
** Corrected values of electrical constants in CGS units. To take
account of different electrical systems of units the values are now
prefixed by GSL_CONST_MKSA (for the SI Metre, Kilogram, Second, Ampere
system) or GSL_CONST_CGSM (for the Centimetre, Gram, Second, Magnetic
system with the Gauss as the fundamental unit of magnetic field
strength). The previous GSL_CONST_MKS and GSL_CONST_CGS prefixes have
been removed, as have the permeability and permittivity constants in
the CGS system since this uses different defining equations.
** Fixed bugs in the random number generators gsl_rng_fishman18,
gsl_rng_fishman2x, and gsl_rng_knuthran2 which caused them to return
incorrect results. Minor corrections were made to the parameters in
the other Knuth generators borosh13, coveyou, fishman20, lecuyer21,
and waterman14.
** Fixed a missing transpose bug in the gsl_linalg_QR_QRsolve
and gsl_linalg_QRPT_QRsolve routines which were computing the
solution to Q^T R x = b instead of Q R x = b.
** Fixed gsl_sf_gammainv to return zero instead of a domain
error for arguments corresponding to singularities in gamma.
** Fixed a bug in the simplex minimization algorithm which
caused it to fail to find the second highest point correctly
when searching the set of simplex points.
** Fixed a bug in the conjugate gradient minimizers conjugate_pr,
conjugate_fr and vector_bgfs which caused the search
directions to be updated incorrectly.
** Fixed a bug in gsl_sf_psi_1_int(1) which caused it to
return the incorrect sign for psi(1,1).
** Fixed the simulated annealing routine gsl_siman_solve to use the
parameter iters_fixed_T for the number of iterations at fixed
temperature instead of n_tries.
** Fixed a bug in gsl_combination_valid which caused it to return the
incorrect status.
** Fixed a bug in gsl_permutation_canonical_to_linear which caused the
output to always be zero, and the input permutation to be incorrectly
replaced by the output.
** Fixed a bug is gsl_ran_discrete which could cause uninitialised
data to be returned for some distributions.
** Fixed the dependencies for gsl_chebyshev.h to include gsl_math.h.
** Fixed a bug in gsl_complex_arccsc_real which caused it to return
the incorrect sign for the imaginary part when -1<x<0.
** Fixed a bug in the QAWC Cauchy integration routine which could
allow the singularity to fall on an interval boundary, leading to
division by zero.
** Improved gsl_sf_gamma_inc_P(a,x) to avoid a domain error for x<<a
when a>10.
** Improved the accuracy of gsl_sf_coupling_3j for large arguments.
** Improved the performance of gsl_sf_choose(m,n) by separating the
calculations for small and large arguments.
** On platforms without IEEE comparisons gsl_{isnan,isinf,finite} will
fall back to the system versions of isnan, isinf and finite if
available.
** gsl_linalg_householder_hv now uses BLAS routines internally
** The script configure.in is now compatible with autoconf-2.50 and
later.
** Reduced the memory usage of the multifit algorithms from MxM to MxN
for large M by performing the QR decomposition of the Jacobian
in-place.
** IEEE modes now use the C99 fenv.h functions when platform spectific
functions are not available.
2003-08-30 23:50:59 +02:00
|
|
|
include/gsl/gsl_const_mksa.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_const_num.h
|
update to 1.5
notable changes besides bugfixes are:
** Multifit routines now handle iterations where |f| is already
minimised to zero, without division by zero.
** Numerical derivatives should now be calculated using the
gsl_deriv_forward, gsl_deriv_central and gsl_deriv_backward functions,
which accept a step-size argument in addition to the position x. The
original gsl_diff functions (without the step-size) are deprecated.
** The tridiagonal matrix solvers gsl_linalg_solve_symm_tridiag,
gsl_linalg_solve_tridiag, gsl_linalg_solve_symm_cyc_tridiag,
gsl_linalg_solve_cyc_tridiag now use the GSL_ERROR macro to report
errors, instead of simply returning an error code. The arguments to
these functions must now use exact lengths with no additional
elements. For cyclic systems all vectors must be of length N, for
tridiagonal systems the offdiagonal elements must be of length N-1.
** The singular value decomposition routines gsl_linalg_SV_decomp and
gsl_linalg_SV_decomp_mod now handle the SVD of a column vector (N=1,
arbitrary M), which can occur in linear fitting.
** Added Stefan-Boltzmann constant and Thomson cross section to
physical constants
2004-08-06 21:29:49 +02:00
|
|
|
include/gsl/gsl_deriv.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_dft_complex.h
|
|
|
|
include/gsl/gsl_dft_complex_float.h
|
|
|
|
include/gsl/gsl_dht.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_diff.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_eigen.h
|
|
|
|
include/gsl/gsl_errno.h
|
|
|
|
include/gsl/gsl_fft.h
|
|
|
|
include/gsl/gsl_fft_complex.h
|
|
|
|
include/gsl/gsl_fft_complex_float.h
|
|
|
|
include/gsl/gsl_fft_halfcomplex.h
|
|
|
|
include/gsl/gsl_fft_halfcomplex_float.h
|
|
|
|
include/gsl/gsl_fft_real.h
|
|
|
|
include/gsl/gsl_fft_real_float.h
|
|
|
|
include/gsl/gsl_fit.h
|
|
|
|
include/gsl/gsl_heapsort.h
|
|
|
|
include/gsl/gsl_histogram.h
|
|
|
|
include/gsl/gsl_histogram2d.h
|
|
|
|
include/gsl/gsl_ieee_utils.h
|
2008-12-20 00:16:22 +01:00
|
|
|
include/gsl/gsl_inline.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_integration.h
|
|
|
|
include/gsl/gsl_interp.h
|
|
|
|
include/gsl/gsl_linalg.h
|
|
|
|
include/gsl/gsl_machine.h
|
|
|
|
include/gsl/gsl_math.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_matrix.h
|
|
|
|
include/gsl/gsl_matrix_char.h
|
|
|
|
include/gsl/gsl_matrix_complex_double.h
|
|
|
|
include/gsl/gsl_matrix_complex_float.h
|
|
|
|
include/gsl/gsl_matrix_complex_long_double.h
|
|
|
|
include/gsl/gsl_matrix_double.h
|
|
|
|
include/gsl/gsl_matrix_float.h
|
|
|
|
include/gsl/gsl_matrix_int.h
|
|
|
|
include/gsl/gsl_matrix_long.h
|
|
|
|
include/gsl/gsl_matrix_long_double.h
|
|
|
|
include/gsl/gsl_matrix_short.h
|
|
|
|
include/gsl/gsl_matrix_uchar.h
|
|
|
|
include/gsl/gsl_matrix_uint.h
|
|
|
|
include/gsl/gsl_matrix_ulong.h
|
|
|
|
include/gsl/gsl_matrix_ushort.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_message.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_min.h
|
2008-12-20 00:16:22 +01:00
|
|
|
include/gsl/gsl_minmax.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_mode.h
|
|
|
|
include/gsl/gsl_monte.h
|
|
|
|
include/gsl/gsl_monte_miser.h
|
|
|
|
include/gsl/gsl_monte_plain.h
|
|
|
|
include/gsl/gsl_monte_vegas.h
|
|
|
|
include/gsl/gsl_multifit.h
|
|
|
|
include/gsl/gsl_multifit_nlin.h
|
|
|
|
include/gsl/gsl_multimin.h
|
|
|
|
include/gsl/gsl_multiroots.h
|
Update to 1.14:
* What is new in gsl-1.14:
** Upgraded to latest libtool, autoconf and automake (libtool-2.2.6b,
autoconf-2.65, automake-1.11.1). Fixes security hole in 'make
dist' (see Automake CVE-2009-4029).
** Added support for "multisets", which are similar to permutations
and combinations. A multiset is an array of k integers in the
range 0 to n-1 where each value may occur more than once. Multisets
can be used to iterate over the indices of a k-th order symmetric
tensor in n-space. (Rhys Ulerich)
** Added gsl_integrate_glfixed routines for performing fixed order
Gauss-Legendre integration
(Pavel Holoborodko, Konstantin Holoborodko, Rhys Ulerich)
** In the LMDER multi-dimensional fitting routines, the return code
GSL_ENOPROG is now used instead of GSL_CONTINUE for the case where
10 or more attempts to find a suitable trial step have been made
without success. [bug #25383]
** The confluent hypergeometric function gsl_sf_hyperg_U (a,b,x) has
been extended to support x < 0 for cases not involving
singularities in 1F1(a,b,x). [bug #27859]
** The F-distribution gsl_ran_fdist_pdf now avoids unnecessary
underflow and overflow and handles cases where n > 248. [bug
#28500]
** The SVD routines now use a scaled version of the implicit QR method
and compute the shift more reliably for values at the limit of
double precision, avoiding potential NaNs. [bug #28767]
** A compile time error is emitted if the configuration stage prevents
the functions gsl_isnan and gsl_finite from being defined.
** Added missing dereference in GSL_VECTOR_COMPLEX when not using
GSL_RANGE_CHECK [bug #28017]
** Improved the range of gsl_sf_hyperg1F1(a,b,x) when a<0,b>0. [bug
#28718]
** Added macros GSL_MAJOR_VERSION and GSL_MINOR_VERSION in
<gsl/gsl_version.h>
** Improved gsl_eigen_symmv and gsl_eigen_symm to avoid a potential
infinite loop when the tridiagonalised matrix contains very small
values. [bug #28096]
** Added functions gsl_multifit_linear_usvd and
gsl_multifit_wlinear_usvd for multilinear fitting without
column-scaling of the fit matrix.
2010-03-15 11:45:28 +01:00
|
|
|
include/gsl/gsl_multiset.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_nan.h
|
|
|
|
include/gsl/gsl_ntuple.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_odeiv.h
|
Update GSL to version 1.15
New in gsl-1.15:
** Added Tuomo Keskitalo's new ode branch ode-initval2 with a
gsl_odeiv2 prefix. This provides proper support for implicit
solvers. It is intended to be the new default for differential
equations. The existing gsl_odeiv routines will be retained for
binary compatibility but their interface will be deprecated.
** Added new gsl_integrate_cquad routines for robust integration of
difficult functions using the doubly-adaptive CQUAD algorithm
(Pedro Gonnet).
** Added error checking to CBLAS functions (Jose Luis Garcia Pallero)
** Added a new function gsl_integration_glfixed_point to return
ordered Gauss-Legendre points and weights contained within a
gsl_integration_glfixed_table [bug #32237].
** Added a new function gsl_interp_type_min_size to return the size of
an interpolation type.
** Added a function gsl_pow_uint(x,n) to compute x^n for unsigned
exponents (needed when n exceeds the range of signed integers).
** Added new routine gsl_linalg_complex_cholesky_invert to handle the
matrix inversion for complex Cholesky decompositions (Huan Wu).
** Added the functions gsl_vector_equal(x,y) and gsl_matrix_equal(x,y)
for testing equality of two vectors or matrices.
** Added function gsl_eigen_nonsymmv_params to control the balancing
transformation for eigenvector calculations. Balancing is now
turned off by default for gsl_eigen_nonsymmv.
** It is now possible to choose an alternative cblas library via
pkg-config using the GSL_CBLAS_LIB environment variable or
the pkg-config --define-variable option.
** The jacobi method gsl_eigen_jacobi now uses the norm of the
off-diagonal elements for its convergence criterion, as in
algorithm 8.4.3 of Golub and van Loan.
** The newton multiroot solvers now return an error when a singular
jacobian is detected.
** The interpolation functions now return NaN and when x is out of range,
instead of extrapolating.
** The gsl_multimin_fdfsolver multidimensional minimisers now return
GSL_ENOPROG immediately if the generated trial point does not
differ from the initial point (to machine precision), avoiding
unnecessary further iterations.
** Extended the range of gsl_sf_bessel_lnKnu_e by rescaling
intermediate results to avoid internal overflows [bug #31528].
** Improved the result of gsl_sf_atanint_e for large arguments by
adding the first order 1/x correction term. [bug #29562]
** Fixed the gsl_rng_ranlxs generators to enforce a maximum seed value
of 2^31-1. Larger seed values caused out of range values to be
returned.
** Fixed gsl_ran_chisq_pdf(x,nu) to return correct result of 1/2
instead of 0 when x=0 and nu=2, and +inf when x=0 and nu<2.
** Fixed gsl_pow_int(x,n) to avoid an infinite loop when n=INT_MIN due
to wrapping of signed integers.
** Fixed gsl_sf_hyperg_2F1(a,b,c,x) to avoid returning NaN for
arguments |a|>10. [bug #24812]
** Avoid spurious underflow return code in gsl_sf_beta_inc_e when
intermediate underflow does not affect the result. [bug #30933]
** Avoid segfault in Chebyshev series derivatives gsl_cheb_calc_deriv
for n=1. [bug #29139]
2011-05-08 22:35:25 +02:00
|
|
|
include/gsl/gsl_odeiv2.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_permutation.h
|
|
|
|
include/gsl/gsl_permute.h
|
|
|
|
include/gsl/gsl_permute_char.h
|
2001-11-22 13:58:40 +01:00
|
|
|
include/gsl/gsl_permute_complex_double.h
|
|
|
|
include/gsl/gsl_permute_complex_float.h
|
|
|
|
include/gsl/gsl_permute_complex_long_double.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_permute_double.h
|
|
|
|
include/gsl/gsl_permute_float.h
|
|
|
|
include/gsl/gsl_permute_int.h
|
|
|
|
include/gsl/gsl_permute_long.h
|
|
|
|
include/gsl/gsl_permute_long_double.h
|
|
|
|
include/gsl/gsl_permute_short.h
|
|
|
|
include/gsl/gsl_permute_uchar.h
|
|
|
|
include/gsl/gsl_permute_uint.h
|
|
|
|
include/gsl/gsl_permute_ulong.h
|
|
|
|
include/gsl/gsl_permute_ushort.h
|
|
|
|
include/gsl/gsl_permute_vector.h
|
|
|
|
include/gsl/gsl_permute_vector_char.h
|
2001-11-22 13:58:40 +01:00
|
|
|
include/gsl/gsl_permute_vector_complex_double.h
|
|
|
|
include/gsl/gsl_permute_vector_complex_float.h
|
|
|
|
include/gsl/gsl_permute_vector_complex_long_double.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_permute_vector_double.h
|
|
|
|
include/gsl/gsl_permute_vector_float.h
|
|
|
|
include/gsl/gsl_permute_vector_int.h
|
|
|
|
include/gsl/gsl_permute_vector_long.h
|
|
|
|
include/gsl/gsl_permute_vector_long_double.h
|
|
|
|
include/gsl/gsl_permute_vector_short.h
|
|
|
|
include/gsl/gsl_permute_vector_uchar.h
|
|
|
|
include/gsl/gsl_permute_vector_uint.h
|
|
|
|
include/gsl/gsl_permute_vector_ulong.h
|
|
|
|
include/gsl/gsl_permute_vector_ushort.h
|
|
|
|
include/gsl/gsl_poly.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_pow_int.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_precision.h
|
|
|
|
include/gsl/gsl_qrng.h
|
|
|
|
include/gsl/gsl_randist.h
|
|
|
|
include/gsl/gsl_rng.h
|
|
|
|
include/gsl/gsl_roots.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_sf.h
|
|
|
|
include/gsl/gsl_sf_airy.h
|
|
|
|
include/gsl/gsl_sf_bessel.h
|
|
|
|
include/gsl/gsl_sf_clausen.h
|
|
|
|
include/gsl/gsl_sf_coulomb.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_sf_coupling.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_sf_dawson.h
|
|
|
|
include/gsl/gsl_sf_debye.h
|
|
|
|
include/gsl/gsl_sf_dilog.h
|
|
|
|
include/gsl/gsl_sf_elementary.h
|
|
|
|
include/gsl/gsl_sf_ellint.h
|
|
|
|
include/gsl/gsl_sf_elljac.h
|
|
|
|
include/gsl/gsl_sf_erf.h
|
|
|
|
include/gsl/gsl_sf_exp.h
|
|
|
|
include/gsl/gsl_sf_expint.h
|
|
|
|
include/gsl/gsl_sf_fermi_dirac.h
|
|
|
|
include/gsl/gsl_sf_gamma.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_sf_gegenbauer.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_sf_hyperg.h
|
|
|
|
include/gsl/gsl_sf_laguerre.h
|
2001-11-22 13:58:40 +01:00
|
|
|
include/gsl/gsl_sf_lambert.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_sf_legendre.h
|
|
|
|
include/gsl/gsl_sf_log.h
|
Update to 1.9:
* What is new in gsl-1.9:
** Fixed the elliptic integrals F,E,P,D so that they have the correct
behavior for phi > pi/2 and phi < 0. The angular argument is now
valid for all phi. Also added the complete elliptic integral
gsl_sf_ellint_Pcomp.
** Added a new BFGS minimisation method gsl_multimin_fdfminimizer_vector_bfgs2
based on the algorithm given by R.Fletcher in "Practical Methods of
Optimisation" (Second edition). This requires substantially fewer
function and gradient evaluations, and supercedes the existing BFGS
minimiser.
** The beta functions gsl_sf_beta_e(a,b) and gsl_sf_lnbeta_e(a,b) now
handle negative arguments a,b. Added new function gsl_sf_lnbeta_sgn_e
for computing magnitude and sign of negative beta values, analagous to
gsl_sf_lngamma_sgn_e.
** gsl_cheb_eval_mode now uses the same error estimate as
gsl_cheb_eval_err.
** Improved gsl_sf_legendre_sphPlm_e to avoid underflow with large
arguments.
** Added updated Knuth generator, gsl_rng_knuthran2002, from 9th
printing of "The Art of Computer Programming". Fixes various
weaknesses in the earlier version gsl_rng_knuthran. See
http://www-cs-faculty.stanford.edu/~knuth/news02.htm
** The functions gsl_multifit_fsolver_set, gsl_multifit_fdfsolver_set
and gsl_multiroot_fsolver_set, gsl_multiroot_fdfsolver_set now have a
const qualifier for the input vector x, reflecting their actual usage.
** gsl_sf_expint_E2(x) now returns the correct value 1 for x==0,
instead of NaN.
** The gsl_ran_gamma function now uses the Marsaglia-Tsang fast gamma
method of gsl_ran_gamma_mt by default.
** The matrix and vector min/max functions now always propagate any
NaNs in their input.
** Prevented NaN occuring for extreme parameters in
gsl_cdf_fdist_{P,Q}inv and gsl_cdf_beta_{P,Q}inv
** Corrected error estimates for the angular reduction functions
gsl_sf_angle_restrict_symm_err and gsl_sf_angle_restrict_pos_err.
Fixed gsl_sf_angle_restrict_pos to avoid possibility of returning
small negative values. Errors are now reported for out of range
negative arguments as well as positive. These functions now return
NaN when there would be significant loss of precision.
** Corrected an error in the higher digits of M_PI_4 (this was beyond
the limit of double precision, so double precision results are not
affected).
** gsl_root_test_delta now always returns success if two iterates are
the same, x1==x0.
** A Japanese translation of the reference manual is now available
from the GSL webpage at http://www.gnu.org/software/gsl/ thanks to
Daisuke TOMINAGA.
** Added new functions for basis splines, see the "Basis Splines"
chapter in the GSL Reference Manual for details.
** Added new functions for testing the sign of vectors and matrices,
gsl_vector_ispos, gsl_vector_isneg, gsl_matrix_ispos and
gsl_matrix_isneg.
** Fixed a bug in gsl_sf_lnpoch_e and gsl_sf_lnpoch_sgn_e which caused
the incorrect value 1.0 instead of 0.0 to be returned for x==0.
** Fixed cancellation error in gsl_sf_laguerre_n for n > 1e7 so that
larger arguments can be calculated without loss of precision.
** Improved gsl_sf_zeta_e to return exactly zero for negative even
integers, avoiding less accurate trigonometric reduction.
** Fixed a bug in gsl_sf_zetam1_int_e where 0 was returned instead of
-1 for negative even integer arguments.
** When the differential equation solver gsl_odeiv_apply encounters a
singularity it returns the step-size which caused the error code from
the user-defined function, as opposed to leaving the step-size
unchanged.
** Added support for nonsymmetric eigensystems
** Added Mathieu functions
2007-02-26 09:05:15 +01:00
|
|
|
include/gsl/gsl_sf_mathieu.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_sf_pow_int.h
|
|
|
|
include/gsl/gsl_sf_psi.h
|
|
|
|
include/gsl/gsl_sf_result.h
|
|
|
|
include/gsl/gsl_sf_synchrotron.h
|
|
|
|
include/gsl/gsl_sf_transport.h
|
|
|
|
include/gsl/gsl_sf_trig.h
|
|
|
|
include/gsl/gsl_sf_zeta.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_siman.h
|
|
|
|
include/gsl/gsl_sort.h
|
|
|
|
include/gsl/gsl_sort_char.h
|
|
|
|
include/gsl/gsl_sort_double.h
|
|
|
|
include/gsl/gsl_sort_float.h
|
|
|
|
include/gsl/gsl_sort_int.h
|
|
|
|
include/gsl/gsl_sort_long.h
|
|
|
|
include/gsl/gsl_sort_long_double.h
|
|
|
|
include/gsl/gsl_sort_short.h
|
|
|
|
include/gsl/gsl_sort_uchar.h
|
|
|
|
include/gsl/gsl_sort_uint.h
|
|
|
|
include/gsl/gsl_sort_ulong.h
|
|
|
|
include/gsl/gsl_sort_ushort.h
|
|
|
|
include/gsl/gsl_sort_vector.h
|
|
|
|
include/gsl/gsl_sort_vector_char.h
|
|
|
|
include/gsl/gsl_sort_vector_double.h
|
|
|
|
include/gsl/gsl_sort_vector_float.h
|
|
|
|
include/gsl/gsl_sort_vector_int.h
|
|
|
|
include/gsl/gsl_sort_vector_long.h
|
|
|
|
include/gsl/gsl_sort_vector_long_double.h
|
|
|
|
include/gsl/gsl_sort_vector_short.h
|
|
|
|
include/gsl/gsl_sort_vector_uchar.h
|
|
|
|
include/gsl/gsl_sort_vector_uint.h
|
|
|
|
include/gsl/gsl_sort_vector_ulong.h
|
|
|
|
include/gsl/gsl_sort_vector_ushort.h
|
|
|
|
include/gsl/gsl_specfunc.h
|
2001-07-05 20:04:50 +02:00
|
|
|
include/gsl/gsl_spline.h
|
2000-02-08 13:05:02 +01:00
|
|
|
include/gsl/gsl_statistics.h
|
|
|
|
include/gsl/gsl_statistics_char.h
|
|
|
|
include/gsl/gsl_statistics_double.h
|
|
|
|
include/gsl/gsl_statistics_float.h
|
|
|
|
include/gsl/gsl_statistics_int.h
|
|
|
|
include/gsl/gsl_statistics_long.h
|
|
|
|
include/gsl/gsl_statistics_long_double.h
|
|
|
|
include/gsl/gsl_statistics_short.h
|
|
|
|
include/gsl/gsl_statistics_uchar.h
|
|
|
|
include/gsl/gsl_statistics_uint.h
|
|
|
|
include/gsl/gsl_statistics_ulong.h
|
|
|
|
include/gsl/gsl_statistics_ushort.h
|
|
|
|
include/gsl/gsl_sum.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_sys.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_test.h
|
2003-02-17 02:01:38 +01:00
|
|
|
include/gsl/gsl_types.h
|
2001-03-28 23:49:41 +02:00
|
|
|
include/gsl/gsl_vector.h
|
|
|
|
include/gsl/gsl_vector_char.h
|
|
|
|
include/gsl/gsl_vector_complex.h
|
|
|
|
include/gsl/gsl_vector_complex_double.h
|
|
|
|
include/gsl/gsl_vector_complex_float.h
|
|
|
|
include/gsl/gsl_vector_complex_long_double.h
|
|
|
|
include/gsl/gsl_vector_double.h
|
|
|
|
include/gsl/gsl_vector_float.h
|
|
|
|
include/gsl/gsl_vector_int.h
|
|
|
|
include/gsl/gsl_vector_long.h
|
|
|
|
include/gsl/gsl_vector_long_double.h
|
|
|
|
include/gsl/gsl_vector_short.h
|
|
|
|
include/gsl/gsl_vector_uchar.h
|
|
|
|
include/gsl/gsl_vector_uint.h
|
|
|
|
include/gsl/gsl_vector_ulong.h
|
|
|
|
include/gsl/gsl_vector_ushort.h
|
2001-05-24 01:47:59 +02:00
|
|
|
include/gsl/gsl_version.h
|
Changes 1.6:
* Added a new wavelet directory, with 1-dimensional and 2-dimensional
discrete wavelet transforms.
* Added support for LQ and P^T LQ decompositions. To find the QR
decomposition of large systems (M>>N) use the LQ decomposition,
solving the transpose of the original system. This allows more
efficient memory access, and is useful for solving large least-squares
problems.
* Fixed a bug in the SYRK and HERK blas functions gsl_blas_{s,d,c,z}syrk
and gsl_blas_{c,z}herk which caused invalid memory access for non-square
matrices.
* Fixed a bug in gsl_swap_vectors which caused it to return incorrect
results when swapping vectors with different strides.
* Corrected the error estimate for gsl_cheb_eval_n_err to use
evaluation order instead of the approximation order.
* Improved the reliability of the gsl_sf_gamma_inc family of
functions.
* Equal abscissae are now handled gracefully in the cspline and
periodic cspline interpolations.
* Removed potential cancellation error in calculation of uniform
histogram ranges.
* Improved numerical stability of integration for akima and cspline
interpolation.
* Differential equation solvers now handle error codes returned from
user-defined functions.
* Improved error estimates in ode-initval solvers, and provide exact
derivatives on output. Added new semi-implicit ode-initval solver,
gsl_odeiv_step_rk2simp.
* Added missing function definition for gsl_sf_psi_1.
* Fixed the function gsl_sf_expint_Ei_scaled to call
gsl_sf_expint_Ei_scaled_e instead of gsl_sf_expint_Ei_e.
* Added cumulative distribution function for exponential power
distribution.
* The functions gsl_cdf_beta_P and gsl_cdf_beta_Q now return
consistent results of 0 or 1 for out of range values, x<0 and x>1,
rather than 0 for left and right tails simultaneously.
* The Jacobi eigensolvers gsl_eigen_jacobi and gsl_eigen_jacobi_invert
have new implementations from Golub and Van Loan.
* The standard output and standard error streams are now flushed by
the default error handler before the program aborts, in order to
ensure that error messages are properly displayed on some platforms.
2005-01-13 16:06:25 +01:00
|
|
|
include/gsl/gsl_wavelet.h
|
|
|
|
include/gsl/gsl_wavelet2d.h
|
2006-04-01 01:56:28 +02:00
|
|
|
info/gsl-ref.info
|
2001-03-28 23:49:41 +02:00
|
|
|
lib/libgsl.la
|
2001-05-24 01:47:59 +02:00
|
|
|
lib/libgslcblas.la
|
2001-11-22 13:58:40 +01:00
|
|
|
lib/pkgconfig/gsl.pc
|
2001-05-24 01:47:59 +02:00
|
|
|
man/man1/gsl-config.1
|
2001-11-22 13:58:40 +01:00
|
|
|
man/man1/gsl-histogram.1
|
|
|
|
man/man1/gsl-randist.1
|
2001-05-24 01:47:59 +02:00
|
|
|
man/man3/gsl.3
|
2001-03-28 23:49:41 +02:00
|
|
|
share/aclocal/gsl.m4
|