Welcome![Sign In][Sign Up]
Location:
Search - Cholesky

Search list

[Windows Develop矩阵所有运算

Description: 矩阵的转置、行列式、秩,逆矩阵求法,矩阵的三角分解、qr分解,对称正定矩阵的乔里斯基分解及行列式值,奇异值分解,广义逆的奇异值分解,矩阵特征值与特征向量的各种计算方法-all kinds of computational method of transposition of matrix, determinant, rank, inverse of matrix,triangle decomposition, qr decomposition, cholesky decomposition and determinant value based on symmetry positive definite matrix, decomposition of singular value, decomposition of generalized inversal singular value, eigenvalue and eigenvector
Platform: | Size: 83488 | Author: 球球 | Hits:

[Other resourcecholesky.cpp

Description: 用改进的乔里斯基方法解对称正定方程组,已被用于有限元正演模拟-Jiaolishiji Improved method for symmetric positive definite equations, have been used in finite element simulation FORWARD
Platform: | Size: 1441 | Author: 刘海飞 | Hits:

[Mathimatics-Numerical algorithmsVB_NUM1

Description: 用VB实现线性方程组的求解。包括:高斯消元法,LU分解法追赶法,迭代法,奇异值分解,乔累斯基分解法等12种数值方法。-VB of linear equations to solve. Including : Gaussian Elimination Act, the law catch up with the LU decomposition, iterative method, singular value decomposition, Joe Cholesky decomposition 12 species of numerical methods.
Platform: | Size: 7196 | Author: 李春波 | Hits:

[Other resource解线性方程的直接法

Description: 解线性方程的直接法:Gauss消去法、矩阵的三角分解、正定矩阵的Cholesky分解、矩阵求逆等。 注释见程序-solution of linear equations of the direct method : Gauss elimination method, the triangular matrix decomposition, Zhengding Cholesky decomposition of the matrix, such as matrix inversion. See Notes procedures
Platform: | Size: 24060 | Author: 周思良 | Hits:

[Other resourcecholesky323232

Description: 平均因子分解法,适用于正定矩阵First, let s recall the definition of the Cholesky decomposition: Given a symmetric positive definite square matrix X, the Cholesky decomposition of X is the factorization X=U U, where U is the square root matrix of X, and satisfies: (1) U U = X (2) U is upper triangular (that is, it has all zeros below the diagonal). It seems that the assumption of positive definiteness is necessary. Actually, it is \"positive definite\" which guarantees the existence of such kind of decomposition.
Platform: | Size: 2711 | Author: self | Hits:

[Other resourceulapack

Description: This collection of C++ templates wraps the FORTRAN or C interfaces for LAPACK so that they integrate with the Boost uBLAS library. Currently implements Cholesky decomposition, LU decomposition, inversion and determinant for general and positive-definite matrices. -This collection of templates wraps the C FOR RTRAN or C interfaces for LAPACK so that they int egrate with the Boost uBLAS library. Currently implements Cholesky decomposition. LU decomposition. inversion and determinant for general and posi tive - definite matrices.
Platform: | Size: 109523 | Author: sunxiaodian | Hits:

[Other resourceincompleteCholesky

Description: 程序简单实现了对稀疏矩阵进行incomplete Cholesky分解的功能,具有一定参考价值。-simple realization of the sparse matrix incomplete Cholesky decomposition of success can have a certain value.
Platform: | Size: 33171 | Author: 易江灯 | Hits:

[Other resourceVolterra

Description: 基于Cholesky分解的混沌时间序列Volterra预测-based on the Cholesky decomposition Volterra chaotic time series prediction
Platform: | Size: 85533 | Author: 四度 | Hits:

[Other resourcet2_3

Description: 本题采用的计算方法为:矩阵的 分解和Cholesky分解。根据Gauss消去法的的矩阵意义,可以将矩阵A分解为一个单位下三角矩阵与一个上三角矩阵的乘积即:即矩阵的LU分解A=LU,进而可以分解为: 的形式。当A为对称矩阵时,A可分解为: 的形式。-that the use of the method of calculating : matrix decomposition and Cholesky decomposition. According to the Gauss elimination of the matrix significance, A matrix can be decomposed into a unit lower triangular matrices and a triangular matrix on the product : that the matrix factorization A = LU, which can be decomposed as follows : form. When A symmetric matrix A can be divided into : form.
Platform: | Size: 1013 | Author: 王明明 | Hits:

[Otherchengxuzjf

Description: 实现矩阵的Cholesky分解,用Cholesky分解求ARMA模型的参数并作谱估计,利用分裂基算法求复序列 的DFT.将得到的 解卷绕,得到无跳变的相频特性.计算七类窗函数并给出归一化对数幅频曲线-achieve Matrix Cholesky decomposition, Cholesky decomposition used for ARMA model and the parameters for spectral estimation, the use of split-based algorithms for complex sequence of DFT. will be the unwrapped. be no change at the phase frequency characteristics. Calculation seven categories window function is given to one of several pieces of frequency curve
Platform: | Size: 6020 | Author: zhoujianfang | Hits:

[Otherzjf147

Description: 用来产生均匀分布或高斯分布的伪随机数 (近似白噪声),它们可具有不同的均值和方差。用REMEZ算法求交错点组。用Cholesky分解求ARMA模型的参数并作谱估计。求MA模型的参数 并估计功率谱。 用最小方差法估计序列 的功率谱。-used to produce uniform or Gaussian distribution of the pseudo-random number (similar to white noise). They may have a different mean and variance. Application of Remez algorithm used for staggered Point Group. Cholesky decomposition used for ARMA model and the parameters estimated for the spectrum. MA for the model parameters and the estimated power spectrum. With MVM sequence of the estimated power spectrum.
Platform: | Size: 5586 | Author: zhoujianfang | Hits:

[Mathimatics-Numerical algorithmsMARMACH

Description: 用Cholesky分解求ARMA模型的参数并作谱估计。
Platform: | Size: 3329 | Author: 张华 | Hits:

[Mathimatics-Numerical algorithmsMCHOLSK

Description: Subroutine MCHOLSK :To solves a hermitian positive definite set of complex linear simultaneous equations (AX=B) using the Cholesky decomposition method.
Platform: | Size: 2754 | Author: 张华 | Hits:

[Communication-MobileMCHOLSK

Description: 实现矩阵的Cholesky分解,这些程序是用C来编写的.
Platform: | Size: 1637 | Author: dh | Hits:

[Communication-MobileMARMACH

Description: 用Cholesky分解求ARMA模型的参数并作谱估计,这个程序是用C来实现的
Platform: | Size: 2212 | Author: dh | Hits:

[Other resourcesparsity

Description: This demonstration shows that reordering the rows and columns of a sparse matrix S can affect the time and storage required for a matrix operation such as factoring S into its Cholesky decomposition
Platform: | Size: 1767 | Author: 楚燕 | Hits:

[AlgorithmGS Cholesky

Description: GS迭代, Cholesky 分解 Givens方法,Householder 方法(Gs iteration cholesky decomposition)
Platform: | Size: 2048 | Author: Ferrytau | Hits:

[matlab矩阵的Cholesky分解的Matlab实现_杨蕊

Description: 介绍了矩阵的 Cholesky 分解算法,结合实例用 Matlab编程实现了矩阵的 Cholesky 分解.(In this paper, The algorithm of Cholesky decomposition for matrix was introduced, and the routine was brought into effect based on matlab according to instance.)
Platform: | Size: 32768 | Author: Effie | Hits:

[AlgorithmCholeskySqr

Description: calculate SLAU with Cholesky algorithm
Platform: | Size: 103424 | Author: madmax32 | Hits:

[matlabcholesky

Description: 乔列斯基分解的matlab程序,很基础很简单的一版(Cholesky's decomposed matlab program, a very basic and simple version)
Platform: | Size: 2048 | Author: 反对121 | Hits:
« 1 2 3 4 5 67 8 9 10 11 12 13 »

CodeBus www.codebus.net