mob*_*eng 5 arrays fortran callback julia
我正在尝试为 twpbvpc(带有重新网格化的 ODE BVP)Fortran-77 求解器编写一个包装器。求解器需要带签名的输入函数
subroutine fsub(ncomp, x, u, f, rpar, ipar)
Run Code Online (Sandbox Code Playgroud)
在哪里
ncomp
是一个整数(向量的长度),x
(in) 是一个浮点数,u
(in) 是一个长度为 的向量ncomp
,f
(out) 是结果的位置,长度向量 ncomp
rpar
和ipar
是浮点数和整数外部参数的数组;Julia 的关闭将是更受欢迎的方式,但显然它存在困难(请参阅此处的博客文章)。但暂时可以忽略它们。在 Julia 中,写fsub
我通常会使用签名
function fsub_julia(x :: Float64, y :: Vector{Float64}, dy :: Vector{Float64})
dy[1] = ...
dy[2] = ...
...
end
Run Code Online (Sandbox Code Playgroud)
ncomp
似乎没有必要,因为可以通过length
or获取长度size
(但是,Julia 可以检测从 Fortran 传递的数组的大小吗?对于测试代码,我ncomp
明确知道,所以现在这不是问题)。
所以,为了符合 twpbvpc 格式,我写了一个包装器:
function fsub_par(n :: Int64, x :: Float64, y :: Vector{Float64}, dy :: Vector{Float64}, rpar :: Vector{Float64}, ipar :: Vector{Float64})
fsub_julia(x, y, dy)
end
Run Code Online (Sandbox Code Playgroud)
现在,要将此函数传递给 Fortran 例程,需要对其进行转换cfunction
以声明类型。问题是如何?
如果我把它写成:
cf_fsub = cfunction(fsub_par, Void, (Ref{Int64}, Ref{Float64}, Ref{Float64}, Ref{Float64}, Ref{Float64}, Ref{Int64}))
Run Code Online (Sandbox Code Playgroud)
从 Fortran 调用时,出现错误:
ERROR: LoadError: MethodError: no method matching (::TWPBVP.#fsub_par#1{TWPBVP_Test.#f})(::Int64, ::Float64, ::Float64, ::Float64, ::Float64, ::Int64)
Closest candidates are:
fsub_par(::Int64, ::Float64, !Matched::Array{Float64,1}, !Matched::Array{Float64,1}, !Matched::Array{Float64,1}, !Matched::Array{Float64,1})
Run Code Online (Sandbox Code Playgroud)
所以,不知何故,签名与数组参数不匹配......
如果我Ref{Float64}
用Ref{Array{Float64,1}}
(虽然看起来有点奇怪......)替换数组参数:
cf_fsub = cfunction(fsub_par, Void, (Ref{Int64}, Ref{Float64}, Ref{Array{Float64,1}}, Ref{Array{Float64,1}}, Ref{Array{Float64,1}}, Ref{Array{Int64,1}}))
Run Code Online (Sandbox Code Playgroud)
在 Fortran 代码中调用fsub_par
( cf_fsub
)时出现分段错误(这大约位于,因为错误没有给出确切的位置)。
更换Ref{Float54}
用Ptr{Float64}
的阵列还没有做任何事情。
我在 Fortran 代码中发现的一件有趣的事情是如何fsub
调用:
call fsub (ncomp, xx(1), u(1,1), fval(1,1),rpar,ipar)
Run Code Online (Sandbox Code Playgroud)
其中u
和fval
声明为:
dimension xx(nmsh), u(nudim,nmsh), fval(ncomp,nmsh)
Run Code Online (Sandbox Code Playgroud)
所以,我想,它使用了这样一个事实,即 Fortran 通过引用传递所有参数,并且引用u(1,1)
应该是指向矩阵第一列的指针(据我记得 Fortran,作为 Julia,将矩阵存储在列第一命令)。
有什么出路?我是否需要更改签名fsub_julia
以接受指针并将它们手动转换为数组(这是ODEInterface.jl在较低级别的工作方式)?
遵循在 ODEInterface.jl 中的做法,并结合void*
在 CI中的-thunk 参数中传递 Julia 函数的想法,得出了这个:
immutable TWPBVPCProblem
fsub :: Function # RHS function
dfsub :: Function # Jacobian of RHS
gsub :: Function # BC function
dgsub :: Function # gradients of BC function
end
function unsafe_fsub(rn :: Ref{Int64}, rx :: Ref{Float64}, py :: Ptr{Float64}, pdy :: Ptr{Float64}, rpar :: Ptr{Float64}, ipar :: Ptr{Int64}) :: Void
x = rx[]
n = rn[]
y = unsafe_wrap(Array, py, n)
dy = unsafe_wrap(Array, pdy, n)
problem = unsafe_pointer_to_objref(rpar) :: TWPBVPCProblem
problem.fsub(x, y, dy)
return nothing
end
const fsub_ptr = cfunction(unsafe_fsub, Void, (Ref{Int64}, Ref{Float64}, Ptr{Float64}, Ptr{Float64}, Ptr{Float64}, Ptr{Int64}))
Run Code Online (Sandbox Code Playgroud)
当我打电话给求解器时(它很长):
function twpbvpc(nlbc :: Int64,
aleft :: Float64, aright :: Float64,
fixpnt :: Nullable{Vector{Float64}},
ltol :: Vector{Int64}, tol :: Vector{Float64},
linear :: Bool, givmsh :: Bool, giveu :: Bool, nmsh :: Ref{Int64},
xx :: Vector{Float64}, u :: Array{Float64, 2}, nmax :: Ref{Int64},
wrk :: Vector{Float64}, iwrk :: Vector{Int64},
fsub :: Function, dfsub :: Function,
gsub :: Function, dgsub :: Function,
ckappa1 :: Ref{Float64}, gamma1 :: Ref{Float64},
ckappa :: Ref{Float64},
# rpar :: Vector{Float64},
# ipar :: Vector{Int64},
iflbvp :: Ref{Int64})
# Keep problem functions in rpar
# HACK!
rpar = TWPBVPCProblem(fsub, dfsub, gsub, dgsub)
# Fake external parameters
# Can't have it 0-length as it would be Any[0] and not Float64[0]
# local rpar :: Vector{Float64} = [0.0]
local ipar :: Vector{Int64} = [0]
# No need to pass these parameters
# u is a matrix for the solution only!
ncomp, nucol = size(u)
# Get the maximum of xx
nxxdim = length(xx)
# max for mesh points must be the same as the number of column points of u
assert(nucol == nxxdim)
# Sizes of work arrays
lwrkfl = length(wrk)
lwrkin = length(iwrk)
# Number of fixed mesh points
if isnull(fixpnt)
nfxpnt = 0
fixpnt_v = [0.0]
else
fixpnt_v = get(fixpnt)
nfxpnt = length(fixpnt_v)
end
# Size of tolerance vector ? ncomp
ntol = length(ltol)
ccall((:twpbvpc_, libtwpbvpc), Void,
(Ref{Int64}, Ref{Int64}, # ncomp, nlbc,
Ref{Float64}, Ref{Float64}, # aleft, aright
Ref{Int64}, Ptr{Float64}, # nfxpnt, fixpnt
Ref{Int64}, Ptr{Int64}, Ptr{Float64}, # ntol, ltol, tol
Ref{Int64}, Ref{Int64}, Ref{Int64}, # linear, givmsh, giveu
Ref{Int64}, Ref{Int64}, # nmsh, nxxdim
Ptr{Float64}, Ref{Int64}, # xx, nudim
Ptr{Float64}, Ref{Int64}, # u, nmax
Ref{Int64}, Ptr{Float64}, # lwrkfl, wrk
Ref{Int64}, Ptr{Int64}, # lwrkin, iwrk
Ptr{Void}, Ptr{Void}, Ptr{Void}, Ptr{Void}, # fsub, dfsub, gsub, dgsub
Ref{Float64}, Ref{Float64}, # ckappa1, gamma1
Ref{Float64}, Any, Ptr{Int64}, # ckappa, rpar, ipar
Ref{Int64}), # iflbvp
ncomp, nlbc, aleft, aright,
nfxpnt, fixpnt_v, ntol, ltol, tol,
linear, givmsh, giveu, nmsh,
nxxdim, xx, nucol, u, nmax, # nudim = nucol
lwrkfl, wrk, lwrkin, iwrk,
fsub_ptr, dfsub_ptr, gsub_ptr, dgsub_ptr,
ckappa1,gamma1,ckappa,pointer_from_objref(rpar),ipar,iflbvp)
end
Run Code Online (Sandbox Code Playgroud)
Fortrantwpbvpc
看起来像这样(显然是开头):
subroutine twpbvpc(ncomp, nlbc, aleft, aright,
* nfxpnt, fixpnt, ntol, ltol, tol,
* linear, givmsh, giveu, nmsh,
* nxxdim, xx, nudim, u, nmax,
* lwrkfl, wrk, lwrkin, iwrk,
* fsub, dfsub, gsub, dgsub,
* ckappa1,gamma1,ckappa,rpar,ipar,iflbvp)
implicit double precision (a-h,o-z)
dimension rpar(*),ipar(*)
dimension fixpnt(*), ltol(*), tol(*)
dimension xx(*), u(nudim,*)
dimension wrk(lwrkfl), iwrk(lwrkin)
logical linear, givmsh, giveu
external fsub, dfsub, gsub, dgsub
logical pdebug, use_c, comp_c
common/algprs/ nminit, pdebug, iprint, idum, uval0, use_c, comp_c
...
Run Code Online (Sandbox Code Playgroud)
Fortran 代码编译为build.jl
:
cd(joinpath(Pkg.dir("TWPBVP"), "deps"))
pic = @windows ? "" : "-fPIC"
run(`gfortran -m$WORD_SIZE -fdefault-real-8 -fdefault-integer-8 -ffixed-form $pic -shared -O3 -o libtwpbvpc.so twpbvpc.f`)
Run Code Online (Sandbox Code Playgroud)
所以,我传递rpar
为Any
(应该等价于Ptr{Void}
):尽管 Fortran 需要一个浮点数数组,但这应该无关紧要。
现在,当我尝试运行一个简单的程序(在Pkg.test("TWPBVP")
)时出现分段错误:
signal (11): Segmentation fault
while loading /home/alexey/.julia/v0.5/TWPBVP/test/runtests.jl, in expression starting on line 58
unknown function (ip: 0xffffffffffffffff)
Allocations: 1400208 (Pool: 1399373; Big: 835); GC: 0
Run Code Online (Sandbox Code Playgroud)
由于代码越来越长,这里是github上完整代码的链接:https : //github.com/mobius-eng/TWPBVP.jl
我是否需要更改 fsub_julia 的签名以接受指针并将它们手动转换为数组(这是 ODEInterface.jl 在较低级别的工作方式)?
是的,ODEInterface.jl 模型看起来是一个非常值得遵循的模型。
您需要了解的第一件事是 FortranINTEGER
类型的大小( 或Int32
)Int64
。对于下面的代码,我将从 ODEInterface.jl 借用并使用FInt
(它可以是类型参数,也可以是typealias
)
结果后备应该类似于:
# SUBROUTINE FSUB(NCOMP,X,Z,F,RPAR,IPAR)
# IMPLICIT NONE
# INTEGER NCOMP, IPAR
# DOUBLE PRECISION F, Z, RPAR, X
# DIMENSION Z(*),F(*)
# DIMENSION RPAR(*), IPAR(*)
function unsafe_fsub(ncomp::Ref{FInt}, x::Ref{Float64}, z::Ptr{Float64},
f::Ptr{Float64}, rpar::Ptr{Float64}, ipar::Ptr{FInt})::Void
xx = x[]
zz = unsafe_wrap(Array, z, ncomp[])
ff = unsafe_wrap(Array, f, ncomp[])
fsub!(xx, zz, ff) # function which updates array ff
return nothing
end
const fsub_ptr = cfunction(unsafe_fsub, Void,
(Ref{FInt},Ref{Float64},Ptr{Float64},Ptr{Float64},Ptr{Float64},Ptr{FInt}))
Run Code Online (Sandbox Code Playgroud)
归档时间: |
|
查看次数: |
256 次 |
最近记录: |