Welcome![Sign In][Sign Up]
Location:
Search - POISSON FORTRAN

Search list

[Other resourcePoisson_MPI.f90

Description: 用MPI在fortran下 泊松方程的并行实现-with MPI in fortran under Poisson equation parallel
Platform: | Size: 8261 | Author: 段宾 | Hits:

[MPIPoisson_MPI.f90

Description: 用MPI在fortran下 泊松方程的并行实现-with MPI in fortran under Poisson equation parallel
Platform: | Size: 8192 | Author: 段宾 | Hits:

[AlgorithmPoisson_solver

Description: a package of fortran subprograms for the solution of separable elliptic partial differential equations
Platform: | Size: 12288 | Author: 魏红波 | Hits:

[Algorithmfem2d_poisson_linear

Description:
Platform: | Size: 4096 | Author: sun | Hits:

[Algorithmzufall

Description: 随机数生成fortran源程序,可用于非均匀,高斯,泊松随机数生成-uniform , gaussian, and poisson random number generation
Platform: | Size: 6144 | Author: zhzbao | Hits:

[AlgorithmPOISSON_FINITE-DIFFERENCE_ALGORITHM

Description: 本程序提供一种求解 Poisson 方程的有限差分法-This program offers a Poisson equation for solving finite difference method
Platform: | Size: 2048 | Author: mike | Hits:

[OtherNonnlinefemforsoil

Description: 1.本程序为平面变形问题非线性有限元程序,可用于计算土坝、地基、挡土墙或地下结构的应力和变形。 2.土的非线性应力--应变关系采用邓肯双曲线模式 另一个弹性常数可有两种选择: (a)切线泊松比: (b)切线体积模量: 3.解题方法为中点增量法,考虑到每级加荷的两次计算所得的弹性常数对某些单元可能相差较大,而实际可能处于这两者之间,因此取两者的某种加权平均值作为修正的计算弹性常数,其中初始弹性常数取权为1/4,中点弹性常数取权为3/4,以反映平均结果接近中点弹性常数。 4.网格为任意四边形等参数单元。 5.程序中包含了一维的Goodman接触单元。 6.蓄水引起的湿化,由干、湿两种状态下不同的非线性参数进行计算。 7.可模拟施工过程逐级加荷。 8.坐标方向:y坐标以向上为正,x坐标以向下游为正。 -1. This procedure for the plane deformation of non-linear finite element program can be used to calculate the earth dam, foundation, retaining walls or underground structure, stress and deformation. 2. Soil non-linear stress- strain relationship with Duncan hyperbolic model The other elastic constants have two options: (a) tangent Poisson s ratio: (b) tangent bulk modulus: 3. Problem-solving approach the midpoint of incremental method, taking into account each of the two-stage loading calculated elastic constants for some units may vary widely, but the actual may be in between, so take two a weighted average calculation of elastic constants, as amended, including the right to take the initial elastic constants of 1/4, the midpoint of the right of elastic constants obtained for the 3/4, to reflect the average of the results of close to the midpoint of elastic constants. 4. Quadrilateral grid parameters such as arbitrary units. 5. The program contains one-dimensional contact eleme
Platform: | Size: 361472 | Author: wangzhe | Hits:

[GUI Developxiaokang1

Description: 用fortran语言对偏微分方程中的泊松方程的进行数值解的程序实现 -Fortran language of partial differential equations with Poisson' s equation in the numerical solution of the program realization
Platform: | Size: 210944 | Author: kangjiejie | Hits:

[Otherxiaokang

Description: 泊松方程的解析解法,并和泊松方程的数值解法比较-Analytic Solution of Poisson equation, and numerical solution of Poisson equation and compare
Platform: | Size: 331776 | Author: kangjiejie | Hits:

[Algorithmsor

Description: 求解Poisson方程的超松弛迭代求法,在Fortran 中使用-Relaxation for solving Poisson equations Iterative
Platform: | Size: 1024 | Author: metjiang | Hits:

[Algorithmmg

Description: 本程序使用Fortran语言,使用多重网格的方法求解泊松方程-This program solves Poisson s equation with multigrid method, using Fortran language
Platform: | Size: 3072 | Author: jiahuili | Hits:

[MPIpossion

Description: 这是泊松分布的并行算法。计算算法所需要的时间。本程序是在基于fortran下的mpi运行的。-This is a parallel algorithm for the Poisson distribution. Calculate the time required by the algorithm. This program is based under fortran mpi run.
Platform: | Size: 173056 | Author: wang bo | Hits:

[AI-NN-PRpoisson

Description: 利用快速傅里叶分解法求解二维泊松方程的fortran程序-Fortran program using the fast Fourier decomposition method for solving 2D Poisson equation
Platform: | Size: 1024 | Author: yanyuming | Hits:

[Technology Managementfortran-package

Description: Fortran package to solver poisson problems
Platform: | Size: 18295808 | Author: Shafqat | Hits:

[OtherDIANSHI

Description: 中心差分格式,离散泊松方程,求解电势分布的fortran文件-Central difference scheme, discrete Poisson equation solving potential distribution fortran files
Platform: | Size: 1024 | Author: Xu Dimeng | Hits:

[Algorithmpoisson

Description: poisson.f90 是矩形区域上泊松方程Dirichlet边值问题差分求解的fortran程序,可选择Jacobi或者Gauss-Seidel迭代子程序,其中Jacobi迭代次数为925,Gauss-Seidel迭代次数为478。结果输出至solution.dat文件 poisson.ncl 是NCL脚本,运行该脚本得到的图为result.pdf thomas.f90 是追赶法解代数方程组的fortran程序。控制分辨率n的不同取值,输出以下文件: thomas(n=3).dat thomas(n=5).dat thomas(n=10).dat thomas(n=20).dat thomas.ncl 是NCL脚本,运行该脚本得到的图为result.pdf-poisson.f90 is a rectangular area on the Poisson equation solving Dirichlet Boundary Value Difference fortran program, you can choose Jacobi or Gauss-Seidel iteration subroutine, which Jacobi iterations is 925, Gauss-Seidel iterations is 478. The results are output to the solution.dat file poisson.ncl NCL script, run the script to get the picture shows result.pdf thomas.f90 is catching method for solving algebraic equations fortran program. Control resolution of n different values, output the following files: thomas (n = 3). Dat thomas (n = 5). Dat thomas (n = 10). Dat thomas (n = 20). Dat thomas.ncl is NCL script, run the script to get the picture shows result.pdf
Platform: | Size: 191488 | Author: 胡容 | Hits:

[AlgorithmPoissonMKL

Description: fortran编写的2D快速泊松求解器,MKL中的程序,可以快速求解泊松方程-fortran prepared 2D fast Poisson solver, MKL in the program, you can quickly solve the Poisson equation
Platform: | Size: 15360 | Author: Xu Guofeng | Hits:

[Algorithm理查逊算法

Description: 有限差分算法 里查询算法 可以计算泊松方程 Fortran编写(The query algorithm in finite difference algorithm can calculate poisson equation.)
Platform: | Size: 2048 | Author: qianye | Hits:

[Other!算法:第二类修正方案算法

Description: 算法:第二类修正方案算法 里查询算法 求解泊松方程(Algorithm: the query algorithm in the second class correction algorithm is used to solve the poisson equation.)
Platform: | Size: 1024 | Author: qianye | Hits:

[simulation modelingpoiseuille flow

Description: 良好的模拟了泊肃叶流的流动特性,运用了LBM方法。(The flow characteristics of Poisson flow are simulated well, and the LBM method is applied.)
Platform: | Size: 2048 | Author: 锅炉小白 | Hits:
« 12 »

CodeBus www.codebus.net