CDN加速镜像 | 设为首页 | 加入收藏夹
当前位置: 首页 资源下载 搜索资源 - solve linear equations

搜索资源列表

  1. mJacobi

    0下载:
  2. The matlab code is designed to solve linear systems of equations using the Jacobi Method.
  3. 所属分类:matlab

    • 发布日期:2017-11-30
    • 文件大小:1150
    • 提供者:Mircea
  1. MxN-Gauss-elimination

    0下载:
  2. 解决MxN阶线性方程组,采用高斯消元法,可显示无解,一解和多解结果。-Solve the MxN-order linear equations using Gaussian elimination can be no solution, one solution, and the results of the multiple solutions.
  3. 所属分类:Other systems

    • 发布日期:2017-11-25
    • 文件大小:1292
    • 提供者:zhangran
  1. RK4

    0下载:
  2. RK4演算法,可用於解決線性及非線性微分方程-RK4 algorithm can be used to solve linear and non-linear differential equations
  3. 所属分类:Algorithm

    • 发布日期:2017-11-16
    • 文件大小:997
    • 提供者:張仁宗
  1. LU

    0下载:
  2. 运用LU分解法来解线性方程组 可以改变N 来解N阶线性方程-N to solve N linear equations using LU decomposition method for solving linear equations can be changed
  3. 所属分类:assembly language

    • 发布日期:2017-11-24
    • 文件大小:652
    • 提供者:李家骐
  1. Nonlinear-equations-to-solve

    0下载:
  2. 本例是matlab算法实例,利用matlab实现非线性方程求解。-Using matlab to achieve a non-linear equation solver
  3. 所属分类:matlab

    • 发布日期:2017-11-15
    • 文件大小:13298
    • 提供者:朱真真
  1. fem_3node

    0下载:
  2. 三节点有限元方法的计算,劲度矩阵式12*12的,可以有效求解出结点位移,结点应力,求解线性方程组方法简单-Three-node finite element method calculation stiffness matrix 12* 12, can effectively solve the nodal displacements, nodal stresses, simple method for solving linear equations
  3. 所属分类:software engineering

    • 发布日期:2017-11-25
    • 文件大小:9172
    • 提供者:小麦
  1. matlab

    0下载:
  2. 误差的来源 非线性方程(组)的数值解法 解线性方程组的直接方法 解线性方程组的迭代法 矩阵的特征值与特征向量的计算 函数的插值方法 函数逼近与曲线(面)拟合 数值微分 数常微分方程(组)求解值积分 -The source of the error Numerical method for solving the nonlinear equation (group) The direct method of solving linear
  3. 所属分类:File Formats

    • 发布日期:2017-11-08
    • 文件大小:1071502
    • 提供者:陈佳文
  1. gauss

    0下载:
  2. solve linear system of equations using gau-solve linear system of equations using gauss
  3. 所属分类:MPI

    • 发布日期:2017-12-03
    • 文件大小:2632
    • 提供者:arrow
  1. THOMAS

    0下载:
  2. 调用THOMAS函数求解三对角矩阵线性方程组-solve tridiagonal matrices of linear equations with THOMAS function
  3. 所属分类:Energy industry

    • 发布日期:2017-11-26
    • 文件大小:15865
    • 提供者:就个零
  1. GAUSSJ

    0下载:
  2. 线性方程组的解法 全主元高斯-约当(Gauss-Jordan)消去法 用高斯-约当消去法求解A[XY]=[BI],其中A为n*n非奇异矩阵,B为n*m矩阵,均已知;X(n*m),Y(n*n)未知。-Solution of linear equations the main yuan Gaussian- Jordan (Gauss-Jordan) elimination method Gauss- Jordan elimination method to solve A [XY] = [B
  3. 所属分类:Algorithm

    • 发布日期:2017-03-31
    • 文件大小:629
    • 提供者:han
  1. RCS

    0下载:
  2. 本文利用Ping-Liang Rui,Ru-Shan Chen提出的一种基于多层快速多极子(MLFMA)谱域两步预处理方法,来求解在单站RCS计算时产生的有多个右边项的大型线性方程组。-In this paper, Ping-Liang Rui, Ru-Shan Chen proposed based on multilevel fast multipole (MLFMA) spectral-domain two-step pretreatment method to solve the mon
  3. 所属分类:matlab

    • 发布日期:2017-04-04
    • 文件大小:601803
    • 提供者:yangkai
  1. conjgradmethod

    0下载:
  2. 共轭梯度法(Conjugate Gradient)是介于最速下降法与牛顿法之间的一个方法,它仅需利用一阶导数信息,但克服了最速下降法收敛慢的缺点,又避免了牛顿法需要存储和计算Hesse矩阵并求逆的缺点,共轭梯度法不仅是解决大型线性方程组最有用的方法之一,也是解大型非线性最优化最有效的算法之一。这里给出共轭梯度法的源程序-Conjugate gradient method (Conjugate Gradient) is between the steepest descent method and
  3. 所属分类:matlab

    • 发布日期:2017-03-30
    • 文件大小:1059
    • 提供者:lucy
  1. bycgste

    0下载:
  2. 共轭梯度法(Conjugate Gradient)是介于最速下降法与牛顿法之间的一个方法,它仅需利用一阶导数信息,但克服了最速下降法收敛慢的缺点,又避免了牛顿法需要存储和计算Hesse矩阵并求逆的缺点,共轭梯度法不仅是解决大型线性方程组最有用的方法之一,也是解大型非线性最优化最有效的算法之一-Conjugate gradient method (Conjugate Gradient) is between the steepest descent method and Newton' s
  3. 所属分类:Algorithm

    • 发布日期:2017-04-13
    • 文件大小:2302
    • 提供者:wangwenshu
  1. code

    0下载:
  2. matlab 程序代码 线性系统 龙格库塔法 可以解微分方程-matlab code linear system can solve differential equations Runge-Kutta method
  3. 所属分类:Other systems

    • 发布日期:2017-04-11
    • 文件大小:1380
    • 提供者:张敏敏
  1. Seidel

    0下载:
  2. Seidel算法解方程组,用于对线性方程组进行迭代求解初值可任选-Seidel algorithm for solving equations, linear equations used to iteratively solve initial value may be optionally
  3. 所属分类:Algorithm

    • 发布日期:2017-04-03
    • 文件大小:1055
    • 提供者:何金水
  1. dc

    0下载:
  2. DC Defect Correction Method. X = DC(A,B) attempts to solve the system of linear equations A*X = B for X. The N-by-N coefficient matrix A must be square and the right hand side column vector B must have length This uses the defect correctio
  3. 所属分类:matlab

    • 发布日期:2017-04-15
    • 文件大小:6049
    • 提供者:elbarmoh
  1. Gauss-Sedeil

    0下载:
  2. 次程序是用MATLAB语言编写的高斯赛德尔迭代法,可用于求解线性微分方程组。-Second procedure is used MATLAB language high Sisaideer iterative method can be used to solve linear differential equations.
  3. 所属分类:matlab

    • 发布日期:2017-04-17
    • 文件大小:126863
    • 提供者:黄智谦
  1. resolution_Lu

    0下载:
  2. In linear algebra, LU decomposition (where LU stands for Lower Upper , and also called LU factorization) factors a matrix as the product of a lower triangular matrix and an upper triangular matrix. The product sometimes includes a permutation matrix
  3. 所属分类:Algorithm

    • 发布日期:2017-04-16
    • 文件大小:20140
    • 提供者:zineb24
  1. Gaussian-elimination

    0下载:
  2. 对给定的线性方程组采用高斯消元法进行求解,可以给定方程阶数-For a given set of linear equations using Gaussian elimination method to solve, you can order a given equation
  3. 所属分类:Algorithm

    • 发布日期:2017-04-15
    • 文件大小:5998
    • 提供者:limin
  1. Jacobi---intrative-mehtod

    0下载:
  2. 解线性方程组,从初始向量X(o)开始逐渐收敛于真值X*-solve the system of linear equations,the program begin with the initial vector and converge to true value gradually.
  3. 所属分类:Algorithm

    • 发布日期:2017-04-11
    • 文件大小:1058
    • 提供者:李颖飞
« 1 2 ... 6 7 8 9 10 1112 13 14 15 16 17 »
搜珍网 www.dssz.com