Code Monkey home page Code Monkey logo

sciml / sundials.jl Goto Github PK

View Code? Open in Web Editor NEW
204.0 11.0 78.0 1.47 MB

Julia interface to Sundials, including a nonlinear solver (KINSOL), ODE's (CVODE and ARKODE), and DAE's (IDA) in a SciML scientific machine learning enabled manner

Home Page: https://diffeq.sciml.ai

License: BSD 2-Clause "Simplified" License

Julia 100.00%
julia sundials cvode ida ode differential-equations differentialequations ordinary-differential-equations dae differential-algebraic-equations

sundials.jl's Introduction

Sundials.jl

Join the chat at https://gitter.im/JuliaDiffEq/Lobby Build Status Coveralls

Introduction

Sundials.jl is a Julia package that interfaces to the Sundials library (see source). Sundials (the C library and this package) provides the following:

  • CVODES - for integration and sensitivity analysis of ODEs. CVODES treats stiff and nonstiff ODE systems of the form y' = f(t,y,p), y(t0) = y0(p), where p is a set of parameters.
  • ARKStep - for integration of non-stiff, stiff, and mixed mode ODEs via split, linearly-implicit form, implicit, and IMEX Runge-Kutta methods on ODEs of the form My' = f_E(t,y,p) + f_i(t,y,p), y(t0) = y0(p) for a set of parameters p.
  • ERKStep - for integration of non-stiff, stiff, and mixed mode ODEs via split, linearly-implicit form, implicit, and IMEX Runge-Kutta methods on ODEs of the form y' = f(t,y,p), y(t0) = y0(p) for a set of parameters p.
  • IDAS - for integration and sensitivity analysis of DAEs. IDAS treats DAE systems of the form F(t,y,y',p) = 0, y(t0) = y0(p), y'(t0) = y0'(p)
  • KINSOL - for solution of nonlinear algebraic systems. KINSOL treats nonlinear systems of the form F(u) = 0

Note that CVODES and IDAS contain all functions provided by CVODE and IDA (for integration without sensitivity analysis). If you need to use the latter, you can set enable_sensitivities=false in deps/build.jl and (re)build the package.

Installation

Within Julia, use the package manager:

Pkg.add("Sundials")

This should download and install the Sundials libraries and register the package. On Windows precompiled binaries are used, while on Unix and OSX Sundials is built from its sources (provided the necessary tools are available). If you have Sundials already installed, make sure that Julia can find it, e.g., via

push!(Base.DL_LOAD_PATH, "/opt/local/lib")

before you install the package. Downloading and/or re-building of the library can be triggered by Pkg.build("Sundials") if anything goes wrong.

To test the installation use

Pkg.test("Sundials")

which currently runs some of the examples in the examples directory.

Common Interface API

This package is part of the JuliaDiffEq common interface. This is documented in the DifferentialEquations.jl documentation. Thus the ODE tutorial applies. For example, the Lorenz attractor can be solved with CVODE_Adams as follows:

using Sundials
function lorenz(du,u,p,t)
 du[1] = 10.0(u[2]-u[1])
 du[2] = u[1]*(28.0-u[3]) - u[2]
 du[3] = u[1]*u[2] - (8/3)*u[3]
end
u0 = [1.0;0.0;0.0]
tspan = (0.0,100.0)
prob = ODEProblem(lorenz,u0,tspan)
sol = solve(prob,CVODE_Adams())
using Plots; plot(sol,vars=(1,2,3))

Sundials.jl exports the CVODE_BDF, CVODE_Adams, and ARKODE methods for ODEs which are documented in the ODE Solvers page, and IDA which is documented in the DAE solvers page. Additionally, the ARKODE method can be used on SplitODEProblems to solve ODEs in IMEX form.

KINSOL High Level API

Along with the ODE solvers, Sundials contains the KINSOL nonlinear solver. It's called via:

kinsol(f, y0::Vector{Float64};
                userdata::Any = nothing,
                linear_solver=:Dense, jac_upper=0, jac_lower=0)

where f(res,y) is an in-place function that computes the residual f(y)-res=0, and KINSOL attempts to find y such that res=0. This method is generally quite fast and the choice linear_solver=:Band is well-suited for problems with a banded Jacobian (you must specify the upper and lower band sizes). However, this is not as robust as many other techniques like trust-region methods, and thus we recommend NLsolve.jl for more general nonlinear solving.

Direct API

This package closely follows the Sundials C API. At a slightly higher level, many (but not all) Sundials.jl functions support passing Julia objects (like Arrays) instead of Sundials objects (like N_Vectors). The Julia package Clang.jl was used to wrap Sundials. This directly uses Sundials' headers sort-of like SWIG. Thus the general C documentation is the documentation for the direct API. See the test directory for usage examples of the direct interface.

For the wrapping code, see src/wrap_sundials.jl. Because of Clang.jl, Sundials.jl provides almost full coverage of the Sundials library (the serial version). A few things to note:

  • Macros like DENSE_ELEM are not available.
  • Nothing is exported from the module. You need to put Sundials. in front of everything.
  • The parallel versions of Sundials which require different N_Vector types have not been wrapped.

Citing

If you use this library, please cite both Sundials and the JuliaDiffEq project.

@article{rackauckas2017differentialequations,
  title={Differentialequations. jl--a performant and feature-rich ecosystem for solving differential equations in julia},
  author={Rackauckas, Christopher and Nie, Qing},
  journal={Journal of Open Research Software},
  volume={5},
  number={1},
  year={2017},
  publisher={Ubiquity Press}
}

@article{gardner2022sundials,
  title={Enabling new flexibility in the {SUNDIALS} suite of nonlinear and differential/algebraic equation solvers},
  author={Gardner, David J and Reynolds, Daniel R and Woodward, Carol S and Balos, Cody J},
  journal={ACM Transactions on Mathematical Software (TOMS)},
  publisher={ACM},
  year={2022},
  doi={10.1145/3539801}
}

@article{hindmarsh2005sundials,
  title={{SUNDIALS}: Suite of nonlinear and differential/algebraic equation solvers},
  author={Hindmarsh, Alan C and Brown, Peter N and Grant, Keith E and Lee, Steven L and Serban, Radu and Shumaker, Dan E and Woodward, Carol S},
  journal={ACM Transactions on Mathematical Software (TOMS)},
  volume={31},
  number={3},
  pages={363--396},
  year={2005},
  publisher={ACM}
}

sundials.jl's People

Contributors

acroy avatar alyst avatar avik-pal avatar chrisrackauckas avatar christopher-dg avatar daviehh avatar dependabot[bot] avatar devmotion avatar domluna avatar github-actions[bot] avatar iraikov avatar ivarne avatar jd-lara avatar kanav99 avatar keno avatar lcontento avatar melonedo avatar oscardssmith avatar papamarkou avatar powerdistribution avatar rodrigomha avatar scottpjones avatar sjdaines avatar staticfloat avatar tkelman avatar tkf avatar tshort avatar utkarsh530 avatar viralbshah avatar yingboma avatar

Stargazers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

Watchers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

sundials.jl's Issues

[PackageEvaluator.jl] Your package Sundials may have a testing issue.

This issue is being filed by a script, but if you reply, I will see it.

PackageEvaluator.jl is a script that runs nightly. It attempts to load all Julia packages and run their test (if available) on both the stable version of Julia (0.2) and the nightly build of the unstable version (0.3).

The results of this script are used to generate a package listing enhanced with testing results.

The status of this package, Sundials, on...

  • Julia 0.2 is 'No tests, but package loads.' PackageEvaluator.jl
  • Julia 0.3 is 'No tests, but package loads.' PackageEvaluator.jl

'No tests, but package loads.' can be due to their being no tests (you should write some if you can!) but can also be due to PackageEvaluator not being able to find your tests. Consider adding a test/runtests.jl file.

'Package doesn't load.' is the worst-case scenario. Sometimes this arises because your package doesn't have BinDeps support, or needs something that can't be installed with BinDeps. If this is the case for your package, please file an issue and an exception can be made so your package will not be tested.

This automatically filed issue is a one-off message. Starting soon, issues will only be filed when the testing status of your package changes in a negative direction (gets worse). If you'd like to opt-out of these status-change messages, reply to this message.

ida examples segfault on OSX

Running the examples ida_Roberts_dns.jl or ida_Roberts_simplified.jl leads to a segmentation fault on my machine. Not sure if this is connected to #13? cc: @tkelman

Build error: Sundials is not downloaded from the website anymore

When I try to build the package on Julia 0.3, I get:

 julia> Pkg.build("Sundials")
 INFO: Building Sundials
 INFO: Attempting to Create directory /home/paulo/.julia/v0.3/Sundials/deps/downloads
 INFO: Directory /home/paulo/.julia/v0.3/Sundials/deps/downloads already created
 INFO: Downloading file http://computation.llnl.gov/casc/sundials/download/code/sundials-2.5.0.tar.gz
 INFO: Done downloading file http://computation.llnl.gov/casc/sundials/download/code/sundials -2.5.0.tar.gz
 INFO: Attempting to Create directory /home/paulo/.julia/v0.3/Sundials/deps/src
 INFO: Directory /home/paulo/.julia/v0.3/Sundials/deps/src already created
 INFO: Attempting to Create directory /home/paulo/.julia/v0.3/Sundials/deps
 INFO: Directory /home/paulo/.julia/v0.3/Sundials/deps already created
 INFO: Attempting to Create directory /home/paulo/.julia/v0.3/Sundials/deps/src/sundials-2.5.0

 gzip: stdin: not in gzip format
 tar: Child returned status 1
 tar: Error is not recoverable: exiting now
 ==============================[ ERROR: Sundials ]===============================

 failed process: Process(`tar xzf /home/paulo/.julia/v0.3/Sundials/deps/downloads/sundials- 2.5.0.tar.gz --directory=/home/paulo/.julia/v0.3/Sundials/deps/src`, ProcessExited(2)) [2]
 while loading /home/paulo/.julia/v0.3/Sundials/deps/build.jl, in expression starting on line 37

 ================================================================================

 ================================[ BUILD ERRORS ]================================

WARNING: Sundials had build errors.

 - packages with build errors remain installed in /home/paulo/.julia/v0.3
 - build a package and all its dependencies with `Pkg.build(pkg)`
 - build a single package by running its `deps/build.jl` script

================================================================================

Move this package to JuliaMath?

In the interest of reducing JuliaLang's CI queue, we've been migrating a bunch of packages out to organizations, and I think this is one such package that we should move. It's not that high-traffic or all that actively maintained, I somehow became the person account with the largest number of commits here even though I can't remember if I ever actually used this for anything. Any objections? There's also a JuliaODE organization that this could fit under, but that currently looks like it's mostly a staging area for PR's to ODE.jl (which is another package that should move out of JuliaLang at some point). cc @mauro3

x-ref JuliaMath/Roadmap.jl#1

Memory leak in cvode()

I'm using sundials to do some trajectory simulations. I noticed there's memory leak in both cvode() simple function and CVode(). The following code is able to reproduce the problem. Both mycvode() and Sundials.cvode() experience this issue.

using Sundials

function main()
    const t_span = collect(0:0.2:600)
    for i = 1:100000
        yout = Sundials.cvode(g,[1.0,0.0,0.0,0.0],t_span)
        #mycvode(f,[1.0,0.0,0.0,0.0],t_span)
    end
end

function mycvode(f::Function, y0::Vector{Float64}, t::Vector{Float64}; reltol::Float64=1e-8, abstol::Float64=1e-7)
    neq = length(y0)
    mem = Sundials.CVodeCreate(Sundials.CV_ADAMS, Sundials.CV_FUNCTIONAL)
    flag = Sundials.CVodeInit(mem, f, t[1], y0)
    flag = Sundials.CVodeSStolerances(mem, reltol, abstol)
    flag = Sundials.CVDense(mem, length(y0))
    y = copy(y0)
    tout = [t[1]]
    for k in 2:length(t)
        flag = Sundials.CVode(mem, t[k], y, tout, Sundials.CV_NORMAL)
    end
    Sundials.CVodeFree([mem])
end

function f(t, y, ydot, user_data)
    y = Sundials.asarray(y)
    ydot = Sundials.asarray(ydot)
    ydot[1] = 0.0
    ydot[2] = 0.0
    ydot[3] = 0.0
    ydot[4] = 0.0
    return Int32(0)
end


function g(t::Float64, x::Vector{Float64},arr::Vector{Float64})
    fill!(arr,0.0)
end

main()

External library support?

By default Sundials is not compiled with blas/lapack.

I changed build.ji to this:

`./configure --prefix=$prefix --enable-shared --with-blas=/usr/lib/libblas.so.3 --with-lapack=/usr/lib/liblapack.so.3`

It compiled all right, and generated cvode_lapack.o and cvode_lapack.o

Then I added CVLapackDense to cvode.jl

 # header: /usr/local/include/cvode/cvode_lapack.h
@c Int32 CVLapackDense (Ptr{:None},:Cint) shlib

I naively thought that's all I needed to do to enable lapack.

However, when I tried to use Sundials.CVLapackDense(mem, neq) instead of Sundials.CVDense(mem, neq) and run Sundials.CVode, my program crashed with no reasons given.

Is there any way to enable lapack in Sundials?

Support for other solvers

Are there any plans for other solvers (such as ARKode) to be included in this package? Or is the idea to keep Sundials.jl as-is and wait for ODE.jl to mature? Thanks.

Possibility of write access to the Sundials package

I have noticed that the Sundials package is not actively maintained, given that it has been about 10 months since the last commit. I would like to kindly ask if it would be possible to grant me write access to the package, as a collaborator so that I can contribute to its maintenance. I can try to sort issues #3 and #6, possibly consider #4 as well (in combination with some examples from the ChemicalKinetics package). I do not claim that I will be maintaining the package on a daily basis, but I can help if this is desired.

Sundials version on METADATA

I opened an issue to double check whether everyone is happy in case I either bump or create a minor new version of Sundials on METADATA, since the last update on the package on METADATA occurred more than a year ago. There is new functionality such as the tolerance options and the BinDeps integration that would be nice to make it available via METADATA. Do you guys agree that I proceed?

Use BinDeps to install Sundials before travis test

The test in ChemicalKinetics executes successfully on my computer, but fails on the travis server because of missing dependencies (the Sundials library needs to get installed before running the tests). Perhaps BinDeps can help sort this out.

How to pass user_data argument of f to the solver

Hi Tom, perhaps I should not report this as an issue, since it is more of a question as to how to use one of your package's functionalities. I want to pass an extra argument to f, which you call user_data in examples/cvode_Roberts_dns.jl (and is of type Ptr{Void}). I will use the CVODE solver and I don't know how this user_data argument of f will be passed to CVODE ultimately - does the package support this functionality? As an example, I simply simulated the ODE system below via Sundials.ode (and circumvented the problem by wrapping f2 in f). In this example, the parameters p = [a, b, c] play the role of user_data. Any hints as to whether it is possible to pass them to CVODE via your package will be valuable. Here is the simple example (Fitzhugh-Nagumo ODE system, consisting of 2 ODEs):

# Simulate data from the Fitzhugh-Nagumo ODEs
# d/dt(V) = c*(R+V-V^3/3)
# d/dt(R) = -(V-a+R*b)/c

using Sundials

function f2(t, y, ydot, p)    
    ydot[1] = p[3]*(y[2]+y[1]-y[1]^3/3)
    ydot[2] = -(y[1]-p[1]+y[2]*p[2])/p[3]
end

# Time t
t = [i for i in 0.:10]

# Initial conditions y0 = [V, R]
y0 = [-1., 1.];

# Parameters p = [a, b, c]
p = [0.2, 0.2, 3];

f(t, y, ydot) = f2(t, y, ydot, p)

data = Sundials.ode(f, y0, t)

Sundials problem memory is not garbage collected

Ideally, there should be a garbage-collected wrapper looking something like this:

type CVmem
  handle :: Ptr{Void}
  function CVmem(lmm::Cint, iter::Cint)
    mem = new(CVodeCreate(lmm, iter))
    mem.handle == C_NULL && error("CVodeCreate failed")
    finalizer(mem, CVodeFree)
    mem
  end
end

convert(::Type{Ptr{Void}}, mem::CVmem) = mem.handle

CVodeFree(mem::CVmem) = ccall((:CVodeFree, Sundials.libsundials_cvodes), Void, (Ptr{Ptr{Void}},), &mem)

Of course, the garbage collector won't always collect the memory aggressively if Sundials uses a lot of it, but it is much more "julia-like" to try to collect these pointers than to expect the user to call create/free pairs.

Segmentation Fault on CVodeF

Hi,

likely it is my fault here but I cannot figure out what is wrong in my code. I am trying to use Sundials api to solve an adjoint sensitivity problem. The culprit is this line:

flag = Sundials.CVodeF(cvode_mem, t[2], [t[1]], tret, Sundials.CV_NORMAL, Int32[0])

which I derived from the line

flag = Sundials.CVode(cvode_mem, t[i], tmp, tret, Sundials.CV_NORMAL)

of the basic interface. Initialisation of the adjoint problem, via CVodeAdjInit is successfull.

The code segfault with this error message

signal (11): Segmentation fault
N_VClone at /home/davide/.julia/v0.3/Sundials/deps/usr/lib/libsundials_cvodes.so (unknown line)

Any hints?

Davide

New release?

I currently have a package that requires the latest Sundials master, because it relies on the fix from #42. Is it possible to tag a new release so I can use it in my REQUIRE? I'm happy to do this, assuming I can figure out the process.

Segmentation fault when passing data stored in Dictionary to user function

The issue I'm describing here is somewhat similar to the one described in #3 .
As in that case, I try to pass additional parameters to my user function. However, the data is not stored in a Vector, but in a dictionary. It works fine with KINSOL:

Initialization of solver:

flag = Sundials.KINInit(kmem, cfunction(wuet_stat, Int32, (Sundials.N_Vector, Sundials.N_Vector, Dict{AbstractString,Any})), nvector(y))

wuet_stat is the user function, additional data is stored in a dictionary called pass_data

flag = Sundials.KINSetUserData(kmem, pass_data)

The header of my user function looks like this:
function wuet_stat(u_in, fu_in, dict_in)

Now, I tried to implement the same strategy in a dynamic model using IDA as solver:

Initialization of solver:

flag = Sundials.IDAInit(mem, cfunction(wuet, Int32, (Sundials.realtype, Sundials.N_Vector, Sundials.N_Vector, Sundials.N_Vector, Dict{ASCIIString,Any})), time[1], nvector(u), nvector(up))

with IDASetUserData and my user function set up in the same way as in the case with KINSOL as solver. When I try to access the dictionary from the user function, the julia REPL terminates instantly, throwing a segmentation fault. Any idea, what needs to be done to the Sundials interface?

Setting ydot equal to vector fails, while element-by-element works

I recently observed the following behavior which was bizarre and unexpected to me. (The code up top works as expected, but the code on bottom fails)

using Sundials

function model(t,y,ydot)
    ydot[1] = 1.0
    ydot[2] = 1.0
end

t = [0.0:10.0]
y = Sundials.cvode(model, [0.0, 0.0], t)

print(y)

[0.0 0.0
1.0 1.0
2.0 2.0
3.0 3.0
4.0 4.0
5.0 5.0
6.0 6.0
7.0 7.0
8.0 8.0
9.0 9.0
10.0 10.0]

function model(t,y,ydot)
    ydot = ones(2)
end

t = [0.0:10.0]
y = Sundials.cvode(model, [0.0, 0.0], t)

print(y)

[0.0 0.0
6.9403255392342e-310 8.1779208e-316
1.38806510784684e-309 1.635584163e-315
2.082097661770263e-309 2.453376244e-315
2.776130215693685e-309 3.271168325e-315
3.470162769617106e-309 4.088960407e-315
4.164195323540527e-309 4.90675249e-315
4.85822787746395e-309 5.72454457e-315
5.552260431387374e-309 6.54233665e-315
6.24629298531079e-309 7.36012873e-315
6.94032553923421e-309 8.177920813e-315]

Memory leaks in N_Vector and cvode

  1. when a julia vector is converted into NVector, the conversion code allocates the NVector structure, but this is never freed.

To solve this, automatic conversion should be disabled and each conversion should be followed by a call to N_VDestroy_Serial

  1. when CVodeCreate is called it allocates memory for internal use, but it is never freed.
    This memory should be freed using CVodeFree

These two leaks fill up memory quite quickly if one calculates say bifurcation diagrams....

Thanks for the code, it is rather useful otherwise.

error installing sundials

I have installed Sundials successfully on my laptop running ubuntu. However on a server running opensuse, upon giving Pkg.add("Sundials") I get the following error. I checked the directory ~/.julia/v0.3/Sundials/deps/usr/lib64 and all the shared libraries seem to be there.

==============================[ ERROR: Sundials ]===============================

Provider BuildProcess failed to satisfy dependency libsundials_idas
while loading /home/rajeev/.julia/v0.3/Sundials/deps/build.jl, in expression starting on line 32

================================================================================

================================[ BUILD ERRORS ]================================

WARNING: Sundials had build errors.

 - packages with build errors remain installed in /home/rajeev/.julia/v0.3
 - build a package and all its dependencies with `Pkg.build(pkg)`
 - build a single package by running its `deps/build.jl` script

================================================================================```

new tagn

Hi,

Can you tag 0.2.2+ as I need it for PDMP.jl?

Thank you for your help,

Romai

CVodeGetRootInfo error

I am trying to run the cvode_Roberts_dns.jl example in Julia 0.4.5.
However, I receive the following error as soon as CVodeGetRootInfo is called:

<ERROR: MethodError: `CVodeGetRootInfo` has no method matching CVodeGetRootInfo(::Ptr{Void}, ::Array{Int32,1})
Closest candidates are:
  CVodeGetRootInfo(::Ptr{Void}, ::Ptr{Int32})
 [inlined code] from none:5
 in anonymous at no file:0>

CVodeGetRootInfo is called with the following command:

  flagr = Sundials.CVodeGetRootInfo(cvode_mem, rootsfound)

and rootsfound is initialized with

rootsfound = round(Int32,[0, 0])

So, I could not figure out what is the problem here.
My understanding is that Julia arrays are automatically converted into Ptr by Julia.

Thanks for your help,

Antoine

Update Sundials version

Sundials.jl uses Sundials 2.5.0, the most version is 2.6.2.

I don't know what would be the specific benefits of upgrading the Sundials version, but with #67 merged into master some of the hand-written wrappers are now generated automatically, so this upgrade should be easier.

Sundials travis test oddly fails

Hi @IainNZ, I enabled travis for Sundials since BinDeps support is available. The travis test fails, which seems odd to me, since my ChemicalKinetics package (which requires Sundials) completes successfully! Any thoughts what could be going wrong with the Sundials travis test?

Transfer to JuliaLang

Tom - I am wondering if it is ok to transfer this repository to JuliaLang, in order to have a larger group of people work towards robust ODE capabilities for julia.

Should sundials functions return Julia symbols instead of integer (enum) flags?

It seems to me the interface would be cleaner if:

  • when a Sundials function returns CV_SUCCESS (= 0), it would return :CV_SUCCESS instead of integer 0, and similarly for any other non-error informational flag
  • when a Sundials function returns CV_ILL_INPUT (or some other flag that means an error), it would raise an error instead of returning an integer

Is there a reason why this isn't done in Sundials.jl? In my own code I have some macros to do this kind of error-checking automatically, and it seems like this would improve the interface.

If the issue is with exactly duplicating the C interface, then maybe put wrapped functions into a separate module?

Adaptive timestepping in high-level interface?

Hey, I am in the process of wrapping some of Sundials into DifferentialEquations.jl and was wondering how you access CVode's adaptive timestepping with the high level interface here. Is it possible? Is there a work around that's needed?

Also, when doing adaptive, where do you find out what times it solved at?

matrix free method

Hi,

I am wondering if the matrix free method is available. According to the manual, the user should provide CVSPILS linear solver a function CVSpilsSetPreconditioner.

Thank you for your help,

Best regards

The example in the front page breaks in Julia 0.5.0

The example in the front page breaks in Julia 0.5.0.

julia> using Sundials

julia> function f(t, y, ydot)
           ydot[1] = -0.04*y[1] + 1.0e4*y[2]*y[3]
           ydot[3] = 3.0e7*y[2]*y[2]
           ydot[2] = -ydot[1] - ydot[3]
       end
f (generic function with 1 method)

julia> t = [0.0, 4 * logspace(-1., 7., 9)]
2-element Array{Any,1}:
 0.0
  [0.4,4.0,40.0,400.0,4000.0,40000.0,400000.0,4.0e6,4.0e7]

julia> res = Sundials.cvode(f, [1.0, 0.0, 0.0], t)
ERROR: MethodError: no method matching cvode(::#f, ::Array{Float64,1}, ::Array{Any,1})
Closest candidates are:
  cvode(::Function, ::Array{Float64,1}, ::Array{Float64,1}; reltol, abstol) at /Users/hldmyb/.julia/v0.5/Sundials/src/Sundials.jl:309

julia> versioninfo()
Julia Version 0.5.0
Commit 3c9d753* (2016-09-19 18:14 UTC)
Platform Info:
  System: Darwin (x86_64-apple-darwin15.6.0)
  CPU: Intel(R) Core(TM) i5-4258U CPU @ 2.40GHz
  WORD_SIZE: 64
  BLAS: libopenblas (DYNAMIC_ARCH NO_AFFINITY Haswell)
  LAPACK: libopenblas
  LIBM: libm
  LLVM: libLLVM-3.7.1 (ORCJIT, haswell)

Is it should t = append!([0.0], 4 * logspace(-1., 7., 9)) instead of t = [0.0, 4 * logspace(-1., 7., 9)]? Since t = [0.0, 4 * logspace(-1., 7., 9)] has the type Array{Any,1} .

A julia blog post on Sundials

Tom - it would be great to have a julia blog post on sundials, because this is some pretty good functionality that people are not otherwise aware of. What do you think?

Type of CVodeUserDataB is wrong

When trying to pass a Julia value as user data, I get a missing method error for convert(::Type{Ptr{Union()}}, ::MyType) Sundials expects it to be an opaque pointer to some user data that then gets passed to other user-specified functions.

In https://github.com/JuliaLang/Sundials.jl/blob/master/src/cvodes.jl#L126: the second void* argument is an opaque pointer to user data, much like CVodeUserData, and should be declared the same way it's set in https://github.com/ikirill/Sundials.jl/blob/master/src/Sundials.jl#L255

The definition of CVodeUserData in cvode.jl (https://github.com/JuliaLang/Sundials.jl/blob/master/src/cvode.jl#L247) has the same problem, I think, but it's overridden by https://github.com/ikirill/Sundials.jl/blob/master/src/Sundials.jl#L255

Are you from the future?

commit history says that 7 days ago you checked in a version of the @c macro that did not exist until two days ago. I thought that only Jeff has this superpower! 🎱

Sundials fails to build under Julia 0.4.6 on Windows

@tkelman

When issuing the command Pkg.build("Sundials") in a freshly installed Julia 0.4.6 on Windows, I get the following message:

julia> Pkg.build("Sundials")
INFO: Building Sundials
INFO: Attempting to Create directory C:\Users\kris\.julia\v0.4\Sundials\deps\downloads
INFO: Directory C:\Users\kris\.julia\v0.4\Sundials\deps\downloads already created
INFO: Downloading file https://cache.e.ip.saba.us/https://bintray.com/artifact/download/tkelman/generic/sundials-2.5.0.7z
Exception calling "DownloadFile" with "2" argument(s): "The underlying connection was closed: Could not establish trust relationship for the SSL/TLS secure channel."
At line:1 char:1
+ (new-object net.webclient).DownloadFile("https://cache.e.ip.saba.us/h ...
+ ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
    + CategoryInfo          : NotSpecified: (:) [], MethodInvocationException
    + FullyQualifiedErrorId : WebException

==============================[ ERROR: Sundials ]===============================

LoadError: failed process: Process(`'C:\Windows\System32\WindowsPowerShell\v1.0\powershell' -NoProfile -Command '(new-object net.webclient).DownloadFile("https://cache.e.ip.saba.us/https://bintray.com/artifact/download/tkelman/generic/sundials-2.5.0.7z", "C:\Users\kris\.julia\v0.4\Sundials\deps\downloads\sundials-2.5.0.7z")'`, ProcessExited(1)) [1]
while loading C:\Users\kris\.julia\v0.4\Sundials\deps\build.jl, in expression starting on line 37

================================================================================

==============================================================================================================[ BUILD ERRORS ]==============================================================================================================

WARNING: Sundials had build errors.

 - packages with build errors remain installed in C:\Users\kris\.julia\v0.4
 - build the package(s) and all dependencies with `Pkg.build("Sundials")`
 - build a single package by running its `deps/build.jl` script

============================================================================================================================================================================================================================================

julia>

Naming and compatibility

I noticed that Sundials is exporting functions named ode and dae. I think those names are too general for a specific package to claim, and would suggest to deprecate and rename them to ode_sundials and dae_sundials. Any objections/alternative names?

CVODES examples and support (cvsRoberts_FSA_dns)

What is the state of support for forward/adjoint sensitivity analysis? The examples seem to be missing, and there is the comment

# IDAS  (still incomplete)

in https://github.com/JuliaLang/Sundials.jl/blob/master/src/Sundials.jl#L200, which seems suspicious.

The type of CVodeSensInit (https://github.com/JuliaLang/Sundials.jl/blob/master/src/Sundials.jl#L200) seems wrong, as it makes a vector out of yS0, where C function expects a pointer to an array of N_Vectors.

I'm not demanding that it must be implemented, it's just that it's missing from the readme's todo-list, and the readme seems to say that it should work, yet it looks only partially implemented.

segfault using sundials functions

I am having a hard time identifying a segfault in a custom code using the wrapped functions of Sundials. The gist is here.

I am running the latest Sundials master and julia 0.4.6. I get this output

...
40[-6.6548489117029055,-10.320613520158005,17.61112044600523]
41[-9.676631014457783,-2.3993127613313825,35.58702934024834]
42[0.6108481014146323,2.7269241610824544,22.475214727745026]
43[1.894340014416633,3.3799990331837733,10.90024308001776]

signal (11): Segmentation fault: 11
fcallback at /Users/davide/Codes/SamplesGenerators.jl/src/tmp.jl:25
jlcapi_fcallback_21488 at  (unknown line)
cvStep at /Users/davide/.julia/v0.4/Sundials/deps/usr/lib/libsundials_cvodes.dylib (unknown line)
CVode at /Users/davide/.julia/v0.4/Sundials/deps/usr/lib/libsundials_cvodes.dylib (unknown line)
__CVode at /Users/davide/.julia/v0.4/Sundials/src/cvodes.jl:416
jlcall___CVode_21501 at  (unknown line)
jl_apply at /Users/davide/Software/julia/src/./julia.h:1331
next at /Users/davide/Codes/SamplesGenerators.jl/src/tmp.jl:81
jlcall_next_21500 at  (unknown line)
jl_apply at /Users/davide/Software/julia/src/./julia.h:1331
anonymous at no file:0
jl_apply at /Users/davide/Software/julia/src/toplevel.c:544
jl_parse_eval_all at /Users/davide/Software/julia/src/toplevel.c:577
jl_load at /Users/davide/Software/julia/src/toplevel.c:619
include at ./boot.jl:261
jl_apply at /Users/davide/Software/julia/src/./julia.h:1331
include_from_node1 at ./loading.jl:320
jl_apply at /Users/davide/Software/julia/src/./julia.h:1331
process_options at ./client.jl:284
_start at ./client.jl:378
jlcall__start_18875 at /Users/davide/Software/julia-0.4/usr/lib/julia/sys.dylib (unknown line)
jl_apply at /Users/davide/Software/julia/src/./julia.h:1331
true_main at /Users/davide/Software/julia-0.4/usr/bin/julia (unknown line)
main at /Users/davide/Software/julia-0.4/usr/bin/julia (unknown line)

Any help is appreciated.

(I am actually hitting this while developing a way to pass the rhs jacobian, quadrature functions and root identification functions in a single shot...)

Cannot build sundials.jl on NixOs

I have developnet environment for julia and other staff which looks like this:

~/envs/allDev.nix:
with import <nixpkgs> {}; {
  allDevEnv = stdenv.mkDerivation {
    name = "allDev";
    buildInputs = [ 
                    stdenv
                    pkgconfig
                    cmake
                    gnumake
                    gcc
                    gfortran
                    zsh
                    gnuplot
                    julia
                    llvm
                  ];
  };
}

I run it as

$nix-shell ~/envs/allDev.nix --run zsh

when I try to build sundials, I got an error: (it seems i miss some dependency, but I fail to track what exactly I am missing.)

julia> Pkg.add("Sundials")
INFO: Initializing package repository /home/kosh/.julia/v0.4
INFO: Cloning METADATA from git://github.com/JuliaLang/METADATA.jl
INFO: Cloning cache of BinDeps from git://github.com/JuliaLang/BinDeps.jl.git
INFO: Cloning cache of Compat from git://github.com/JuliaLang/Compat.jl.git
INFO: Cloning cache of SHA from git://github.com/staticfloat/SHA.jl.git
INFO: Cloning cache of Sundials from git://github.com/JuliaDiffEq/Sundials.jl.git
INFO: Cloning cache of URIParser from git://github.com/JuliaWeb/URIParser.jl.git
INFO: Installing BinDeps v0.4.5
INFO: Installing Compat v0.9.2
INFO: Installing SHA v0.2.1
INFO: Installing Sundials v0.2.2
INFO: Installing URIParser v0.1.6
INFO: Building Sundials
INFO: Attempting to Create directory /home/kosh/.julia/v0.4/Sundials/deps/downloads
INFO: Downloading file http://ftp.mcs.anl.gov/pub/petsc/externalpackages/sundials-2.5.0.tar.gz
  % Total    % Received % Xferd  Average Speed   Time    Time     Time  Current
                                 Dload  Upload   Total   Spent    Left  Speed
100 8102k  100 8102k    0     0  1600k      0  0:00:05  0:00:05 --:--:-- 1782k
INFO: Done downloading file http://ftp.mcs.anl.gov/pub/petsc/externalpackages/sundials-2.5.0.tar.gz
INFO: Attempting to Create directory /home/kosh/.julia/v0.4/Sundials/deps/src
INFO: Attempting to Create directory /home/kosh/.julia/v0.4/Sundials/deps
INFO: Directory /home/kosh/.julia/v0.4/Sundials/deps already created
INFO: Changing Directory to /home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0

---------------------------------
Running SUNDIALS Configure Script
---------------------------------

Initialization
--------------

checking build system type... x86_64-unknown-linux-gnu
checking host system type... x86_64-unknown-linux-gnu
checking whether make sets $(MAKE)... yes
checking for a BSD-compatible install... /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c

C Compiler Settings
-------------------

checking for C compiler default output file name... a.out
checking whether the C compiler works... yes
checking whether we are cross compiling... no
checking for suffix of executables... 
checking for suffix of object files... o
checking whether we are using the GNU C compiler... yes
checking whether gcc accepts -g... yes
checking for gcc option to accept ANSI C... none needed
checking for egrep... grep -E
checking for sys/types.h... yes
checking for sys/stat.h... yes
checking for stdlib.h... yes
checking for string.h... yes
checking for memory.h... yes
checking for strings.h... yes
checking for inttypes.h... yes
checking for stdint.h... yes
checking for unistd.h... yes
checking floating-point data type to use... double
checking for C compiler flags... none
checking how to run the C preprocessor... gcc -E
checking for C/C++ preprocessor flags... none
checking for linker flags... none
checking for extra libraries... none
checking for ANSI C header files... yes
checking for stdlib.h... (cached) yes
checking float.h usability... yes
checking float.h presence... yes
checking for float.h... yes
checking math.h usability... yes
checking math.h presence... yes
checking for math.h... yes
checking for abs in -lm... yes
checking for fabs in -lm... yes
checking for pow in -lm... yes
checking for sqrt in -lm... yes
checking for additional required C libraries... -lm 
checking for int... yes
checking size of int... 4
checking for long int... yes
checking size of long int... 8
checking for double... yes
checking size of double... 8
checking for egrep... (cached) grep -E
checking for fgrep... grep -F
checking if gcc is a C++ compiler... no

Fortran Settings
----------------

checking for f77... f77
checking whether we are using the GNU Fortran 77 compiler... yes
checking whether f77 accepts -g... yes
checking for extra Fortran compiler flags... none
checking how to get verbose linking output from f77... -v
checking for Fortran libraries of f77...  -L/nix/store/0ki0pmc87z3hlvir0qa9d15vqfxpldsf-zsh-5.2/lib -L/nix/store/rzmv7g9i09dlns8ysg8bgwi3d49ihz8y-python3.4-PyQt-5.6/lib -L/nix/store/9jqa3qj2vimwxnzm7wqpplgr9zxnklvv-python3.4-sip-4.18.1/lib -L/nix/store/cinpvy8nqd2gzbsdzls7h76g0668q1nm-python3-3.4.5/lib -L/nix/store/hj3rayffdj7z0a1l8vaxdkkzcl13gw8v-python3.4-setuptools-26.1.1/lib -L/nix/store/yljif0227xh6x5v02hiyagb4l4hf92by-qtbase-5.6.1-1/lib -L/nix/store/jg2l9ifqj787c9k9rb0wd5dlyfl3cfjx-qtsvg-5.6.1-1/lib -L/nix/store/h7bfvm2rzaxccbp1gcvzp7xxl167ajsa-qtdeclarative-5.6.1-1/lib -L/nix/store/n7zfwbvldw4rhmhddwsaxb8nppcpp5qd-qtmultimedia-5.6.1-1/lib -L/nix/store/5yqp923cf5v3rk6573s602aj99xlbgfk-qtlocation-5.6.1-1/lib -L/nix/store/y2xqwd1pnsgphic6xxvp01zv3hxisgyv-qtsensors-5.6.1-1/lib -L/nix/store/lx5mw4h4dzqvnigc76p639bw3kdja2bd-qtwebkit-5.6.1/lib -L/nix/store/85dsf8jcy79vj9phrd2kynlq5clbya30-python3.4-numpy-1.11.1/lib -L/nix/store/qdindkmxx9z8sncwwmbnbmh0zp2rmilv-openblas-0.2.19/lib -L/nix/store/pq0ij5ldr6h9hakpgxhj0h4fnhp4929h-python3.4-scipy-0.18.0/lib -L/nix/store/f8fankrjca3sfn7bnvd8xczrplni3w66-python3.4-matplotlib-1.5.1/lib -L/nix/store/y2vzrphpmw2gwz06rpmyc3sml5vhbphx-python3.4-cycler-0.10.0/lib -L/nix/store/nhl7aci29cnw477vqnlgp3zmsll4czh6-python3.4-six-1.10.0/lib -L/nix/store/v14qkj3mx28xws268z1hfm28pcjxvh9v-python3.4-dateutil-2.4.2/lib -L/nix/store/i7g8cjw6i7g64i68p4kb5kxj60z52n75-python3.4-nose-1.3.7/lib -L/nix/store/y2vdxi33834wq9wzl8k8748nr8q039l9-python3.4-coverage-4.0.1/lib -L/nix/store/ib2sn3a5mjcwiaiplsvbn62xw64yrnqh-python3.4-pyparsing-2.1.8/lib -L/nix/store/1jlira3d20bgkhsgbrvxbmxkvwilhmqz-python3.4-tornado-4.4.1/lib -L/nix/store/grqgij3wri501sh9v04xh4kmf1ckwssi-python3.4-backports_abc-0.4/lib -L/nix/store/jn43jrf4lrlzih4v5b44dz2qz649f1kj-python3.4-backports.ssl_match_hostname-3.5.0.1/lib -L/nix/store/lihw4plwgynlpdpd371gxv82mb7600ds-python3.4-certifi-2016.2.28/lib -L/nix/store/f6rx50qmym5sp02zdzrjf0qq1ypdfg39-python3.4-singledispatch-3.4.0.3/lib -L/nix/store/6lcyv964bl4b424jsr8pkqi17yfhncnl-freetype-2.6.5-dev/lib -L/nix/store/l0xrpsihd7yp97cfh1af4lvi6vmdr35h-zlib-1.2.8-dev/lib -L/nix/store/b5mwbrx8cldkchiqgwgkaagw91xfjr89-zlib-1.2.8/lib -L/nix/store/vqplqg2yxwzd7j27535kilgb6raxni70-bzip2-1.0.6.0.1-dev/lib -L/nix/store/9jplq6zqlfixn2drgq07jgvcabjrmn47-bzip2-1.0.6.0.1/lib -L/nix/store/rv2iwsydhjy91j83p2b7x6rcp85ry25j-libpng-apng-1.6.23-dev/lib -L/nix/store/rapy57vhj8fckrh7wbpm5fzlls62k6yq-libpng-apng-1.6.23/lib -L/nix/store/07fdvyiml8hayl2xs1f7vldn8nlh2gkb-freetype-2.6.5/lib -L/nix/store/65rja57bmh1zm68jnrgkg6z5zp1d3jy5-python3.4-pkgconfig-1.1.0/lib -L/nix/store/mjpd5k1k27c6q4sy5nzs72r5cny1s1lm-python3.4-mock-1.3.0/lib -L/nix/store/2rba3j52qz6ycrq6giv44mxxxri7gyp6-python3.4-funcsigs-0.4/lib -L/nix/store/rk6s9wlvyvwwygxjvwpjrb7wsm95mvg1-python3.4-pbr-1.8.1/lib -L/nix/store/4kzs6bkbnn011nrmlr0hndwkbb32p9vl-python3.4-pytz-2016.6.1/lib -L/nix/store/91aa320ql5j3mj89ssvf7ydb5721gyvp-python3.4-ipython-5.1.0/lib -L/nix/store/pflca1yck21nw3d49369nw3dhv2baarp-python3.4-decorator-4.0.9/lib -L/nix/store/n3yzmjlcwc8xg0kmzwmxrw1km5l01anq-python3.4-pickleshare-0.5/lib -L/nix/store/4qfk8jzbkdd13wz0d41fwj25v6g0sp86-python3.4-path.py-8.1.2/lib -L/nix/store/lr03mr21b05b8hzydyl5a8d809s2fzkp-python3.4-prompt_toolkit-1.0.3/lib -L/nix/store/58lw997wwjm3rd9machgvbdw1k8janh4-python3.4-docopt-0.6.2/lib -L/nix/store/d6a4al3zcwm0g0nwfbcmzpcn5anpv4a1-python3.4-wcwidth-0.1.6/lib -L/nix/store/5iagc7yncmbrrc6x7ngbw5iksdlr502x-python3.4-Pygments-2.1.3/lib -L/nix/store/2h2ah17ynj561g488xmy2ffkxk2rhiam-python3.4-docutils-0.12/lib -L/nix/store/9p0m4h47qwaz23rhmv8l3blidjxdf5dm-python3.4-simplegeneric-0.8.1/lib -L/nix/store/883l2yr7pzylygl2r7pripxni60a9inw-python3.4-traitlets-4.2.2/lib -L/nix/store/3snkfkwli6s0xh92czkswxzjq5l4r57g-python3.4-ipython_genutils-0.1.0/lib -L/nix/store/gkkvmlrav8rlhy0v1ibq0fck00c92rj6-python3.4-requests-2.11.1/lib -L/nix/store/2gpryd609xs1cxnib7w8v0w85ncppjgx-python3.4-pexpect-3.3/lib -L/nix/store/nchfwfk19z6bx37id9f3zr845w47q76g-ghc-8.0.1/lib -L/nix/store/w5ghbhrspck383b9cxrzy65xkdsy5s49-julia-0.4.6/lib -L/nix/store/26ps1nri7v0gcd0bv91xyw1bz1fqnq9h-llvm-3.7.1/lib -L/nix/store/yfm40v49qvfmh1mfn6syd931807jbk1n-ncurses-6.0-dev/lib -L/nix/store/m4fscyf6j97wh5yfi6gww86x79jsw321-ncurses-6.0/lib -L/nix/store/6fix3zqpnahyml8zp2sxi2rwan55rgb8-glibc-2.24/lib -L/nix/store/zy84lvl29mxn88fgb02sw4fzl95yp0dz-gfortran-5.4.0-lib/lib -L/nix/store/2qcmna39jkddhpdiw2lbmvbg699b6ijn-gfortran-wrapper-5.4.0/bin -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0 -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0/../../../../lib64 -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0/../../.. -lgfortran -lm -lgcc_s -lquadmath
checking which linker to use... f77
checking for Fortran name-mangling scheme of C identifiers... lower case  + one underscore
checking for Fortran name-mangling scheme of C identifiers with underscores... lower case  + one underscore
checking for dgemm_... no
checking for dgemm_ in -lcxml... no
checking for dgemm_ in -ldxml... no
checking for dgemm_ in -lscs... no
checking for dgemm_ in -lcomplib.sgimath... no
checking for dgemm_ in -lblas... no
checking for dgemm_ in -lblas... (cached) no
checking for Blas/Lapack library linkage... "no"

   Unable to determine Blas/Lapack library linkage.

   Try using --with-blas and --with-lapack.

   Disabling compilation of Blas/Lapack interfaces...

MPI-C Settings
--------------

checking if using MPI-C script... yes
checking if absolute path to mpicc was given... no
checking for mpicc... none
configure: WARNING: cannot find MPI-C compiler

   Unable to find a functional MPI-C compiler.

   Try using --with-mpicc to specify a MPI-C compiler script,
   --with-mpi-incdir, --with-mpi-libdir and --with-mpi-libs
   to specify the locations of all relevant MPI files, or
   --with-mpi-root to specify the base installation directory
   of the MPI implementation to be used.

   Disabling the parallel NVECTOR module and all parallel examples...


Libtool Settings
----------------

checking for a sed that does not truncate output... /nix/store/n62975gpkckivvxvlhg9hjfknspxnkkm-gnused-4.2.2/bin/sed
checking for ld used by gcc... /nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld
checking if the linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) is GNU ld... yes
checking for /nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld option to reload object files... -r
checking for BSD-compatible nm... /nix/store/v77miigq2dx55ga1hxfv3k7v9a873472-binutils-2.27/bin/nm -B
checking whether ln -s works... yes
checking how to recognise dependent libraries... pass_all
./configure: line 11735: /usr/bin/file: No such file or directory
checking dlfcn.h usability... yes
checking dlfcn.h presence... yes
checking for dlfcn.h... yes
checking whether we are using the GNU C++ compiler... yes
checking whether g++ accepts -g... yes
checking how to run the C++ preprocessor... g++ -E
checking the maximum length of command line arguments... 32768
checking command to parse /nix/store/v77miigq2dx55ga1hxfv3k7v9a873472-binutils-2.27/bin/nm -B output from gcc object... ok
checking for objdir... .libs
checking for ar... ar
checking for ranlib... ranlib
checking for strip... strip
checking if gcc supports -fno-rtti -fno-exceptions... no
checking for gcc option to produce PIC... -fPIC
checking if gcc PIC flag -fPIC works... yes
checking if gcc static flag -static works... no
checking if gcc supports -c -o file.o... yes
checking whether the gcc linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) supports shared libraries... yes
checking whether -lc should be explicitly linked in... no
checking dynamic linker characteristics... ./configure: line 15627: /usr/bin/file: No such file or directory
GNU/Linux ld.so
checking how to hardcode library paths into programs... immediate
checking whether stripping libraries is possible... yes
checking if libtool supports shared libraries... yes
checking whether to build shared libraries... yes
checking whether to build static libraries... yes
configure: creating libtool
appending configuration tag "CXX" to libtool
checking for ld used by g++... /nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld
checking if the linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) is GNU ld... yes
checking whether the g++ linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) supports shared libraries... yes
checking for g++ option to produce PIC... -fPIC
checking if g++ PIC flag -fPIC works... yes
checking if g++ static flag -static works... no
checking if g++ supports -c -o file.o... yes
checking whether the g++ linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) supports shared libraries... yes
checking dynamic linker characteristics... ./configure: line 19608: /usr/bin/file: No such file or directory
GNU/Linux ld.so
checking how to hardcode library paths into programs... immediate
appending configuration tag "F77" to libtool
checking if libtool supports shared libraries... yes
checking whether to build shared libraries... yes
checking whether to build static libraries... yes
checking for f77 option to produce PIC... -fPIC
checking if f77 PIC flag -fPIC works... yes
checking if f77 static flag -static works... no
checking if f77 supports -c -o file.o... yes
checking whether the f77 linker (/nix/store/45qrn064f92kfxnjg99z39zxda671h6f-gcc-wrapper-5.4.0/bin/ld) supports shared libraries... yes
checking dynamic linker characteristics... ./configure: line 22220: /usr/bin/file: No such file or directory
GNU/Linux ld.so
checking how to hardcode library paths into programs... immediate

Create Makefiles and configuration files
----------------------------------------

configure: creating ./config.status
config.status: creating Makefile
config.status: creating src/sundials/Makefile
config.status: creating src/nvec_ser/Makefile
config.status: creating src/cvode/Makefile
config.status: creating src/cvode/fcmix/Makefile
config.status: creating src/cvodes/Makefile
config.status: creating src/ida/Makefile
config.status: creating src/ida/fcmix/Makefile
config.status: creating src/idas/Makefile
config.status: creating src/kinsol/Makefile
config.status: creating src/kinsol/fcmix/Makefile
config.status: creating include/sundials/sundials_config.h
config.status: creating bin/sundials-config
config.status: creating config.h

***************
*   WARNING   *
***************

At least one warning was issued. Some features were disabled.

Review the configure output and/or the contents of config.log
before proceeding with the build.


------------------------------
SUNDIALS Configuration Summary
------------------------------

Configuration
-------------

  Host System:               x86_64-unknown-linux-gnu
  Build System:              x86_64-unknown-linux-gnu

  C Preprocessor:            gcc -E
  C Preprocessor Flags:      
  C Compiler:                gcc
  C Compiler Flags           -g -O2
  C Linker:                  gcc
  Linker Flags:              
  Libraries:                 -lm 

  Fortran Compiler:          f77
  Fortran Compiler Flags:    -g -O2
  Fortran Linker:            f77
  Extra Fortran Libraries:    -L/nix/store/0ki0pmc87z3hlvir0qa9d15vqfxpldsf-zsh-5.2/lib -L/nix/store/rzmv7g9i09dlns8ysg8bgwi3d49ihz8y-python3.4-PyQt-5.6/lib -L/nix/store/9jqa3qj2vimwxnzm7wqpplgr9zxnklvv-python3.4-sip-4.18.1/lib -L/nix/store/cinpvy8nqd2gzbsdzls7h76g0668q1nm-python3-3.4.5/lib -L/nix/store/hj3rayffdj7z0a1l8vaxdkkzcl13gw8v-python3.4-setuptools-26.1.1/lib -L/nix/store/yljif0227xh6x5v02hiyagb4l4hf92by-qtbase-5.6.1-1/lib -L/nix/store/jg2l9ifqj787c9k9rb0wd5dlyfl3cfjx-qtsvg-5.6.1-1/lib -L/nix/store/h7bfvm2rzaxccbp1gcvzp7xxl167ajsa-qtdeclarative-5.6.1-1/lib -L/nix/store/n7zfwbvldw4rhmhddwsaxb8nppcpp5qd-qtmultimedia-5.6.1-1/lib -L/nix/store/5yqp923cf5v3rk6573s602aj99xlbgfk-qtlocation-5.6.1-1/lib -L/nix/store/y2xqwd1pnsgphic6xxvp01zv3hxisgyv-qtsensors-5.6.1-1/lib -L/nix/store/lx5mw4h4dzqvnigc76p639bw3kdja2bd-qtwebkit-5.6.1/lib -L/nix/store/85dsf8jcy79vj9phrd2kynlq5clbya30-python3.4-numpy-1.11.1/lib -L/nix/store/qdindkmxx9z8sncwwmbnbmh0zp2rmilv-openblas-0.2.19/lib -L/nix/store/pq0ij5ldr6h9hakpgxhj0h4fnhp4929h-python3.4-scipy-0.18.0/lib -L/nix/store/f8fankrjca3sfn7bnvd8xczrplni3w66-python3.4-matplotlib-1.5.1/lib -L/nix/store/y2vzrphpmw2gwz06rpmyc3sml5vhbphx-python3.4-cycler-0.10.0/lib -L/nix/store/nhl7aci29cnw477vqnlgp3zmsll4czh6-python3.4-six-1.10.0/lib -L/nix/store/v14qkj3mx28xws268z1hfm28pcjxvh9v-python3.4-dateutil-2.4.2/lib -L/nix/store/i7g8cjw6i7g64i68p4kb5kxj60z52n75-python3.4-nose-1.3.7/lib -L/nix/store/y2vdxi33834wq9wzl8k8748nr8q039l9-python3.4-coverage-4.0.1/lib -L/nix/store/ib2sn3a5mjcwiaiplsvbn62xw64yrnqh-python3.4-pyparsing-2.1.8/lib -L/nix/store/1jlira3d20bgkhsgbrvxbmxkvwilhmqz-python3.4-tornado-4.4.1/lib -L/nix/store/grqgij3wri501sh9v04xh4kmf1ckwssi-python3.4-backports_abc-0.4/lib -L/nix/store/jn43jrf4lrlzih4v5b44dz2qz649f1kj-python3.4-backports.ssl_match_hostname-3.5.0.1/lib -L/nix/store/lihw4plwgynlpdpd371gxv82mb7600ds-python3.4-certifi-2016.2.28/lib -L/nix/store/f6rx50qmym5sp02zdzrjf0qq1ypdfg39-python3.4-singledispatch-3.4.0.3/lib -L/nix/store/6lcyv964bl4b424jsr8pkqi17yfhncnl-freetype-2.6.5-dev/lib -L/nix/store/l0xrpsihd7yp97cfh1af4lvi6vmdr35h-zlib-1.2.8-dev/lib -L/nix/store/b5mwbrx8cldkchiqgwgkaagw91xfjr89-zlib-1.2.8/lib -L/nix/store/vqplqg2yxwzd7j27535kilgb6raxni70-bzip2-1.0.6.0.1-dev/lib -L/nix/store/9jplq6zqlfixn2drgq07jgvcabjrmn47-bzip2-1.0.6.0.1/lib -L/nix/store/rv2iwsydhjy91j83p2b7x6rcp85ry25j-libpng-apng-1.6.23-dev/lib -L/nix/store/rapy57vhj8fckrh7wbpm5fzlls62k6yq-libpng-apng-1.6.23/lib -L/nix/store/07fdvyiml8hayl2xs1f7vldn8nlh2gkb-freetype-2.6.5/lib -L/nix/store/65rja57bmh1zm68jnrgkg6z5zp1d3jy5-python3.4-pkgconfig-1.1.0/lib -L/nix/store/mjpd5k1k27c6q4sy5nzs72r5cny1s1lm-python3.4-mock-1.3.0/lib -L/nix/store/2rba3j52qz6ycrq6giv44mxxxri7gyp6-python3.4-funcsigs-0.4/lib -L/nix/store/rk6s9wlvyvwwygxjvwpjrb7wsm95mvg1-python3.4-pbr-1.8.1/lib -L/nix/store/4kzs6bkbnn011nrmlr0hndwkbb32p9vl-python3.4-pytz-2016.6.1/lib -L/nix/store/91aa320ql5j3mj89ssvf7ydb5721gyvp-python3.4-ipython-5.1.0/lib -L/nix/store/pflca1yck21nw3d49369nw3dhv2baarp-python3.4-decorator-4.0.9/lib -L/nix/store/n3yzmjlcwc8xg0kmzwmxrw1km5l01anq-python3.4-pickleshare-0.5/lib -L/nix/store/4qfk8jzbkdd13wz0d41fwj25v6g0sp86-python3.4-path.py-8.1.2/lib -L/nix/store/lr03mr21b05b8hzydyl5a8d809s2fzkp-python3.4-prompt_toolkit-1.0.3/lib -L/nix/store/58lw997wwjm3rd9machgvbdw1k8janh4-python3.4-docopt-0.6.2/lib -L/nix/store/d6a4al3zcwm0g0nwfbcmzpcn5anpv4a1-python3.4-wcwidth-0.1.6/lib -L/nix/store/5iagc7yncmbrrc6x7ngbw5iksdlr502x-python3.4-Pygments-2.1.3/lib -L/nix/store/2h2ah17ynj561g488xmy2ffkxk2rhiam-python3.4-docutils-0.12/lib -L/nix/store/9p0m4h47qwaz23rhmv8l3blidjxdf5dm-python3.4-simplegeneric-0.8.1/lib -L/nix/store/883l2yr7pzylygl2r7pripxni60a9inw-python3.4-traitlets-4.2.2/lib -L/nix/store/3snkfkwli6s0xh92czkswxzjq5l4r57g-python3.4-ipython_genutils-0.1.0/lib -L/nix/store/gkkvmlrav8rlhy0v1ibq0fck00c92rj6-python3.4-requests-2.11.1/lib -L/nix/store/2gpryd609xs1cxnib7w8v0w85ncppjgx-python3.4-pexpect-3.3/lib -L/nix/store/nchfwfk19z6bx37id9f3zr845w47q76g-ghc-8.0.1/lib -L/nix/store/w5ghbhrspck383b9cxrzy65xkdsy5s49-julia-0.4.6/lib -L/nix/store/26ps1nri7v0gcd0bv91xyw1bz1fqnq9h-llvm-3.7.1/lib -L/nix/store/yfm40v49qvfmh1mfn6syd931807jbk1n-ncurses-6.0-dev/lib -L/nix/store/m4fscyf6j97wh5yfi6gww86x79jsw321-ncurses-6.0/lib -L/nix/store/6fix3zqpnahyml8zp2sxi2rwan55rgb8-glibc-2.24/lib -L/nix/store/zy84lvl29mxn88fgb02sw4fzl95yp0dz-gfortran-5.4.0-lib/lib -L/nix/store/2qcmna39jkddhpdiw2lbmvbg699b6ijn-gfortran-wrapper-5.4.0/bin -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0 -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0/../../../../lib64 -L/nix/store/8g80rszia5czn68f45i1b6yb63fyj5j5-gfortran-5.4.0/lib/gcc/x86_64-unknown-linux-gnu/5.4.0/../../.. -lgfortran -lm -lgcc_s -lquadmath

  srcdir:                    /home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0
  builddir:                  /home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0
  prefix:                    /home/kosh/.julia/v0.4/Sundials/deps/usr
  exec_prefix:               ${prefix}
  includedir:                ${prefix}/include
  libdir:                    ${exec_prefix}/lib

Modules
-------

  CVODE  FCVODE
  CVODES
  IDA    FIDA
  IDAS
  KINSOL FKINSOL

  Type 'make' and then 'make install' to build and install SUNDIALS 2.5.0.

----------------------------------
Finished SUNDIALS Configure Script
----------------------------------

INFO: Changing Directory to /home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/bin
mkdir -p -- /home/kosh/.julia/v0.4/Sundials/deps/usr/bin
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c  ./bin/sundials-config    /home/kosh/.julia/v0.4/Sundials/deps/usr/bin/
----------------------
Install src/sundials...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../config/mkinstalldirs  /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials
mkdir -p -- /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_direct.h     /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_band.h       /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_dense.h      /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_iterative.h  /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_spgmr.h      /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_spbcgs.h     /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_sptfqmr.h    /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_math.h       /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_types.h      /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_nvector.h    /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/sundials/sundials_fnvector.h   /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ../..//include/sundials/sundials_config.h   /home/kosh/.julia/v0.4/Sundials/deps/usr/include/sundials/
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'

----------------------
Install src/nvec_ser...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/nvec_ser'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_direct.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_direct.c  -fPIC -DPIC -o .libs/sundials_direct.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_direct.c -o sundials_direct.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_band.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_band.c  -fPIC -DPIC -o .libs/sundials_band.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_band.c -o sundials_band.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_dense.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_dense.c  -fPIC -DPIC -o .libs/sundials_dense.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_dense.c -o sundials_dense.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_iterative.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_iterative.c  -fPIC -DPIC -o .libs/sundials_iterative.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_iterative.c -o sundials_iterative.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_math.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_math.c  -fPIC -DPIC -o .libs/sundials_math.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_math.c -o sundials_math.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_nvector.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_nvector.c  -fPIC -DPIC -o .libs/sundials_nvector.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_nvector.c -o sundials_nvector.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_spgmr.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_spgmr.c  -fPIC -DPIC -o .libs/sundials_spgmr.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_spgmr.c -o sundials_spgmr.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_spbcgs.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_spbcgs.c  -fPIC -DPIC -o .libs/sundials_spbcgs.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_spbcgs.c -o sundials_spbcgs.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./sundials_sptfqmr.c
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_sptfqmr.c  -fPIC -DPIC -o .libs/sundials_sptfqmr.o
 gcc -I./../../include -I../..//include -g -O2 -c ./sundials_sptfqmr.c -o sundials_sptfqmr.o >/dev/null 2>&1
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./nvector_serial.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./nvector_serial.c  -fPIC -DPIC -o .libs/nvector_serial.o
 gcc -I./../../include -I../..//include -g -O2 -c ./nvector_serial.c -o nvector_serial.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=link gcc -g -O2 -o libsundials_nvecserial.la nvector_serial.lo ../..//src/sundials/sundials_math.lo -rpath /home/kosh/.julia/v0.4/Sundials/deps/usr/lib  -lm  -version-info 0:2:0
gcc -shared  .libs/nvector_serial.o ../..//src/sundials/.libs/sundials_math.o  -lm  -Wl,-soname -Wl,libsundials_nvecserial.so.0 -o .libs/libsundials_nvecserial.so.0.0.2
(cd .libs && rm -f libsundials_nvecserial.so.0 && ln -s libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so.0)
(cd .libs && rm -f libsundials_nvecserial.so && ln -s libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so)
ar cru .libs/libsundials_nvecserial.a  nvector_serial.o ../..//src/sundials/sundials_math.o
ar: `u' modifier ignored since `D' is the default (see `U')
ranlib .libs/libsundials_nvecserial.a
creating libsundials_nvecserial.la
(cd .libs && rm -f libsundials_nvecserial.la && ln -s ../libsundials_nvecserial.la libsundials_nvecserial.la)
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./fnvector_serial.c
 gcc -I./../../include -I../..//include -g -O2 -c ./fnvector_serial.c  -fPIC -DPIC -o .libs/fnvector_serial.o
 gcc -I./../../include -I../..//include -g -O2 -c ./fnvector_serial.c -o fnvector_serial.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=link gcc -g -O2 -o libsundials_fnvecserial.la fnvector_serial.lo ../..//src/sundials/sundials_math.lo -rpath /home/kosh/.julia/v0.4/Sundials/deps/usr/lib  -lm  -version-info 0:2:0
gcc -shared  .libs/fnvector_serial.o ../..//src/sundials/.libs/sundials_math.o  -lm  -Wl,-soname -Wl,libsundials_fnvecserial.so.0 -o .libs/libsundials_fnvecserial.so.0.0.2
(cd .libs && rm -f libsundials_fnvecserial.so.0 && ln -s libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so.0)
(cd .libs && rm -f libsundials_fnvecserial.so && ln -s libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so)
ar cru .libs/libsundials_fnvecserial.a  fnvector_serial.o ../..//src/sundials/sundials_math.o
ar: `u' modifier ignored since `D' is the default (see `U')
ranlib .libs/libsundials_fnvecserial.a
creating libsundials_fnvecserial.la
(cd .libs && rm -f libsundials_fnvecserial.la && ln -s ../libsundials_fnvecserial.la libsundials_fnvecserial.la)
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/include/nvector
mkdir -p -- /home/kosh/.julia/v0.4/Sundials/deps/usr/include/nvector
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
mkdir -p -- /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=install /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c libsundials_nvecserial.la /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_nvecserial.so.0.0.2 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_nvecserial.so.0.0.2
(cd /home/kosh/.julia/v0.4/Sundials/deps/usr/lib && { ln -s -f libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so.0 || { rm -f libsundials_nvecserial.so.0 && ln -s libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so.0; }; })
(cd /home/kosh/.julia/v0.4/Sundials/deps/usr/lib && { ln -s -f libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so || { rm -f libsundials_nvecserial.so && ln -s libsundials_nvecserial.so.0.0.2 libsundials_nvecserial.so; }; })
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_nvecserial.lai /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_nvecserial.la
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_nvecserial.a /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_nvecserial.a
chmod 644 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_nvecserial.a
ranlib /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_nvecserial.a
PATH="$PATH:/sbin" ldconfig -n /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
----------------------------------------------------------------------
Libraries have been installed in:
   /home/kosh/.julia/v0.4/Sundials/deps/usr/lib

If you ever happen to want to link against installed libraries
in a given directory, LIBDIR, you must either use libtool, and
specify the full pathname of the library, or use the `-LLIBDIR'
flag during linking and do at least one of the following:
   - add LIBDIR to the `LD_LIBRARY_PATH' environment variable
     during execution
   - add LIBDIR to the `LD_RUN_PATH' environment variable
     during linking
   - use the `-Wl,--rpath -Wl,LIBDIR' linker flag

See any operating system documentation about shared libraries for
more information, such as the ld(1) and ld.so(8) manual pages.
----------------------------------------------------------------------
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c -m 644 ./../../include/nvector/nvector_serial.h /home/kosh/.julia/v0.4/Sundials/deps/usr/include/nvector/
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=install /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c libsundials_fnvecserial.la /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fnvecserial.so.0.0.2 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fnvecserial.so.0.0.2
(cd /home/kosh/.julia/v0.4/Sundials/deps/usr/lib && { ln -s -f libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so.0 || { rm -f libsundials_fnvecserial.so.0 && ln -s libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so.0; }; })
(cd /home/kosh/.julia/v0.4/Sundials/deps/usr/lib && { ln -s -f libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so || { rm -f libsundials_fnvecserial.so && ln -s libsundials_fnvecserial.so.0.0.2 libsundials_fnvecserial.so; }; })
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fnvecserial.lai /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fnvecserial.la
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fnvecserial.a /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fnvecserial.a
chmod 644 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fnvecserial.a
ranlib /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fnvecserial.a
PATH="$PATH:/sbin" ldconfig -n /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
----------------------------------------------------------------------
Libraries have been installed in:
   /home/kosh/.julia/v0.4/Sundials/deps/usr/lib

If you ever happen to want to link against installed libraries
in a given directory, LIBDIR, you must either use libtool, and
specify the full pathname of the library, or use the `-LLIBDIR'
flag during linking and do at least one of the following:
   - add LIBDIR to the `LD_LIBRARY_PATH' environment variable
     during execution
   - add LIBDIR to the `LD_RUN_PATH' environment variable
     during linking
   - use the `-Wl,--rpath -Wl,LIBDIR' linker flag

See any operating system documentation about shared libraries for
more information, such as the ld(1) and ld.so(8) manual pages.
----------------------------------------------------------------------
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/nvec_ser'

----------------------
Install src/cvode...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Nothing to be done for 'lib_without_bl'.
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./cvode.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./cvode.c  -fPIC -DPIC -o .libs/cvode.o
./cvode.c: In function ‘CVProcessError’:
./cvode.c:4139:5: error: format not a string literal and no format arguments [-Werror=format-security]
     fprintf(stderr, msgfmt);
     ^
cc1: some warnings being treated as errors
make[1]: *** [Makefile:146: cvode.lo] Error 1
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode'

----------------------
Install src/cvode/fcmix...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvode.c
mkdir .libs
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvode.c  -fPIC -DPIC -o .libs/fcvode.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvode.c -o fcvode.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvband.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvband.c  -fPIC -DPIC -o .libs/fcvband.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvband.c -o fcvband.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvdense.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvdense.c  -fPIC -DPIC -o .libs/fcvdense.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvdense.c -o fcvdense.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvjtimes.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvjtimes.c  -fPIC -DPIC -o .libs/fcvjtimes.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvjtimes.c -o fcvjtimes.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvpreco.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvpreco.c  -fPIC -DPIC -o .libs/fcvpreco.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvpreco.c -o fcvpreco.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbbd.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbbd.c  -fPIC -DPIC -o .libs/fcvbbd.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbbd.c -o fcvbbd.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbp.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbp.c  -fPIC -DPIC -o .libs/fcvbp.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvbp.c -o fcvbp.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvroot.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvroot.c  -fPIC -DPIC -o .libs/fcvroot.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvroot.c -o fcvroot.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvewt.c
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvewt.c  -fPIC -DPIC -o .libs/fcvewt.o
 gcc -I./../../../include -I./../../../src/cvode -I../../..//include -g -O2 -c ./fcvewt.c -o fcvewt.o >/dev/null 2>&1
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=link gcc -g -O2 -o libsundials_fcvode.la fcvode.lo fcvband.lo fcvdense.lo fcvjtimes.lo fcvpreco.lo fcvbbd.lo fcvbp.lo fcvroot.lo fcvewt.lo -rpath /home/kosh/.julia/v0.4/Sundials/deps/usr/lib  -lm  -static -version-info 0:1:0
ar cru .libs/libsundials_fcvode.a  fcvode.o fcvband.o fcvdense.o fcvjtimes.o fcvpreco.o fcvbbd.o fcvbp.o fcvroot.o fcvewt.o
ar: `u' modifier ignored since `D' is the default (see `U')
ranlib .libs/libsundials_fcvode.a
creating libsundials_fcvode.la
(cd .libs && rm -f libsundials_fcvode.la && ln -s ../libsundials_fcvode.la libsundials_fcvode.la)
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../../config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=install /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c libsundials_fcvode.la /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fcvode.lai /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fcvode.la
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fcvode.a /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fcvode.a
chmod 644 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fcvode.a
ranlib /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fcvode.a
PATH="$PATH:/sbin" ldconfig -n /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
----------------------------------------------------------------------
Libraries have been installed in:
   /home/kosh/.julia/v0.4/Sundials/deps/usr/lib

If you ever happen to want to link against installed libraries
in a given directory, LIBDIR, you must either use libtool, and
specify the full pathname of the library, or use the `-LLIBDIR'
flag during linking and do at least one of the following:
   - add LIBDIR to the `LD_LIBRARY_PATH' environment variable
     during execution
   - add LIBDIR to the `LD_RUN_PATH' environment variable
     during linking
   - use the `-Wl,--rpath -Wl,LIBDIR' linker flag

See any operating system documentation about shared libraries for
more information, such as the ld(1) and ld.so(8) manual pages.
----------------------------------------------------------------------
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvode/fcmix'

----------------------
Install src/cvodes...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvodes'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Nothing to be done for 'lib_without_bl'.
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./cvodes.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./cvodes.c  -fPIC -DPIC -o .libs/cvodes.o
./cvodes.c: In function ‘cvProcessError’:
./cvodes.c:8961:21: error: format not a string literal and no format arguments [-Werror=format-security]
     fprintf(stderr, msg);
                     ^
cc1: some warnings being treated as errors
make[1]: *** [Makefile:146: cvodes.lo] Error 1
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/cvodes'

----------------------
Install src/ida...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Nothing to be done for 'lib_without_bl'.
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./ida.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./ida.c  -fPIC -DPIC -o .libs/ida.o
./ida.c: In function ‘IDAProcessError’:
./ida.c:3381:5: error: format not a string literal and no format arguments [-Werror=format-security]
     fprintf(stderr, msgfmt);
     ^
cc1: some warnings being treated as errors
make[1]: *** [Makefile:142: ida.lo] Error 1
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida'

----------------------
Install src/ida/fcmix...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fida.c
mkdir .libs
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fida.c  -fPIC -DPIC -o .libs/fida.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fida.c -o fida.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaband.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaband.c  -fPIC -DPIC -o .libs/fidaband.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaband.c -o fidaband.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidadense.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidadense.c  -fPIC -DPIC -o .libs/fidadense.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidadense.c -o fidadense.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidajtimes.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidajtimes.c  -fPIC -DPIC -o .libs/fidajtimes.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidajtimes.c -o fidajtimes.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidapreco.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidapreco.c  -fPIC -DPIC -o .libs/fidapreco.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidapreco.c -o fidapreco.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaewt.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaewt.c  -fPIC -DPIC -o .libs/fidaewt.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaewt.c -o fidaewt.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaroot.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaroot.c  -fPIC -DPIC -o .libs/fidaroot.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidaroot.c -o fidaroot.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidabbd.c
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidabbd.c  -fPIC -DPIC -o .libs/fidabbd.o
 gcc -I./../../../include -I./../../../src/ida -I../../..//include -g -O2 -c ./fidabbd.c -o fidabbd.o >/dev/null 2>&1
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=link gcc -g -O2 -o libsundials_fida.la fida.lo fidaband.lo fidadense.lo fidajtimes.lo fidapreco.lo fidaewt.lo fidaroot.lo fidabbd.lo -rpath /home/kosh/.julia/v0.4/Sundials/deps/usr/lib  -lm  -static -version-info 1:0:0
ar cru .libs/libsundials_fida.a  fida.o fidaband.o fidadense.o fidajtimes.o fidapreco.o fidaewt.o fidaroot.o fidabbd.o
ar: `u' modifier ignored since `D' is the default (see `U')
ranlib .libs/libsundials_fida.a
creating libsundials_fida.la
(cd .libs && rm -f libsundials_fida.la && ln -s ../libsundials_fida.la libsundials_fida.la)
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../../config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=install /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c libsundials_fida.la /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fida.lai /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fida.la
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fida.a /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fida.a
chmod 644 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fida.a
ranlib /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fida.a
PATH="$PATH:/sbin" ldconfig -n /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
----------------------------------------------------------------------
Libraries have been installed in:
   /home/kosh/.julia/v0.4/Sundials/deps/usr/lib

If you ever happen to want to link against installed libraries
in a given directory, LIBDIR, you must either use libtool, and
specify the full pathname of the library, or use the `-LLIBDIR'
flag during linking and do at least one of the following:
   - add LIBDIR to the `LD_LIBRARY_PATH' environment variable
     during execution
   - add LIBDIR to the `LD_RUN_PATH' environment variable
     during linking
   - use the `-Wl,--rpath -Wl,LIBDIR' linker flag

See any operating system documentation about shared libraries for
more information, such as the ld(1) and ld.so(8) manual pages.
----------------------------------------------------------------------
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/ida/fcmix'

----------------------
Install src/idas...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/idas'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Nothing to be done for 'lib_without_bl'.
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./idas.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./idas.c  -fPIC -DPIC -o .libs/idas.o
./idas.c: In function ‘IDAProcessError’:
./idas.c:7182:5: error: format not a string literal and no format arguments [-Werror=format-security]
     fprintf(stderr, msgfmt);
     ^
cc1: some warnings being treated as errors
make[1]: *** [Makefile:142: idas.lo] Error 1
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/idas'

----------------------
Install src/kinsol...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol'
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[3]: Nothing to be done for 'lib_without_bl'.
make[3]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/sundials'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../..//libtool --mode=compile gcc  -I./../../include -I../..//include -g -O2 -c ./kinsol.c
mkdir .libs
 gcc -I./../../include -I../..//include -g -O2 -c ./kinsol.c  -fPIC -DPIC -o .libs/kinsol.o
./kinsol.c: In function ‘KINProcessError’:
./kinsol.c:1879:5: error: format not a string literal and no format arguments [-Werror=format-security]
     fprintf(stderr, msgfmt);
     ^
cc1: some warnings being treated as errors
make[1]: *** [Makefile:142: kinsol.lo] Error 1
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol'

----------------------
Install src/kinsol/fcmix...
----------------------
make[1]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinsol.c
mkdir .libs
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinsol.c  -fPIC -DPIC -o .libs/fkinsol.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinsol.c -o fkinsol.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkindense.c
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkindense.c  -fPIC -DPIC -o .libs/fkindense.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkindense.c -o fkindense.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinband.c
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinband.c  -fPIC -DPIC -o .libs/fkinband.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinband.c -o fkinband.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinpreco.c
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinpreco.c  -fPIC -DPIC -o .libs/fkinpreco.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinpreco.c -o fkinpreco.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinjtimes.c
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinjtimes.c  -fPIC -DPIC -o .libs/fkinjtimes.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinjtimes.c -o fkinjtimes.o >/dev/null 2>&1
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=compile gcc  -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinbbd.c
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinbbd.c  -fPIC -DPIC -o .libs/fkinbbd.o
 gcc -I./../../../include -I./../../../src/kinsol -I../../..//include -g -O2 -c ./fkinbbd.c -o fkinbbd.o >/dev/null 2>&1
make[2]: Entering directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=link gcc -g -O2 -o libsundials_fkinsol.la fkinsol.lo fkindense.lo fkinband.lo fkinpreco.lo fkinjtimes.lo fkinbbd.lo -rpath /home/kosh/.julia/v0.4/Sundials/deps/usr/lib  -lm  -static -version-info 0:1:0
ar cru .libs/libsundials_fkinsol.a  fkinsol.o fkindense.o fkinband.o fkinpreco.o fkinjtimes.o fkinbbd.o
ar: `u' modifier ignored since `D' is the default (see `U')
ranlib .libs/libsundials_fkinsol.a
creating libsundials_fkinsol.la
(cd .libs && rm -f libsundials_fkinsol.la && ln -s ../libsundials_fkinsol.la libsundials_fkinsol.la)
make[2]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol/fcmix'
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ./../../../config/mkinstalldirs /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/nyj6xd7s1n1w8c0xdwk5ddhi7bjcyi9x-bash-4.3-p46/bin/bash ../../..//libtool --mode=install /nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c libsundials_fkinsol.la /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fkinsol.lai /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fkinsol.la
/nix/store/zhhb02yrp03xzfrpk06ixb0gmwrjmjff-coreutils-8.25/bin/install -c .libs/libsundials_fkinsol.a /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fkinsol.a
chmod 644 /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fkinsol.a
ranlib /home/kosh/.julia/v0.4/Sundials/deps/usr/lib/libsundials_fkinsol.a
PATH="$PATH:/sbin" ldconfig -n /home/kosh/.julia/v0.4/Sundials/deps/usr/lib
----------------------------------------------------------------------
Libraries have been installed in:
   /home/kosh/.julia/v0.4/Sundials/deps/usr/lib

If you ever happen to want to link against installed libraries
in a given directory, LIBDIR, you must either use libtool, and
specify the full pathname of the library, or use the `-LLIBDIR'
flag during linking and do at least one of the following:
   - add LIBDIR to the `LD_LIBRARY_PATH' environment variable
     during execution
   - add LIBDIR to the `LD_RUN_PATH' environment variable
     during linking
   - use the `-Wl,--rpath -Wl,LIBDIR' linker flag

See any operating system documentation about shared libraries for
more information, such as the ld(1) and ld.so(8) manual pages.
----------------------------------------------------------------------
make[1]: Leaving directory '/home/kosh/.julia/v0.4/Sundials/deps/src/sundials-2.5.0/src/kinsol/fcmix'

==============================[ ERROR: Sundials ]===============================

LoadError: Provider BinDeps.BuildProcess failed to satisfy dependency libsundials_cvodes
while loading /home/kosh/.julia/v0.4/Sundials/deps/build.jl, in expression starting on line 37

================================================================================

=======================================================================[ BUILD ERRORS ]========================================================================

WARNING: Sundials had build errors.

 - packages with build errors remain installed in /home/kosh/.julia/v0.4
 - build the package(s) and all dependencies with `Pkg.build("Sundials")`
 - build a single package by running its `deps/build.jl` script

===============================================================================================================================================================
INFO: Package database updated

julia> 

CVodeFree has correct type but gets called incorrectly

CVodeFree takes a pointer to a void* mem object from CVodeCreate, not the object itself.

So the correct call is

ccall((:CVodeFree, Sundials.libsundials_cvodes), Void, (Ptr{Ptr{Void}},), &mem)

not as it is called now if you try to pass mem to it:

CVodeFree(mem)
==> ccall((:CVodeFree, Sundials.libsundials_cvodes), Void, (Ptr{Ptr{Void}},), mem)

This bug leads to unexpected segfaults when freeing resources. CVodeFree looks like this:

SUNDIALS_EXPORT void CVodeFree(void **cvode_mem);

Sparse user-defined jacobian

Is there a way to provide the user-defined jacobian in sparse matrix form. Though the sundials ida documentation states this is possible, I can't seem to find this function implemented in src/ida.jl

getting error on running update

I am getting an error on running package update.

julia> Pkg.update()
Branch devel set up to track remote branch devel from origin.
Already up-to-date.
MESSAGE: Upgrading Sundials: v0.0.0 => v0.0.0
error: pathspec '"eec27d643765eeb075dd82dd7b8d57f13becf2da\n "' did not match any file(s) known to git.
ERROR: failed process: Process(`git checkout -q 'eec27d643765eeb075dd82dd7b8d57f13becf2da
 '`, ProcessExited(1)) [1]
 in error at error.jl:22
 in pipeline_error at process.jl:394
 in run at process.jl:384
 in anonymous at no file:327
 in cd at file.jl:26
 in _resolve at pkg.jl:326
 in anonymous at no file:592
 in cd at file.jl:26
 in cd_pkgdir at pkg.jl:42
 in update at pkg.jl:563

ODE Status Monitoring

In Matlab we have 'odeprint' which is very handy in monitoring the Progress of ode, is there any equivalent thing for Sundials-Julia?

Make Sundials.jl API compatible with ODE.jl

This package has seen little updates since it was first created, long long ago, before keyword arguments was part of Julia.

The recent API discussions in ODE.jl, has resulted in an API draft, that should (probably) be followed in Sundials.jl aswell. The first PR in this direction has already been merged.

pass user jacobian to cvode

Hi,

I am looking to implement the required code to pass the rhs jacobian to sundials to avoid expensive finite-difference approximations. According to the example cvde_Roberts_dns.jl, at line 26 (this link) this needs implementing a wrapper from Sundials._DlsMat to Matrix and the user jacobian wrapper.

My strategy for the latter is as follows:

# Type to store user rhs and jacobian, no data are provided, 
# as these can be defined using efficient closures in v0.5.
type FunJac{F, J}
    fun::F
    jac::J
end
funjac(f, J) = FunJac(f, J)

function cvodefunjac(t::Float64, 
                     x::N_Vector, 
                     ẋ::N_Vector, 
                     funjac::FunJac)
    funjac.fun(t, convert(Vector, x), convert(Vector, ẋ))
    return CV_SUCCESS
end

function cvodefunjac(N::Clong, 
                     t::realtype, 
                     x::N_Vector, 
                     ẋ::N_Vector, 
                     J::DlsMat,
                     userjac::FunJac,
                     tmp1::N_Vector, 
                     tmp2::N_Vector, 
                     tmp3::N_Vector)
    funjac.jac(t, convert(Matrix, J), convert(Vector, x))
    return CV_SUCCESS
end

i.e. the same FunJac type is used to store the rhs and the jacobian. Appropriate julia callbacks are then defined for the rhs and jacobian using cfunction and dispatch, along the lines of:

fun = cfunction(cvodefunjac, 
                Cint, 
                (realtype, 
                 N_Vector, 
                 N_Vector, 
                 Ref{typeof(funjac)}))

jac = cfunction(cvodefunjac, 
                Cint, 
                (Clong, 
                 realtype, 
                 N_Vector, 
                 N_Vector, 
                 DlsMat,
                 Ref{typeof(funjac)}, 
                 N_Vector, 
                 N_Vector, 
                 N_Vector))

ynv = NVector(copy(x₀))
CVodeInit(mem, fun, 0.0, convert(N_Vector, ynv))
CVodeSetUserData(mem, funjac)
CVDlsSetDenseJacFn(mem, jac)

Now the missing piece is how to define the convert(::Type{Matrix}, J::DlsMat) method called in the jacobian. Any pointers (no pun intended) are welcome. Is the code in cvode_Roberts_dns.jl a valid approach? It looks beyond my CJulia-fu skills...

I am actually writing this as part of a personal package but could contribute it to Sundials if requested.

Sundials slow on 0.5

I just started playing around with 0.5-rc2 and was excited that the speed of my rhs function easily doubled :)
But Sundials itself does really bad now, needing 9x the time and lots >20x more allocations:

using Sundials, BenchmarkTools
@benchmark include(Pkg.dir("Sundials", "test/runtests.jl"))

0.4.6:

BenchmarkTools.Trial: 
  samples:          22
  evals/sample:     1
  time tolerance:   5.00%
  memory tolerance: 1.00%
  memory estimate:  3.21 mb
  allocs estimate:  75805
  minimum time:     227.84 ms (0.00% GC)
  median time:      233.52 ms (0.00% GC)
  mean time:        238.09 ms (1.02% GC)
  maximum time:     275.99 ms (6.89% GC)

0.5-rc2:

BenchmarkTools.Trial: 
  samples:          3
  evals/sample:     1
  time tolerance:   5.00%
  memory tolerance: 1.00%
  memory estimate:  61.24 mb
  allocs estimate:  441084
  minimum time:     1.77 s (0.87% GC)
  median time:      1.78 s (1.69% GC)
  mean time:        1.78 s (1.42% GC)
  maximum time:     1.79 s (1.69% GC)

CVodeReInit arguments

It looks as if there's a glitch in the CVodeReInit syntax in Sundials.jl [lines 102-3]: the second argument needs to be removed (after which it seems to work ok in a trivial test example).

[Caveat: I'm new to Julia, just having a play as a possible addition to/replacement of my Matlab/Octave needs. Also never used github before, so pls forgive wrong approach/lack of a PR.]

installation/configuration on Mac OS

I do not know how all this works; maybe I just misunderstood something. Details of the problem:

I installed Livermore Sundials 2.5.0.
System: Mac OSX 10.7.5, Sundials 0.1.0, Julia 0.3 release candidate 2;
Apple LLVM version 4.2 (clang-425.0.28) (based on LLVM 3.2svn)

Lightly annotated Screen capture of what happened:

julia> Pkg.update() <- latest Sundials
INFO: Updating METADATA...
INFO: Updating BinDeps...
INFO: Computing changes...
INFO: No packages to install, update or remove

julia> using Sundials

julia> Pkg.test("Sundials")
INFO: Testing Sundials
== start cvode example

signal (11): Segmentation fault: 11
N_VGetArrayPointer at /usr/local/lib/libsundials_cvodes.dylib (unknown line)
cvDlsDenseDQJac at /usr/local/lib/libsundials_cvodes.dylib (unknown line)
cvDenseSetup at /usr/local/lib/libsundials_cvode.dylib (unknown line)
CVode at /usr/local/lib/libsundials_cvode.dylib (unknown line)
cvode at /Users/travis/.julia/v0.3/Sundials/src/Sundials.jl:274
julia_cvode;19767 at (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/gf.c:1416
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:59
eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:207
eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:215
eval_body at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:541
jl_interpret_toplevel_thunk_with at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:569
jl_toplevel_eval_flex at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:451
jl_parse_eval_all at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:541
jl_load at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:578
include at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/./julia.h:980
include_from_node1 at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/./julia.h:980
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:59
eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:207
jl_toplevel_eval_flex at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:493
jl_parse_eval_all at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:541
jl_load at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:578
include at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/./julia.h:980
include_from_node1 at loading.jl:128
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/gf.c:1416
process_options at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
_start at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
_start at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/./julia.h:980
true_main at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/julia (unknown line)
julia_trampoline at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/init.c:1002
==============================[ ERROR: Sundials ]===============================

failed process: Process(/Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/julia /Users/travis/.julia/v0.3/Sundials/test/runtests.jl, ProcessSignaled(11)) [0]

INFO: No packages to install, update or remove
ERROR: Sundials had test errors
in error at error.jl:21
in test at pkg/entry.jl:711
in anonymous at pkg/dir.jl:28
in cd at /Applications/Julia-0.3.0-rc2-3ddbaa1c03.app/Contents/Resources/julia/bin/../lib/julia/sys.dylib
in cd at pkg/dir.jl:28
in test at pkg.jl:67


another example:

ulia> using Sundials

julia> function f(t, y, ydot)
ydot[1] = -0.04_y[1] + 1.0e4_y[2]_y[3]
ydot[3] = 3.0e7_y[2]*y[2]
ydot[2] = -ydot[1] - ydot[3]
end
f (generic function with 1 method)

julia> t = [0.0, 4 * logspace(-1., 7., 9)]
10-element Array{Float64,1}:
0.0
0.4
4.0
40.0
400.0
4000.0
40000.0
400000.0
4.0e6
4.0e7

julia> res = Sundials.cvode(f, [1.0, 0.0, 0.0], t)

signal (11): Segmentation fault: 11
N_VGetArrayPointer at /usr/local/lib/libsundials_cvodes.dylib (unknown line)
cvDlsDenseDQJac at /usr/local/lib/libsundials_cvodes.dylib (unknown line)
cvDenseSetup at /usr/local/lib/libsundials_cvode.dylib (unknown line)
CVode at /usr/local/lib/libsundials_cvode.dylib (unknown line)
cvode at /Users/travis/.julia/v0.3/Sundials/src/Sundials.jl:274
julia_cvode;20456 at (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/gf.c:1416
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:59
eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:207
eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:215
eval_body at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:541
jl_interpret_toplevel_thunk_with at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/interpreter.c:569
jl_toplevel_eval_flex at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/toplevel.c:451
jl_f_top_eval at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/builtins.c:396
eval_user_input at REPL.jl:54
jlcall_eval_user_input;19771 at (unknown line)
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/./julia.h:980
anonymous at task.jl:96
jl_apply at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/task.c:427
julia_trampoline at /Users/vagrant/tmp/julia-packaging/osx10.7+/julia-master/src/init.c:1002

[Process completed]

Recommend Projects

  • React photo React

    A declarative, efficient, and flexible JavaScript library for building user interfaces.

  • Vue.js photo Vue.js

    🖖 Vue.js is a progressive, incrementally-adoptable JavaScript framework for building UI on the web.

  • Typescript photo Typescript

    TypeScript is a superset of JavaScript that compiles to clean JavaScript output.

  • TensorFlow photo TensorFlow

    An Open Source Machine Learning Framework for Everyone

  • Django photo Django

    The Web framework for perfectionists with deadlines.

  • D3 photo D3

    Bring data to life with SVG, Canvas and HTML. 📊📈🎉

Recommend Topics

  • javascript

    JavaScript (JS) is a lightweight interpreted programming language with first-class functions.

  • web

    Some thing interesting about web. New door for the world.

  • server

    A server is a program made to process requests and deliver data to clients.

  • Machine learning

    Machine learning is a way of modeling and interpreting data that allows a piece of software to respond intelligently.

  • Game

    Some thing interesting about game, make everyone happy.

Recommend Org

  • Facebook photo Facebook

    We are working to build community through open source technology. NB: members must have two-factor auth.

  • Microsoft photo Microsoft

    Open source projects and samples from Microsoft.

  • Google photo Google

    Google ❤️ Open Source for everyone.

  • D3 photo D3

    Data-Driven Documents codes.