搜索资源列表
para
- 抛物线法求解 方程的构造方法:给出[0,1]区间上的随机数(服从均匀分布)作为方程的根p*. 设你的班级数为a3,学号的后两位数分别为a2与a1,从而得到你的三次方程 例如:你的31班的12号,则你的方程是21x3+60x2+2x+a0=0的形式. 方程中的系数a0由你得到的根p*来确定. -parabolic equation method Construction Methods : given interval [0,1] on the random numbe
hypot
- 抛物线法求解 方程的构造方法:给出[0,1]区间上的随机数(服从均匀分布)作为方程的根p*. 设你的班级数为a3,学号的后两位数分别为a2与a1,从而得到你的三次方程 例如:你的31班的12号,则你的方程是21x3+60x2+2x+a0=0的形式. 方程中的系数a0由你得到的根p*来确定. -parabolic equation method Construction Methods : given interval [0,1] on the random numbe
solution-of-Partial-differential-equation
- “解边值问题的松弛法”(SOR)(Chebyshev absolution)和“交替方向隐式方法”(ADI) (此两种解法均针对解椭圆形方程所用到的方法)-"solution to the boundary value problems relaxation method" (SOR) (Chebyshev Absolution) and "alternating direction implicit method" (ADI) (these two
zhouqi_new
- 追赶法解周期性方程 输入:a[],b[],c[],x[] 输出:求解结果X在x[]中-chased cyclical equation method of input : a [], [] b, c [] [] x output : Results for the X x []
DEFFIRENTIAL-EQUATION
- 用LAPLACE方法求解多维沃尔泰拉方程,此处为一个变元的方程,由于该方程同时含有微分和积分,一般求解有一定的困难。此处为MATHEMAICAL程序-used method for multiple preoperational Ertaila equation here as a variable element of the equation, As the same time contain differential equations and integral, the general
预测
- 数据预测算法,主要是一元n次方程的回归预测实现。* 预测分析--本算法只适用于有明显线性趋势的数据 * 默认为一元二次曲线方程法 * * 本程序主要涉及有两个算法 * 1.用最小二乘原理找到线性方程组的系数和常数。 * 2.解线性方程组 * 本程序在解线性方程组中,由于考虑到收敛性问题未采用迭代法,而是采用Gauss-Jordan消去法来解决。-data prediction algorithm is mainly one yuan n equation forecast to achieve
EFIE.rar
- 矩量法解电场双位方程求线天线表面电流分布,方向图及辐射阻抗,Moment Method Solution of the electric field equation for a double-wire antenna surface current distribution, radiation pattern and impedance
fem2d_poisson_linear.rar
- 用有限元方法求解二维泊松方程的FORTRAN90 程序,适合有限元初学者掌握有限元方法编程技巧!,FEM2D_POISSON_LINEAR is a FORTRAN90 program which solves the 2D Poisson equation using the finite element method with piecewise linear triangular elements.
danxiang
- 单端故障解二次方程法算法,结合PSCAD使用,得到故障测距距离-Single-ended fault solution algorithm quadratic equation method, combined with PSCAD used by fault location distance
Shooting-Schrodinger-equation
- 打靶法解薛定谔方程利用matlab软件,采用打靶法结合Numerov算法进行求解定态薛定谔方程的本征值和本征方程。在位势为不同的抛物势时,都能求解出符合精度要求的本征值和本征方程。-Shooting method to solve the Schrodinger equation using matlab software, using the shooting method combined Numerov algorithm to solve the steady-state Schrodi
sola_vof
- SOLA-VOF program solving Navier-Stokes equation with free surface by volume of fluid method
equation
- 分别用高斯消去法,三角分解法,Jacobi迭代法,GS迭代法,SOR迭代法求解Ax=b-Separately using Gaussian elimination, triangular decomposition, Jacobi iterative method, GS iterative method, SOR iterative method for solving Ax = b
RAM_Parabolic_Equation_Code
- 抛物线方程法计算水声远场传播损失仿真代码-Parabolic equation method to calculate the far field of underwater acoustic transmission loss simulation code
M
- 利用速率方程的方法,对VCSOA放大器的增益特性进行模拟仿真,-Using rate equation method, VCSOA amplifier gain characteristics of simulation
Method_of_Moments
- 基于pocklington方程和hallen方程的矩量法求解线天线电流分布和方向图-Based pocklington equation and hallen equation method of moments current distribution and antenna pattern
3D-Wave-equation-Model-forwarding--by-the-method-
- 3D Wave equation Model forwarding by the method of pesudo-spectrum-3D Wave equation Model forwarding by the method of pesudo-spectrum
least-square-method-using-c-language
- 该程序通过依次输入已知点个数n,输入已知点的X坐标,输入已知点的Y坐标直接得到经最小二乘法拟合得到的一元线性方程。-The procedure followed by the number of known points in the input n, enter the coordinates of a known point X, Y coordinates of a known point input directly from the least squares fitted by a
Shooting method
- Solve second order boundary condition differential equation using shooting method
Split Step Fourier Method
- This M-File solves Nonlinear schrodinger equation and display the results in 3d graphics along with it the Pulse broadening ratio and phase shift has also been calculated and displayed
常微分方程的初值问题
- 常微分方程初值问题的matlab计算方法代码(The calculation method of initial value problem of ordinary differential equation)