我正在尝试为twpbvpc(带重切的ODE BVP)Fortran-77解算器编写包装。求解器需要带签名的输入功能

subroutine fsub(ncomp, x, u, f, rpar, ipar)

在哪里
  • ncomp是一个整数(向量的长度),
  • x(in)是一个浮点数,
  • u(in)是长度为ncomp
  • 的向量
  • f(out)是结果的位置,长度为ncomp的向量
  • rparipar是float和integer外部参数的数组; Julia (Julia)的闭包是更可取的方式,但显然存在困难(请参阅the blog post here)。但是有一段时间他们可以被忽略。

  • 在Julia中,要编写fsub,我通常会使用签名
    function fsub_julia(x :: Float64, y :: Vector{Float64}, dy :: Vector{Float64})
            dy[1] = ...
            dy[2] = ...
            ...
    end
    
    ncomp似乎不是必需的,因为可以通过lengthsize来获取长度(但是,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
    

    现在,要将此函数传递给Fortran例程,需要使用cfunction对其进行转换以声明类型。问题是如何?

    如果我这样说:
    cf_fsub = cfunction(fsub_par, Void, (Ref{Int64}, Ref{Float64}, Ref{Float64}, Ref{Float64}, Ref{Float64}, Ref{Int64}))
    

    从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})
    

    因此,某种程度上签名与数组参数不匹配...

    如果我将数组参数的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}}))
    

    当在Fortran代码中调用fsub_par(cf_fsub)时,我遇到了一个段错误(此位置大约位于该位置,因为错误没有给出确切的位置)。

    Ref{Float54}替换数组的Ptr{Float64}也不起作用。

    我在Fortran代码中发现的一件有趣的事情是fsub的调用方式:
    call fsub (ncomp, xx(1), u(1,1), fval(1,1),rpar,ipar)
    

    其中ufval声明为:
    dimension xx(nmsh), u(nudim,nmsh), fval(ncomp,nmsh)
    

    因此,我猜想,它使用了这样的事实:Fortran通过引用传递所有参数,并且对u(1,1)的引用应该是指向矩阵第一列的指针(据我所知,Fortran和Julia都将矩阵存储在-第一个订单)。

    出路是什么?我是否需要更改fsub_julia的签名以接受指针并将其手动转换为数组(这是ODEInterface.jl在较低级别的工作方式)?

    更新

    遵循ODEInterface.jl中的完成方式,并结合在C中通过void* -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}))
    

    当我调用求解器时(很长):
    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
    

    Fortran的twpbvpc看起来像这样(显然是开始的):
      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
      ...
    

    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`)
    

    因此,我将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
    

    由于代码变得很长,因此以下是指向github上完整代码的链接:https://github.com/mobius-eng/TWPBVP.jl

    最佳答案



    是的,ODEInterface.jl模型看起来很不错。

    您需要了解的第一件事是fortran INTEGER类型的大小(Int32Int64)。对于下面的代码,我将从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}))
    

    关于arrays - Julia回调中的Fortran数组,我们在Stack Overflow上找到一个类似的问题:https://stackoverflow.com/questions/40482764/

    10-14 08:47