搜索资源列表
KrigingInterpolation
- Kriging 插值程序,实现二维三维数据插值 Makefile_hp700 Makefile_ibm6000 kriging.mdf kriging.c outboard.c inv_m.tar.gz The inverse matrix source codes which got from Netlib. f2c.tar.gz The head file and library which are used to inverse matrix sou
Crank-Nicolson_
- C-N解偏微分方程的程序。解的是定步长的抛物型偏微分方程: du/dx - a * d2u/dx2 = 0 在程序中可以更改 a 的值以实现不同系数的解。在循环中改变 a 的值以实现变系数. 该说明在压缩包是也有
有限元一维C++源码
- 本程序写出了一个完整的一维有限元程序算列,列子如下 d^2u/dx^2=sin(x); u(0)=0,du(1)=0. u=sin(x);区间[0,2*pi].
femod1
- FEMOD1 is an interactive program for the setup, solution, and printout of a two point boundary value problem in a one dimensional region. The finite element method is used. The differential equation has the form: -d/dX ( K(X) dU/dX ) + C(
sijielonggekutafajieyijiechangweifenfangcheng
- 本程序是用Visual Biasic 实现用四阶龙格-库塔方法对一阶常微分方程(其通式为dy/dx=m-qx(m,q为常数))求解,并用点表示出各函数值在坐标轴上的位置。 龙格-库塔(Runge-Kutta)方法是一种高精度的单步法,比欧拉格式更精确,它采用了间接使用泰勒级数的技术。他既保留了泰勒公式的精度高的特点又避免过多的计算导数值。他是有泰勒公式推倒出的,因此它要求所求的解应具有较好的光滑性。 坐标表示其位置,这样可以直观的看出不用微分方程解的位置以及它们的联系。 -This
_fsimpfun@20_RK4fun@28
- 在vb/vc中调用mathlualib.dll中的自定义API计算一些泛函的值,如计算定积分∫[a->b]f(x)dx,计算数项级数∑[n=1->100]f(n)≈∑[n=1->+∞]f(n),计算函数项级数∑[n=1->100]f(n,x)≈∑[n=1->+∞]f(n,x),计算一阶ODEy =fsxy(x,y),y(x_0)=y_0中的y(x),……泛函的自变量在Lua文件里面输入。注意:请不要改变Lua中的函数名fun(x),fan(n),fsx(x),fan
DXSFitting
- C++实现多项式拟合计算, y=a+bx+cx^2+dx^3,给出n对x,y值后,得出abcd值,以后给出x的值,自动计算y的值-C++ implementation polynomial fitting calculation, y = a+ bx+ cx ^ 2+ dx ^ 3, n is given on the x, y values, results in abcd value that is given after the value of x, y values
jisuan
- 用复化梯形公式和复化辛卜生公式计算积分 I_1 (f)=∫_0^(π/2)?√(1+cos^2?x ) dx和I_2 (f)=∫_0^(π/2)?〖tan?x/x dx〗 观察n为多少时,所得近似值有6位有效数字。 -Compound trapezoid formula and complexification Xinbo Health formula calculated integral I_1 (f) = ∫ _0 ^ (π/2) ? √ (1+cos ^ 2 ? x) dx
fdtd2D
- This MATLAB M-file implements the finite-difference time-domain solution of Maxwell s curl equations over a two-dimensional Cartesian space lattice comprised of uniform square grid cells. To illustrate the algorithm, a 6-cm-diameter metal cylindric
Numerical-analysis4
- 对下面每个定积分,构造(手工计算)一个3行的龙贝格表。 (1)∫(0,3)sin(2x)/(1+x^2)dx=0.4761463020… (2)∫(0,3)sin(4x)e^(-2x)dx=0.1997146621… (3)∫(0.04,1)1/x^(1/2)dx=1.6 (4)∫(0,2)1/(x^2+1/10)dx=4.4713993943… (5)∫(1/(2π),2)sin(1/x)dx=1.1140744942… (6)∫(0,2)(4-x^2)^(1/2
Solvers
- 求解器方程 BisectionZero.m 使用二分法求解方程的过零点; LEPDS.m 求解方程ax = b,a为正定对称矩阵; ModNewt 给定微分,求解方程f(x) = 0; NLEqSolver.m 使用牛顿法求解方程; NLEqSolverWrapper.m 使用不同的初值调用牛顿法解方程; NewtRaph.m 方程只有一个根时,给定df(x)/dx信息,求解方程f(x) = 0。乳菇婆有多个根,x应该在根附近。- Math/Solver
F3
- 计算各断面在各吃水﹑各横摇角状态下附加质量对吃水之斜率(dy.out)以 及对横摇角之斜率(dx.out)。-Calculated for each section in each draft ﹑ each roll angle of the slope of the draft status of the additional mass (dy.out) and the roll angle of the slope (dx.out).
FunctionGenerator.pl
- 使用perl程序生成一组复杂的常微分方程组。这组常微分方程组具有固定的格式,常用于基因调控网络。-#generate ODEs plain txt #the ODEs has the form dx/dt -x+vm*A/(K+A)/[vm*(K+I)], where A sum(a^n)
最小二乘法拟合
- %最小二乘法下用a*sin(x)+b*cos(x)拟合下列散点坐标 %求出拟合系数a,b和方差Dx(The least square method is used to fit the following scatter coordinates with a*sin (x) +b*cos (x) The fitting coefficients a, B and variance Dx were calculated)
functionequation
- 求解微风方程边界条件限制下的解。解一个方程组, du/dx+dv/dx=0 u=dn/dx v=-dm/dx du/dx=-exp(-x)+n*m/(m+n) 边界条件和初值条件 u(p)=0,u(0)=v(p),v(0)=0 n(0)=q 其中函数自变量为x,边界条件和初值条件中p为常量,q为变量(Solving the solution of the boundary condition of the breeze equation)