📄 news
字号:
* What is new in gsl-1.6:** Added a new wavelet directory, with 1-dimensional and 2-dimensionaldiscrete wavelet transforms.** Added support for LQ and P^T LQ decompositions. To find the QRdecomposition of large systems (M>>N) use the LQ decomposition,solving the transpose of the original system. This allows moreefficient memory access, and is useful for solving large least-squaresproblems.** 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 incorrectresults when swapping vectors with different strides.** Corrected the error estimate for gsl_cheb_eval_n_err to useevaluation order instead of the approximation order.** Improved the reliability of the gsl_sf_gamma_inc family offunctions.** Equal abscissae are now handled gracefully in the cspline andperiodic cspline interpolations.** Removed potential cancellation error in calculation of uniformhistogram ranges.** Improved numerical stability of integration for akima and csplineinterpolation.** Differential equation solvers now handle error codes returned fromuser-defined functions.** Improved error estimates in ode-initval solvers, and provide exactderivatives 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 callgsl_sf_expint_Ei_scaled_e instead of gsl_sf_expint_Ei_e.** Added cumulative distribution function for exponential powerdistribution.** The functions gsl_cdf_beta_P and gsl_cdf_beta_Q now returnconsistent 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 bythe default error handler before the program aborts, in order toensure that error messages are properly displayed on some platforms.* What was new in gsl-1.5:** Multifit routines now handle iterations where |f| is alreadyminimised to zero, without division by zero.** Fixed the singular value tolerance test in the multifit covariancecalculation from < to <= to match the original MINPACK code.** The macro HAVE_INLINE is now tested with #ifdef instead of #if asin versions prior to 1.4, to match the documentation, and the macroGSL_RANGE_CHECK_OFF now works correctly. An alternative macroGSL_RANGE_CHECK={0,1} can be used to control range-checking.** Fixed a potential array overflow in gsl_ran_landau.** Fixed a small discrepancy in the tolerance calculation of theone-dimensional brent minimiser.** Numerical derivatives should now be calculated using thegsl_deriv_forward, gsl_deriv_central and gsl_deriv_backward functions,which accept a step-size argument in addition to the position x. Theoriginal gsl_diff functions (without the step-size) are deprecated.** Corrected documentation for gsl_ran_hypergeometric_pdf()** 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 reporterrors, instead of simply returning an error code. The arguments tothese functions must now use exact lengths with no additionalelements. For cyclic systems all vectors must be of length N, fortridiagonal systems the offdiagonal elements must be of length N-1.** The singular value decomposition routines gsl_linalg_SV_decomp andgsl_linalg_SV_decomp_mod now handle the SVD of a column vector (N=1,arbitrary M), which can occur in linear fitting.** Restored missing header files gsl_const_mks.h and gsl_const_cgs.h.The incorrect values of the electrical units for gsl_const_cgs(VACUUM_PERMEABILITY and VACUUM_PERMITTIVITY) have been removed.** Fixed gsl_linalg_SV_decomp() to avoid an infinite loop whencomputing the SVD of matrices containing Inf and Nan.** Fixed gsl_linalg_balance_columns() to avoid an infinite loop whenrescaling matrices containing Inf and NaN.** Fixed header file <gsl/gsl_sf_log.h> to include declarations for error codes in inline versions of gsl_sf_log functions** Fixed header file <gsl/gsl_const.h> to include new MKSA and CGSMheader files.** Added Stefan-Boltzmann constant and Thomson cross section tophysical constants* What was new in gsl-1.4:** Added cumulative distribution functions and their inverses for thecontinuous 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 rejectionalgorithm, in the function gsl_randist_binomial_tpe.** Added new functions gsl_rng_fwrite and gsl_rnd_fread for storingthe state of random number generators in a file.** Added a new function gsl_combination_memcpy()** Corrected values of electrical constants in CGS units. To takeaccount of different electrical systems of units the values are nowprefixed by GSL_CONST_MKSA (for the SI Metre, Kilogram, Second, Amperesystem) or GSL_CONST_CGSM (for the Centimetre, Gram, Second, Magneticsystem with the Gauss as the fundamental unit of magnetic fieldstrength). The previous GSL_CONST_MKS and GSL_CONST_CGS prefixes havebeen removed, as have the permeability and permittivity constants inthe 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 returnincorrect results. Minor corrections were made to the parameters inthe other Knuth generators borosh13, coveyou, fishman20, lecuyer21,and waterman14.** Fixed a missing transpose bug in the gsl_linalg_QR_QRsolveand gsl_linalg_QRPT_QRsolve routines which were computing thesolution to Q^T R x = b instead of Q R x = b.** Fixed gsl_sf_gammainv to return zero instead of a domainerror for arguments corresponding to singularities in gamma.** Fixed a bug in the simplex minimization algorithm whichcaused it to fail to find the second highest point correctlywhen searching the set of simplex points.** Fixed a bug in the conjugate gradient minimizers conjugate_pr,conjugate_fr and vector_bgfs which caused the searchdirections to be updated incorrectly.** Fixed a bug in gsl_sf_psi_1_int(1) which caused it toreturn the incorrect sign for psi(1,1).** Fixed the simulated annealing routine gsl_siman_solve to use theparameter iters_fixed_T for the number of iterations at fixedtemperature instead of n_tries.** Fixed a bug in gsl_combination_valid which caused it to return theincorrect status.** Fixed a bug in gsl_permutation_canonical_to_linear which caused theoutput to always be zero, and the input permutation to be incorrectlyreplaced by the output.** Fixed a bug is gsl_ran_discrete which could cause uninitialiseddata 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 couldallow the singularity to fall on an interval boundary, leading todivision by zero.** Improved gsl_sf_gamma_inc_P(a,x) to avoid a domain error for x<<awhen a>10.** Improved the accuracy of gsl_sf_coupling_3j for large arguments.** Improved the performance of gsl_sf_choose(m,n) by separating thecalculations for small and large arguments.** On platforms without IEEE comparisons gsl_{isnan,isinf,finite} willfall back to the system versions of isnan, isinf and finite ifavailable.** gsl_linalg_householder_hv now uses BLAS routines internally** The script configure.in is now compatible with autoconf-2.50 andlater.** Reduced the memory usage of the multifit algorithms from MxM to MxNfor large M by performing the QR decomposition of the Jacobianin-place.** IEEE modes now use the C99 fenv.h functions when platform spectificfunctions are not available.* What was new in gsl-1.3:** Changed interface for gsl_sf_coupling_6j...(...). The old functionsactually calculated 6j for a permutation of the arguments (thatrelated to Racah W). This was incorrect and not consistent withthe documentation. The new versions calculate < {a,b,c}, {d,e,f} >,as stated in the documentation. The old versions are still availableas gsl_sf_coupling_6j_INCORRECT...(...), though they are deprecatedand will be removed at some point in the future.** Added new functions for computing Em(x)=exp(-x)*Ei(x), the modified(scaled) form of the exponential integral, gsl_sf_expint_E1_scaled,gsl_sf_expint_E2_scaled, gsl_sf_expint_Ei_scaled. ** Fixed compilation problems with gcc -ansi and other ANSI compilers.** Fixed uninitialized memory access in the Niederreiter quasi-randomnumber generator.** Fixed the eigenvalue routines to prevent an infinite loop for Infor NaN entries in matrix.** Fixed a bug in the multifit and multiroots allocation routineswhich cause them to fail to report some out of memory conditions.** Fixed a bug in the seeding for the random number generatorgsl_rng_taus2 which affected a small number of seeds.** Modified the complex householder transforms to avoid division byzero, which could cause NaNs to be returned by the gsl_eigen_hermveigenvalue decomposition.** The Nelder-Mead simplex algorithm for multidimensional minimisation has been added.** The random number distributions now include the Dirichlet andMultinomial distributions.** Added a new function gsl_fcmp for approximate comparison offloating point numbers using Knuth's algorithm.** Added new functions gsl_ldexp and gsl_frexp as portablealternatives to ldexp() and frexp().** Fixed a bug in gsl_linalg_bidiag_unpack_B which was returningincorrect results for the superdiagonal.** Fixed a bug in the acceptance condition for simulated annealing** Ordinary differential equations can now be solved using a differentabsolute error for each component with gsl_odeiv_control_scaled_new().** Upgraded to libtool-1.4.3* What was new in gsl-1.2:** Added new functions for combining permutations, converting betweencyclic and linear representations, and counting cycles and inversions.** New multiroot functions now allow access to the current values of fand dx.** The default error handler now outputs a explanatory message beforeaborting.** Extended gsl_linalg_SV_decomp to handle exact zeroes in thesingular values, and added tests for 3x3 matrices.** Fixed a bug in gsl_linalg_SV_decomp which caused singular values tobe sorted incorrectly.** Fixed a bug in gsl_linalg_solv_symm_cyc_tridiag which caused it toproduce incorrect results.** Added nonsymmetric tridiagonal solvers gsl_linalg_solve_tridiag andgsl_linalg_solve_cyc_tridiag.** The declarations used to export static objects can now becontrolled through a macro GSL_VAR and the header file<gsl/gsl_types.h>.
⌨️ 快捷键说明
复制代码
Ctrl + C
搜索代码
Ctrl + F
全屏模式
F11
切换主题
Ctrl + Shift + D
显示快捷键
?
增大字号
Ctrl + =
减小字号
Ctrl + -