⭐ 欢迎来到虫虫下载站! | 📦 资源下载 📁 资源专辑 ℹ️ 关于我们
⭐ 虫虫下载站

📄 math.readme

📁 basic median filter simulation
💻 README
字号:
Math and Statistics pro/math                             Dec 2007_________      This directory contains IDL mathematics and statistics proceduresthought to be of interest in astronomy.    Fifteen of the procedures,are adapted from algorithms in "Numerical Recipes 2nd Edition" by Press, Flannery,Teukolsky, and Vetterling (1992, Cambridge University Press).    These procedures are marked below with an "NR"     The FORTRAN procedure names in "Numerical Recipes" are limited to 6 characters, and in some cases (e.g. MINF_PARABOLIC for BRENT) we havechosen more descriptive names for the equivalent IDL procedure.     Eight procedures (e.g. linmix_err.pro)  were supplied by Brandon Kelly (U.of Arizona) as part of Bayesian approach to linear regression(astro-ph/0705.2774)    Additional IDL mathematics and statistics procedures developed byHenry Freudenreich (Hughes STX) are available in the contrib/freudenreichdirectory.    These include procedures for LOWESS smoothing, robust fitting,bootstrap errors, and fitting to a plane.    Also note the following mathematics procedures available at CraigMarkwardt's site ( http://astrog.physics.wisc.edu/~craigm/idl/math.html )CHEBFIT - Fit Chebyshev polynomial coefficients to a tabulated function  CHEBEVAL - Evaluate a Chebyshev polynomial on an interval, given the coefficients  CHEBCOEF - Estimate Chebyshev polynomial coefficients of a function on an interval MCHOLDC - Modified Cholesky Factorization of a Symmetric Matrix QPINT1D -  One dimensional numerical adaptive integration of IDL function or expression ---------ASINH() - Return the inverse hyperbolic sine of its argumentAVG() - Return the average value of an array or 1 dimension of an array.CIC - Cloud In Cell interpolation of irregularly gridded dataCSPLINE() - Interpolate using the Numerical Recipes natural cubic splineFACTOR - Find the prime factors of a given number (in /jhuapl)FITEXY - Best straight-line fit to data with errors in both coordinatesFLEGENDRE() - Compute the first M terms in a Legendre polynomial expansionGAUSSIAN() - Evaluate a 1-d Gaussian and optionally its derivativeHERMITE() - Interpolate a tabulated function using a Hermite splineKSONE -  Compute the one-sided Kolmogorov-Smirnov statisticKSTWO -  Compute the two-sided Kolmogorov-Smirnov statisticKUIPERONE - Compute the one-sided Kuiper statistic (NR)KUIPERTWO - Compute the two-sided Kuiper statistic (NR)LINMIX_ERR - Bayesian approach to linear regression with errors in both X and YLINTERP - Linearly interpolate X,Y vectors onto a new X grid      MEANCLIP - Compute an iteratively sigma-clipped mean on a data setMLINMIX_ERR : Bayesian approach to linear regression with errors in both X and Y and multiple independent variables.MINF_BRACKET - Find 3 points which bracket the minimum of a functionMINF_CONJ_GRAD - Find local minimum of a scalar valued function of several        variables using conjugate gradient method MINF_PARABOLIC - Minimize a function using Brent's method with parabolic interpolation MINF_PARABOL_D - Minimize a function using Brent's method with derivativesMLINMIX_ERR : Bayesian approach to linear regression with errors in both X and Y and multiple independent variables.MRANDOMN : Generate random vectors from a multivariate normal density.MULTINOM - Simulate multinomial random variablesNGP - Nearest Grid Point interpolation of irregularly gridded dataPCA - Perform a principal component analysis (Karhunen-Loeve expansion)PENT() - Return the information entropy S of time-series data for a set of trial periodsPOIDEV() - Generate a Poisson random deviate POLINT - Polynomial interpolation of an (X,Y) pair POLYLEG() - Evaluate a Legendre polynomial with specified coefficientsPOLY_SMOOTH() - Apply a least-squares (Savitzky-Golay) polynomial smoothing filterPRIME - Return the first N primes (in /jhuapl)PROB_KS - Return the significance of a Kolmogorov-Smirnov statisticPROB_KUIPER - Return the significance of the Kuiper statistic QSIMP - Integrate using Simpson's rule to specified accuracyQTRAP - Integrate using trapezoidal rule to specified accuracy.  QUADTERP - Quadratic interpolation of X,Y vectors onto a new X gridRANDOMCHI - Generate chi-square distributed random variablesRANDOMDIR - Generate Dirichlet-distributed random variablesRANDOMGAM - Generate random numbers from a gamma distribution.RANDOMP - Create a vector of random numbers distributed as a power-lawRANDOMWISH - Draw random matrices from a Wishart distributionSIXLIN - Compute linear regression by 6 different methods.SPLINE_SMOOTH - Compute cubic smoothing spline to (weighted) dataTABINV - Find the effective index of a function value.                          TRANSFORM_COEFF() - Compute new polynomial coeffficients under a linear transformation TRAPZD - Compute Nth iteration of trapezoidal rule.  Called by QSIMP, QTRAPTSC - Triangular Shaped Cloud interpolation of irregularly gridded data onto a regular gridTSUM() - Trapezoidal integration of the area under a curveZBRENT() - Find the root of a function known to lie between specified limits----------------------A listing of intrinsic IDL mathematics routines is available at http://idlastro.gsfc.nasa.gov/idl_html_help/mathematics_funt_list.htmlIn particular, note the following intrinsic "Numerical Recipes"  proceduresAMOEBA - Multidimensional minimization of a function via downhill simplex methodBETA   - beta functionBROYDEN - Solve a system of n nonlinear equations in n dimensions (broydn)CHOLDC - Cholesky decompositionCHOLSOL - Cholesky backsubstitution (cholsl)DFPMIN - minimize a user-written function of two or more independent variablesELMHES - Reduce a matrix to upper Hessenberg formEXPINT - exponential integral EnFULSTR - Restore a row-indexed sparse matrix to full storage mode FZ_ROOTS - Roots of a polynomial by Laguerre's method with deflation (zroots)HQR    - eigenvalue of an Hessenberg matrixINVERT - Invert a matrix using Gaussian elimination methodsLADFIT - Fit a straight line by minimizing absolute deviation (medfit)LEGENDRE - Return the value of the associated Legendre polynomial (plgndr)LINBCG - Solve N linear equation in N unknowns using biconjugate gradient	method LMFIT - Nonlinear least-squares fit using Levenberg-Marquardt algorithm (mrqmin)LNP_TEST - Lomb Normalized Periodogram of two sample populations (fasper)LUSOL - linear equation solution, backsubstitution (lubksb)LUDC - linear equation solution, LU decomposition (ludcmp)LUMPROVE - linear equation solution, iterative improvement (mprove)MACHAR - diagnose computer's floating arithmeticNEWTON   - globally convergent multi-dimensional Newton's method (newt)POWELL - minimize a function of N variables using the Powell method QROMB  - integrate using Romberg adaptive methodQROMO  - integrate using open Romberg adaptive methodQSIMP  - integrate using Simpson's ruleR_CORRELATE - compute Spearman's (rho) or Kendalls's (tau) rank correlation(spear & kendl1)RK4    - integrate one step of ODEs, fourth-order Runge-Kutta SAVGOL - Compute Savitsky-Golay polynomial smoothing coefficients SIMPLEX - Use the Simplex method to solve linear programming problems SPL_INIT - construct a cubic spline (spline)SPL_INTERP - cubic spline interpolation (splint)SPRSAB - Multiply two row-indexed sparse matrices (sprstm)SPRSAX - Multiply a row-indexed sparse matrix by an N-element vector SPRSIN - Convert a matrix to row-indexed sparse matrix mode SVDC    - singular value decomposition of a matrix (svdcmp)SVDFIT - General least-square fit with optional error estimates SVSOL - Solve simultaneous linear equations via back-substitution (svbksb)TRIQL   - eigensolution of a symmetric tridiagonal matrix (tqli)TRIRED  - Householder reduction of a real, symmetric matrix (tred2)TRISOL  - solution of tridiagonal systems (tridag)VALUE_LOCATE - find effective index of a function value (locate)WTN    - multi-dimensional discrete wavelet transform

⌨️ 快捷键说明

复制代码 Ctrl + C
搜索代码 Ctrl + F
全屏模式 F11
切换主题 Ctrl + Shift + D
显示快捷键 ?
增大字号 Ctrl + =
减小字号 Ctrl + -