Issues with DifferentialEquations compiling

Hello,
I am currently learning Julia for my bachelor thesis and have ran into a problem with using DifferentialEquations.


When I try to compile DifferentialEquations, these four dependencies error and I cannot see to get around this. The result is I am unable to solve even a simple ODE (I am using JupyterNotebook), and therefore I cannot move further with my thesis.
Any help is appreciated

How did you install Julia? If not via juliaup or a binary from julialang.org then please uninstall Julia and use one these methods.

Please run ]precompile and post the resulting output enclosed in ``` so we can see the actual error message.
Additionally, please post the output of ]status.

We had a hiccup with the DifferentiationInterface release. Should be fixed in a little bit.

2 Likes

What’s up? Can I help?

1 Like

Okay so apparently it’s an issue with the PR that started using DI, not with DI per se? I see the following precompilation errors:

Precompiling project...
  βœ— BoundaryValueDiffEqFIRK
  βœ— BoundaryValueDiffEqMIRK
  βœ— BoundaryValueDiffEq
  174 dependencies successfully precompiled in 98 seconds. 91 already precompiled.
  3 dependencies had output during precompilation:
β”Œ BoundaryValueDiffEqMIRKN
β”‚  WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqMIRKN
β””  
β”Œ BoundaryValueDiffEqAscher
β”‚  WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqAscher
β””  
β”Œ BoundaryValueDiffEqShooting
β”‚  WARNING: could not import BoundaryValueDiffEqCore.ColoredMatrix into BoundaryValueDiffEqShooting
β”‚  WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqShooting
β”‚  WARNING: could not import BoundaryValueDiffEqCore.__sparsity_detection_alg into BoundaryValueDiffEqShooting
β””  
  3 dependencies errored.
  For a report of the errors see `julia> err`. To retry use `pkg> precompile`

julia> err
PkgPrecompileError: The following 1 direct dependency failed to precompile:

BoundaryValueDiffEq 

Failed to precompile BoundaryValueDiffEq [764a87c0-6b3e-53db-9096-fe964310641d] to "/Users/guillaumedalle/.julia/compiled/v1.11/BoundaryValueDiffEq/jl_WJuiqZ".
WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__sparsity_detection_alg into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.ColoredMatrix into BoundaryValueDiffEqFIRK
ERROR: LoadError: TaskFailedException

    nested task error: UndefVarError: `__sparse_jacobian_cache` not defined in `BoundaryValueDiffEqFIRK`
    Stacktrace:
      [1] __construct_nlproblem(cache::BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}, y::Vector{Float64}, loss_bc::BoundaryValueDiffEqFIRK.var"#115#121"{SciMLBase.StandardBVProblem, BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}}, loss_collocation::BoundaryValueDiffEqFIRK.var"#117#123"{BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}}, loss::BoundaryValueDiffEqFIRK.var"#119#125"{BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}, SciMLBase.StandardBVProblem, BoundaryValueDiffEqCore.EvalSol{BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}, Vector{Vector{Float64}}, Vector{Float64}}}, ::SciMLBase.StandardBVProblem)
        @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/firk.jl:452
      [2] __construct_nlproblem
        @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/firk.jl:433 [inlined]
      [3] __perform_firk_iteration(cache::BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}}, abstol::Float64, adaptive::Bool; nlsolve_kwargs::@NamedTuple{}, kwargs::@Kwargs{abstol::Float64, adaptive::Bool})
        @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/firk.jl:356
      [4] __perform_firk_iteration
        @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/firk.jl:354 [inlined]
      [5] solve!(cache::BoundaryValueDiffEqFIRK.FIRKCacheExpand{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, typeof(BoundaryValueDiffEqFIRK.bc1!), SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, SciMLBase.StandardBVProblem, SciMLBase.NullParameters, BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{false, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{false, Matrix{Float64}, Float64}, Vector{Float64}, Vector{Float64}, Vector{Float64}, Vector{PreallocationTools.DiffCache{Matrix{Float64}, Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Vector{PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}}, PreallocationTools.DiffCache{Vector{Float64}, Vector{Float64}}, Vector{Float64}, RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, Tuple{Int64}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}})
        @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/firk.jl:309
      [6] __solve(::SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, ::BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}; kwargs::@Kwargs{dt::Float64})
        @ BoundaryValueDiffEqCore ~/.julia/packages/BoundaryValueDiffEqCore/YqNKE/src/BoundaryValueDiffEqCore.jl:36
      [7] __solve
        @ ~/.julia/packages/BoundaryValueDiffEqCore/YqNKE/src/BoundaryValueDiffEqCore.jl:33 [inlined]
      [8] #solve_call#35
        @ ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:635 [inlined]
      [9] solve_call
        @ ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:592 [inlined]
     [10] solve_up(prob::SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, sensealg::Nothing, u0::Vector{Float64}, p::SciMLBase.NullParameters, args::BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}; kwargs::@Kwargs{dt::Float64})
        @ DiffEqBase ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:1128
     [11] solve_up
        @ ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:1106 [inlined]
     [12] solve(prob::SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}, args::BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}; sensealg::Nothing, u0::Nothing, p::Nothing, wrap::Val{true}, kwargs::@Kwargs{dt::Float64})
        @ DiffEqBase ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:1043
     [13] solve
        @ ~/.julia/packages/DiffEqBase/HGITF/src/solve.jl:1033 [inlined]
     [14] (::BoundaryValueDiffEqFIRK.var"#175#198"{BoundaryValueDiffEqFIRK.RadauIIa5{Nothing, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}, ADTypes.AutoForwardDiff{2, Nothing}}, Float64}, SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, false, SciMLBase.NullParameters, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, false, typeof(BoundaryValueDiffEqFIRK.f1!), typeof(BoundaryValueDiffEqFIRK.bc1!), LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.StandardBVProblem, @Kwargs{}}})()
        @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:100

...and 3 more exceptions.

Stacktrace:
  [1] sync_end(c::Channel{Any})
    @ Base ./task.jl:466
  [2] macro expansion
    @ ./task.jl:499 [inlined]
  [3] macro expansion
    @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:99 [inlined]
  [4] macro expansion
    @ ~/.julia/packages/PrecompileTools/L8A3n/src/workloads.jl:78 [inlined]
  [5] macro expansion
    @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:98 [inlined]
  [6] macro expansion
    @ ~/.julia/packages/PrecompileTools/L8A3n/src/workloads.jl:140 [inlined]
  [7] top-level scope
    @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:59
  [8] include
    @ ./Base.jl:557 [inlined]
  [9] include_package_for_output(pkg::Base.PkgId, input::String, depot_path::Vector{String}, dl_load_path::Vector{String}, load_path::Vector{String}, concrete_deps::Vector{Pair{Base.PkgId, UInt128}}, source::String)
    @ Base ./loading.jl:2881
 [10] top-level scope
    @ stdin:6
in expression starting at /Users/guillaumedalle/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:1
in expression starting at stdin:6
ERROR: LoadError: Failed to precompile BoundaryValueDiffEqFIRK [85d9eb09-370e-4000-bb32-543851f73618] to "/Users/guillaumedalle/.julia/compiled/v1.11/BoundaryValueDiffEqFIRK/jl_Iwp8LR".
Stacktrace:
  [1] error(s::String)
    @ Base ./error.jl:35
  [2] compilecache(pkg::Base.PkgId, path::String, internal_stderr::IO, internal_stdout::IO, keep_loaded_modules::Bool; flags::Cmd, cacheflags::Base.CacheFlags, reasons::Dict{String, Int64}, loadable_exts::Nothing)
    @ Base ./loading.jl:3174
  [3] (::Base.var"#1110#1111"{Base.PkgId})()
    @ Base ./loading.jl:2579
  [4] mkpidlock(f::Base.var"#1110#1111"{Base.PkgId}, at::String, pid::Int32; kwopts::@Kwargs{stale_age::Int64, wait::Bool})
    @ FileWatching.Pidfile ~/.julia/juliaup/julia-1.11.3+0.aarch64.apple.darwin14/share/julia/stdlib/v1.11/FileWatching/src/pidfile.jl:95
  [5] #mkpidlock#6
    @ ~/.julia/juliaup/julia-1.11.3+0.aarch64.apple.darwin14/share/julia/stdlib/v1.11/FileWatching/src/pidfile.jl:90 [inlined]
  [6] trymkpidlock(::Function, ::Vararg{Any}; kwargs::@Kwargs{stale_age::Int64})
    @ FileWatching.Pidfile ~/.julia/juliaup/julia-1.11.3+0.aarch64.apple.darwin14/share/julia/stdlib/v1.11/FileWatching/src/pidfile.jl:116
  [7] #invokelatest#2
    @ ./essentials.jl:1057 [inlined]
  [8] invokelatest
    @ ./essentials.jl:1052 [inlined]
  [9] maybe_cachefile_lock(f::Base.var"#1110#1111"{Base.PkgId}, pkg::Base.PkgId, srcpath::String; stale_age::Int64)
    @ Base ./loading.jl:3698
 [10] maybe_cachefile_lock
    @ ./loading.jl:3695 [inlined]
 [11] _require(pkg::Base.PkgId, env::String)
    @ Base ./loading.jl:2565
 [12] __require_prelocked(uuidkey::Base.PkgId, env::String)
    @ Base ./loading.jl:2388
 [13] #invoke_in_world#3
    @ ./essentials.jl:1089 [inlined]
 [14] invoke_in_world
    @ ./essentials.jl:1086 [inlined]
 [15] _require_prelocked(uuidkey::Base.PkgId, env::String)
    @ Base ./loading.jl:2375
 [16] macro expansion
    @ ./loading.jl:2314 [inlined]
 [17] macro expansion
    @ ./lock.jl:273 [inlined]
 [18] __require(into::Module, mod::Symbol)
    @ Base ./loading.jl:2271
 [19] #invoke_in_world#3
    @ ./essentials.jl:1089 [inlined]
 [20] invoke_in_world
    @ ./essentials.jl:1086 [inlined]
 [21] require(into::Module, mod::Symbol)
    @ Base ./loading.jl:2260
 [22] include
    @ ./Base.jl:557 [inlined]
 [23] include_package_for_output(pkg::Base.PkgId, input::String, depot_path::Vector{String}, dl_load_path::Vector{String}, load_path::Vector{String}, concrete_deps::Vector{Pair{Base.PkgId, UInt128}}, source::Nothing)
    @ Base ./loading.jl:2881
 [24] top-level scope
    @ stdin:6
in expression starting at /Users/guillaumedalle/.julia/packages/BoundaryValueDiffEq/PQI6Y/src/BoundaryValueDiffEq.jl:1
in expression starting at stdin:

It seems to be working now, I uninstalled again and when I reinstalled there were no issues. Will post here if it occurs again.
Thank you for the help!

1 Like

Small remark: In many cases DiffEqBase is good enough and faster to install.

1 Like

Not really, it’s a result of BoundaryValueDiffEq.jl merging things for all subpackages and not having Monorepo Packages via Submodules/Subpackages: Support in Pkg and Julia Compiler Β· Issue #55516 Β· JuliaLang/julia Β· GitHub so it’s just hard to keep 8 packages in sync or whatnot. We had two that we forgot to lock-step release.

1 Like

I believe I am experiencing a related, but not identical issue. Using DifferentialEquations.jl, I get an error loading it in Pluto.jl. Here is the code,

begin
using Pkg
Pkg.activate()
using CairoMakie
using Random, Distributions
using StatsBase, Statistics
using Unitful
using CSV, DataFrames
using LsqFit
using Glob
using ClipData
using DifferenceEquations
end

and the Pluto.jl error message:

" The package DifferenceEquations.jl could not load because it failed to initialize.
That’s not nice! Things you could try:

  • Restart the notebook.
  • Try a different Julia version.
  • Contact the developers of DifferenceEquations.jl about this error.
    You might find useful information in the package installation log:

This new issue, as the code written about a year ago has been very useful to me in the past. The package precompiles well, but testing fails. The error message is,

Precompiling project for configuration --code-coverage=none --color=yes --check-bounds=yes --warn-overwrite=yes --depwarn=yes --inline=yes --startup-file=no --track-allocation=none…
281 dependencies successfully precompiled in 164 seconds. 35 already precompiled.
Testing Running tests…
Test Summary: | Pass Total Time
Default Discrete Algorithm | 1 1 1.3s
1.385784 seconds (7.28 M allocations: 397.675 MiB, 15.57% gc time, 99.61% compilation time: <1% of which was recompilation)
Default Steady State Algorithm: Error During Test at /Users/seb/.julia/packages/DifferentialEquations/he2qQ/test/default_steady_state_alg_test.jl:12
Test threw exception
Expression: DifferentialEquations.NonlinearSolve.get_name(sol.alg) === :NewtonRaphson
UndefVarError: get_name not defined in NonlinearSolve
Stacktrace:
[1] getproperty(x::Module, f::Symbol)
@ Base ./Base.jl:42
[2] macro expansion
@ ~/.julia/juliaup/julia-1.11.4+0.aarch64.apple.darwin14/share/julia/stdlib/v1.11/Test/src/Test.jl:676 [inlined]
[3] top-level scope
@ ~/.julia/packages/DifferentialEquations/he2qQ/test/default_steady_state_alg_test.jl:515
Test Summary: | Error Total Time
Default Steady State Algorithm | 1 1 1.9s
ERROR: LoadError: Some tests did not pass: 0 passed, 0 failed, 1 errored, 0 broken.
in expression starting at /Users/seb/.julia/packages/DifferentialEquations/he2qQ/test/runtests.jl:4
ERROR: Package DifferentialEquations errored during testing

I tried removing and reinstalling DifferentialEquations.jl a few times. Tried with Julia 1.11.2, 1.11.3, and 1.11.4. I tried with a clean install with only this package, but I always get this error.

That is all the info I have for now. Thanks for any help on this matter and, thank so much, for developing and maintaining this wonderful package.
Seb

P.S. Sorry if syntax highlighting is not activated, I could not find how to activate it.

Did you try to just install DifferentialEquations on its own:

mkdir test
cd test
julia --project=.

and then in Julia

using Pkg
Pkg.add("DifferentialEquations")

?

Thanks for you reply. I did try exactly as you have suggested. I get what seems to be the same error message. Here is a screenshot

I stand ready to try other suggestions…

Wrong package?

I played with so many things trying to solve the initial error that adding the package back I did this embarrassing mistake. In works fine in Pluto now.

If nothing has been changed in the past week in DifferentialEquations.jl or its dependencies, then, I will go under a rock and hide for a little while.

Sorry and thanks!
S.

1/3 I’m getting the exact same error message for the same packages as OP, however I get there slightly differently. I start from a well compiled and functional project called SQT, which I’m trying to upgrade. This is what I’m doing:

(SQT) pkg> st                                                                                                                                                                                                                                                                                                                                                 
Project SQT v0.1.0                                                                                                                                                                                                                                                                                                                                            
Status `~/workspace/11/SQT/Project.toml`                                                                                                                                                                                                                                                                                                                     
  [fbb218c0] BSON v0.3.9                                                                                                                                                                                                                                                                                                    
  [6e4b80f9] BenchmarkTools v1.6.0                                                                                                                                                                                                                                                                                                                              
  [336ed68f] CSV v0.10.15                                                                                                                                                                                                                                                                                                       
βŒƒ [052768ef] CUDA v5.6.1                                                                                                                                                                                                                                                                                                    
  [1b08a953] Dash v1.5.0                                                                                                                                                                                                                                                                                                    
  [a93c6f00] DataFrames v1.7.0                                                                                                                                                                                                                                                                                                                      
  [1313f7d8] DataFramesMeta v0.15.4                                                                                                                                                                                                                                                                                                                             
βŒƒ [071ae1c0] DiffEqGPU v3.4.1                                                                                                                                                                                                                                                                                                                   
  [0c46a032] DifferentialEquations v7.16.1                                                                                                                                                                                                                                                                                                                      
βŒ… [a0c0ee7d] DifferentiationInterface v0.6.43                                                                                                                                                                                                                                                                                                                   
βŒ… [f6369f11] ForwardDiff v0.10.38                                                                                                                                                                                                                                                                                                                               
  [38e38edf] GLM v1.9.0                                                                                                                                                                                                                                                                                                 
  [cd3eb016] HTTP v1.10.16                                                                                                                                                                                                                                                                                                          
  [a98d9a8b] Interpolations v0.16.1                                                                                                                                                                                                                                                                                                                             
  [682c06a0] JSON v0.21.4                                                                                                                                                                                                                                                                                                       
  [194296ae] LibPQ v1.18.0                                                                                                                                                                                                                                                                                                          
  [2774e3e8] NLsolve v4.5.1                                                                                                                                                                                                                                                                                                             
  [7f7a1694] Optimization v4.3.0                                                                                                                                                                                                                                                                                                                            
  [36348300] OptimizationOptimJL v0.4.3                                                                                                                                                                                                                                                                                                                         
  [f0f68f2c] PlotlyJS v0.18.16                                                                                                                                                                                                                                                                                                                      
  [91a5bcdd] Plots v1.40.13                                                                                                                                                                                                                                                                                                             
  [98d1487c] PolyesterForwardDiff v0.1.3                                                                                                                                                                                                                                                                                                                        
  [92933f4c] ProgressMeter v1.10.4                                                                                                                                                                                                                                                                                                                              
  [37e2e3b7] ReverseDiff v1.16.1                                                                                                                                                                                                                                                                                                                            
  [90137ffa] StaticArrays v1.9.13                                                                                                                                                                                                                                                                                                                               
  [10745b16] Statistics v1.11.1                                                                                                                                                                                                                                                                                                                         
  [2913bbd2] StatsBase v0.34.5                                                                                                                                                                                                                                                                                                                      
  [f269a46b] TimeZones v1.21.3                                                                                                                                                                                                                                                                                                                      
  [ade2ca70] Dates v1.11.0                                                                                                                                                                                                                                                                                                          
  [de0858da] Printf v1.11.0                                                                                                                                                                                                                                                                                                             
Info Packages marked with βŒƒ and βŒ… have new versions available. Those with βŒƒ may be upgradable, but those with βŒ… are restricted by compatibility constraints from upgrading. To see why use `status --outdated`                                                                                                                                                  

2/3

(SQT) pkg> up                                                                                                                                                                                                                                                                                                                                                 
    Updating registry at `~/.julia/registries/General.toml`                                                                                                                                                                                                                                                                                                     
    Updating `~/workspace/11/SQT/Project.toml`                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              
  [052768ef] ↑ CUDA v5.6.1 β‡’ v5.8.2                                                                                                                                                                                                                                                                                                                             
  [071ae1c0] ↑ DiffEqGPU v3.4.1 β‡’ v3.7.0                                                                                                                                                                                                                                                                                                                        
  [a0c0ee7d] ↑ DifferentiationInterface v0.6.43 β‡’ v0.7.0                                                                                                                                                                                                                                                                                                        
    Updating `~/workspace/11/SQT/Manifest-v1.11.toml`                                                                                                                                                                                                                                                                                                        
  [47edcb42] ↑ ADTypes v1.13.0 β‡’ v1.14.0                                                                                                                                                                                                                                                                                                                        
  [7d9f7c33] ↑ Accessors v0.1.41 β‡’ v0.1.42                                                                                                                                                                                                                                                                                                                      
  [79e6a3ab] ↑ Adapt v4.1.1 β‡’ v4.3.0                                                                                                                                                                                                                                                                                                                            
  [4fba245c] ↑ ArrayInterface v7.18.0 β‡’ v7.19.0                                                                                                                                                                                                                                                                                                                 
  [4c555306] ↑ ArrayLayouts v1.11.0 β‡’ v1.11.1                                                                                                                                                                                                                                                                                                                   
  [a9b6321e] ↑ Atomix v1.1.0 β‡’ v1.1.1                                                                                                                                                                                                                                                                                                                           
  [ab4f0b2a] ↑ BFloat16s v0.5.0 β‡’ v0.5.1                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  
  [aae01518] ↑ BandedMatrices v1.9.1 β‡’ v1.9.4                                                                                                                                                                                                                                                                                                                   
  [764a87c0] ↑ BoundaryValueDiffEq v5.15.0 β‡’ v5.17.0                                                                                                                                                                                                                                                                                                            
  [7227322d] ↑ BoundaryValueDiffEqAscher v1.4.0 β‡’ v1.6.1                                                                                                                                                                                                                                                                                                        
  [56b672f2] ↑ BoundaryValueDiffEqCore v1.7.0 β‡’ v1.9.0                                                                                                                                                                                                                                                                                                          
  [9255f1d6] ↑ BoundaryValueDiffEqMIRKN v1.4.0 β‡’ v1.6.1                                                                                                                                                                                                                                                                                                         
  [70df07ce] ↑ BracketingNonlinearSolve v1.1.0 β‡’ v1.3.0                                                                                                                                                                                                                                                                                                         
  [052768ef] ↑ CUDA v5.6.1 β‡’ v5.8.2                                                                                                                                                                                                                                                                                                                             
  [3da002f7] ↑ ColorTypes v0.12.0 β‡’ v0.12.1                                                                                                                                                                                                                                                                                                                     
  [5ae59095] ↑ Colors v0.13.0 β‡’ v0.13.1                                                                                                                                                                                                                                                                                                                         
  [864edb3b] ↑ DataStructures v0.18.20 β‡’ v0.18.22                                                                                                                                                                                                                                                                                                               
  [bcd4f6db] ↑ DelayDiffEq v5.52.0 β‡’ v5.53.1                                                                                                                                                                                                                                                                                                                    
  [2b5f629d] ↑ DiffEqBase v6.162.2 β‡’ v6.175.0                                                                                                                                                                                                                                                                                                                   
  [459566f4] ↑ DiffEqCallbacks v4.2.2 β‡’ v4.6.0                                                                                                                                                                                                                                                                                                                  
  [071ae1c0] ↑ DiffEqGPU v3.4.1 β‡’ v3.7.0                                                                                                                                                                                                                                                                                                                        
  [a0c0ee7d] ↑ DifferentiationInterface v0.6.43 β‡’ v0.7.0                                                                                                                                                                                                                                                                                                        
  [31c24e10] ↑ Distributions v0.25.117 β‡’ v0.25.120                                                                                                                                                                                                                                                                                                              
  [ffbed154] ↑ DocStringExtensions v0.9.3 β‡’ v0.9.5                                                                                                                                                                                                                                                                                                              
  [4e289a0a] ↑ EnumX v1.0.4 β‡’ v1.0.5                                                                                                                                                                                                                                                                                                                            
  [f151be2c] ↑ EnzymeCore v0.8.8 β‡’ v0.8.11                                                                                                                                                                                                                                                                                                                      
  [6b7a57c9] - Expronicon v0.8.5                                                                                                                                                                                                                                                                                                                            
  [55351af7] + ExproniconLite v0.10.14                                                                                                                                                                                                                                                                                                                          
  [9d29842c] ↑ FastAlmostBandedMatrices v0.1.4 β‡’ v0.1.5                                                                                                                                                                                                                                                                                                         
  [29a986be] - FastLapackInterface v2.0.4                                                                                                                                                                                                                                                                                                                       
  [a4df4552] ↑ FastPower v1.1.1 β‡’ v1.1.2                                                                                                                                                                                                                                                                                                                        
  [48062228] ↑ FilePathsBase v0.9.23 β‡’ v0.9.24                                                                                                                                                                                                                                                                                                                  
  [61eb1bfa] ↑ GPUCompiler v1.1.1 β‡’ v1.5.1                                                                                                                                                                                                                                                                                                                      
  [096a3bc2] + GPUToolbox v0.2.0                                                                                                                                                                                                                                                                                                                            
  [28b8d3ca] ↑ GR v0.73.12 β‡’ v0.73.16                                                                                                                                                                                                                                                                                                                           
  [c145ed77] ↑ GenericSchur v0.5.4 β‡’ v0.5.5                                                                                                                                                                                                                                                                                                                     
  [86223c79] ↑ Graphs v1.12.0 β‡’ v1.13.0                                                                                                                                                                                                                                                                                                                         
  [3e5b6fbb] - HostCPUFeatures v0.1.17                                                                                                                                                                                                                                                                                                                          
  [34004b35] ↑ HypergeometricFunctions v0.3.27 β‡’ v0.3.28                                                                                                                                                                                                                                                                                                        
  [842dd82b] ↑ InlineStrings v1.4.2 β‡’ v1.4.3                                                                                                                                                                                                                                                                                                                    
  [1019f520] ↑ JLFzf v0.1.9 β‡’ v0.1.11                                                                                                                                                                                                                                                                                                                           
  [0f8b85d8] ↑ JSON3 v1.14.1 β‡’ v1.14.3                                                                                                                                                                                                                                                                                                                          
  [ae98c720] + Jieko v0.2.1                                                                                                                                                                                                                                                                                                             
  [ccbc3e58] ↑ JumpProcesses v9.14.2 β‡’ v9.16.0                                                                                                                                                                                                                                                                                                                  
  [ef3ab10e] - KLU v0.6.0                                                                                                                                                                                                                                                                                                       
  [63c18a36] ↑ KernelAbstractions v0.9.33 β‡’ v0.9.34                                                                                                                                                                                                                                                                                                             
  [ba0b0d4f] ↑ Krylov v0.9.9 β‡’ v0.10.1                                                                                                                                                                                                                                                                                                                          
  [929cbde3] ↑ LLVM v9.2.0 β‡’ v9.4.0                                                                                                                                                                                                                                                                                                                             
  [23fbe1c1] ↑ Latexify v0.16.6 β‡’ v0.16.8
  [5078a376] ↑ LazyArrays v2.6.0 β‡’ v2.6.1
  [7ed4a6bd] ↑ LinearSolve v2.39.0 β‡’ v3.17.0
  [bdcacae8] - LoopVectorization v0.12.171
  [d8e11817] - MLStyle v0.4.17
  [1914dd2f] ↑ MacroTools v0.5.15 β‡’ v0.5.16
  [2e0e35c7] + Moshi v0.3.5
  [ffc61752] ↑ Mustache v1.0.20 β‡’ v1.0.21
  [5da4648a] ↑ NVTX v0.3.5 β‡’ v1.0.0
  [77ba4419] ↑ NaNMath v1.1.2 β‡’ v1.1.3
  [8913a72c] ↑ NonlinearSolve v4.4.0 β‡’ v4.9.0
  [be0214bd] ↑ NonlinearSolveBase v1.4.1 β‡’ v1.12.0
  [5959db7a] ↑ NonlinearSolveFirstOrder v1.3.0 β‡’ v1.5.0
  [9a2c21bd] ↑ NonlinearSolveQuasiNewton v1.2.0 β‡’ v1.6.0
  [26075421] ↑ NonlinearSolveSpectralMethods v1.1.0 β‡’ v1.2.0
  [6fe1bfb0] ↑ OffsetArrays v1.15.0 β‡’ v1.17.0
  [4d8831e6] ↑ OpenSSL v1.4.3 β‡’ v1.5.0
  [bca83a33] ↑ OptimizationBase v2.4.0 β‡’ v2.8.0
  [bac558e1] ↑ OrderedCollections v1.8.0 β‡’ v1.8.1
  [1dea7af3] ↑ OrdinaryDiffEq v6.91.0 β‡’ v6.98.0
  [6ad6398a] ↑ OrdinaryDiffEqBDF v1.2.0 β‡’ v1.6.0
  [bbf590c4] ↑ OrdinaryDiffEqCore v1.17.0 β‡’ v1.26.0
  [50262376] ↑ OrdinaryDiffEqDefault v1.2.0 β‡’ v1.4.0
  [4302a76b] ↑ OrdinaryDiffEqDifferentiation v1.4.0 β‡’ v1.10.0
  [e0540318] ↑ OrdinaryDiffEqExponentialRK v1.2.0 β‡’ v1.4.0
  [becaefa8] ↑ OrdinaryDiffEqExtrapolation v1.3.0 β‡’ v1.5.0
  [5960d6e9] ↑ OrdinaryDiffEqFIRK v1.6.0 β‡’ v1.12.0
  [9f002381] ↑ OrdinaryDiffEqIMEXMultistep v1.2.0 β‡’ v1.3.0
  [521117fe] ↑ OrdinaryDiffEqLinear v1.1.0 β‡’ v1.3.0
  [b0944070] ↑ OrdinaryDiffEqLowStorageRK v1.2.1 β‡’ v1.3.0
  [127b3ac7] ↑ OrdinaryDiffEqNonlinearSolve v1.4.0 β‡’ v1.10.0
  [5dd0a6cf] ↑ OrdinaryDiffEqPDIRK v1.2.0 β‡’ v1.3.1
  [43230ef6] ↑ OrdinaryDiffEqRosenbrock v1.5.0 β‡’ v1.11.0
  [2d112036] ↑ OrdinaryDiffEqSDIRK v1.2.0 β‡’ v1.3.0
  [669c94d9] ↑ OrdinaryDiffEqSSPRK v1.2.0 β‡’ v1.3.0
  [e3e12d00] ↑ OrdinaryDiffEqStabilizedIRK v1.2.0 β‡’ v1.3.0
  [fa646aed] ↑ OrdinaryDiffEqSymplecticRK v1.2.0 β‡’ v1.3.0
  [79d7bb75] ↑ OrdinaryDiffEqVerner v1.1.1 β‡’ v1.2.0
  [90014a1f] ↑ PDMats v0.11.32 β‡’ v0.11.35
  [69de0a69] ↑ Parsers v2.8.1 β‡’ v2.8.3
  [b98c9c47] - Pipe v1.3.0
  [a03496cd] ↑ PlotlyBase v0.8.19 β‡’ v0.8.21
  [f2990250] ↑ PlotlyKaleido v2.2.6 β‡’ v2.3.0
  [f517fe37] ↑ Polyester v0.7.16 β‡’ v0.7.18
  [d236fae5] ↑ PreallocationTools v0.4.24 β‡’ v0.4.27
  [74087812] ↑ Random123 v1.7.0 β‡’ v1.7.1
  [731186ca] ↑ RecursiveArrayTools v3.29.0 β‡’ v3.33.0
  [f2c3362d] - RecursiveFactorization v0.2.23
  [ae029012] ↑ Requires v1.3.0 β‡’ v1.3.1
  [7e49a35a] ↑ RuntimeGeneratedFunctions v0.5.13 β‡’ v0.5.15
  [476501e8] - SLEEFPirates v0.6.43
  [0bca4576] ↑ SciMLBase v2.74.0 β‡’ v2.97.0
  [19f34311] ↑ SciMLJacobianOperators v0.1.1 β‡’ v0.1.6
βŒ… [c0aeaf25] ↑ SciMLOperators v0.3.12 β‡’ v0.4.0
  [53ae85a6] ↑ SciMLStructures v1.6.1 β‡’ v1.7.0
  [efcf1570] ↑ Setfield v1.1.1 β‡’ v1.1.2
  [727e6d20] ↑ SimpleNonlinearSolve v2.1.0 β‡’ v2.5.0
  [9f842d2f] ↑ SparseConnectivityTracer v0.6.12 β‡’ v0.6.19
  [47a9eef4] ↑ SparseDiffTools v2.23.1 β‡’ v2.26.0
  [0a514795] ↑ SparseMatrixColorings v0.4.13 β‡’ v0.4.20
  [e56a9233] - Sparspak v0.3.9
  [276daf66] ↑ SpecialFunctions v2.5.0 β‡’ v2.5.1
  [860ef19b] ↑ StableRNGs v1.0.2 β‡’ v1.0.3
  [aedffcd0] ↑ Static v1.1.1 β‡’ v1.2.0
  [82ae8749] ↑ StatsAPI v1.7.0 β‡’ v1.7.1
  [4c63d2b9] ↑ StatsFuns v1.3.2 β‡’ v1.5.0
  [9672c7b4] ↑ SteadyStateDiffEq v2.4.1 β‡’ v2.5.0
  [789caeaf] ↑ StochasticDiffEq v6.74.0 β‡’ v6.80.0
  [c3572dad] ↑ Sundials v4.26.1 β‡’ v4.28.0
  [2efcf032] ↑ SymbolicIndexingInterface v0.3.37 β‡’ v0.3.40
  [dc5dba14] ↑ TZJData v1.4.0+2025a β‡’ v1.5.0+2025b
  [bd369af6] ↑ Tables v1.12.0 β‡’ v1.12.1
  [8290d209] ↑ ThreadingUtilities v0.5.2 β‡’ v0.5.4
  [a759f4b9] ↑ TimerOutputs v0.5.26 β‡’ v0.5.29
  [e689c965] + Tracy v0.1.4
  [d5829a12] - TriangularSolve v0.2.1
  [5c2747f8] ↑ URIs v1.5.1 β‡’ v1.5.2
  [1986cc42] ↑ Unitful v1.22.0 β‡’ v1.22.1
  [45397f5d] ↑ UnitfulLatexify v1.6.4 β‡’ v1.7.0
  [3d5dd08c] - VectorizationBase v0.21.71
  [ddb6d928] ↑ YAML v0.4.12 β‡’ v0.4.14
  [4ee394cb] ↑ CUDA_Driver_jll v0.10.4+0 β‡’ v0.13.0+0
  [76a88914] ↑ CUDA_Runtime_jll v0.15.5+0 β‡’ v0.17.0+0
  [83423d85] ↑ Cairo_jll v1.18.2+1 β‡’ v1.18.5+0
  [ee1fde0b] ↑ Dbus_jll v1.14.10+0 β‡’ v1.16.2+0
  [a3f928ae] ↑ Fontconfig_jll v2.15.0+0 β‡’ v2.16.0+0
  [d7e528f0] ↑ FreeType2_jll v2.13.3+1 β‡’ v2.13.4+0
  [559328eb] ↑ FriBidi_jll v1.0.16+0 β‡’ v1.0.17+0
  [d2c73de3] ↑ GR_jll v0.73.12+0 β‡’ v0.73.16+0
  [7746bdde] ↑ Glib_jll v2.82.4+0 β‡’ v2.84.0+0
  [3b182d85] ↑ Graphite2_jll v1.3.14+1 β‡’ v1.3.15+0
  [2e76f6c2] ↑ HarfBuzz_jll v8.5.0+0 β‡’ v8.5.1+0
  [a51ab1cf] ↑ ICU_jll v69.1.0+0 β‡’ v76.2.0+0
  [b39eb1a6] ↑ Kerberos_krb5_jll v1.19.3+0 β‡’ v1.21.3+0
  [dad2f222] ↑ LLVMExtra_jll v0.0.35+0 β‡’ v0.0.36+0
  [1d63c593] ↑ LLVMOpenMP_jll v18.1.7+0 β‡’ v18.1.8+0
  [08be9ffa] ↑ LibPQ_jll v16.0.0+0 β‡’ v16.8.0+0
  [ad6e5548] + LibTracyClient_jll v0.9.1+6
  [e9f186c6] ↑ Libffi_jll v3.2.2+2 β‡’ v3.4.7+0
  [d4300ac3] - Libgcrypt_jll v1.11.0+0
  [7e76a0d4] ↑ Libglvnd_jll v1.7.0+0 β‡’ v1.7.1+1
  [7add5ba3] - Libgpg_error_jll v1.51.1+0
  [4b2f31a3] ↑ Libmount_jll v2.40.3+0 β‡’ v2.41.0+0
  [38a345b3] ↑ Libuuid_jll v2.40.3+0 β‡’ v2.41.0+0
  [e98f9f5b] ↑ NVTX_jll v3.1.0+2 β‡’ v3.1.1+0
  [458c3c95] ↑ OpenSSL_jll v3.0.16+0 β‡’ v3.5.0+0
  [36c8627f] ↑ Pango_jll v1.55.5+0 β‡’ v1.56.3+0
βŒ… [30392449] ↑ Pixman_jll v0.43.4+0 β‡’ v0.44.2+0
  [c0090381] ↑ Qt6Base_jll v6.7.1+1 β‡’ v6.8.2+1
  [629bc702] ↑ Qt6Declarative_jll v6.7.1+2 β‡’ v6.8.2+1
  [ce943373] ↑ Qt6ShaderTools_jll v6.7.1+1 β‡’ v6.8.2+1
  [e99dba38] ↑ Qt6Wayland_jll v6.7.1+1 β‡’ v6.8.2+0
  [a2964d1f] ↑ Wayland_jll v1.21.0+2 β‡’ v1.23.1+0
βŒ… [02c8fc9c] ↑ XML2_jll v2.13.6+0 β‡’ v2.13.6+1
  [aed1982a] - XSLT_jll v1.1.42+0
  [ffd25f8a] ↑ XZ_jll v5.6.4+1 β‡’ v5.8.1+0
  [f67eecfb] ↑ Xorg_libICE_jll v1.1.1+0 β‡’ v1.1.2+0
  [c834827a] ↑ Xorg_libSM_jll v1.2.4+0 β‡’ v1.2.6+0
  [4f6342f7] ↑ Xorg_libX11_jll v1.8.6+3 β‡’ v1.8.12+0
  [0c0b7dd1] ↑ Xorg_libXau_jll v1.0.12+0 β‡’ v1.0.13+0
  [935fb764] ↑ Xorg_libXcursor_jll v1.2.3+0 β‡’ v1.2.4+0
  [a3789734] ↑ Xorg_libXdmcp_jll v1.1.5+0 β‡’ v1.1.6+0
  [1082639a] ↑ Xorg_libXext_jll v1.3.6+3 β‡’ v1.3.7+0
  [d091e8ba] ↑ Xorg_libXfixes_jll v6.0.0+0 β‡’ v6.0.1+0
  [a51aa0fd] ↑ Xorg_libXi_jll v1.8.2+0 β‡’ v1.8.3+0
  [d1454406] ↑ Xorg_libXinerama_jll v1.1.5+0 β‡’ v1.1.6+0
  [ec84b674] ↑ Xorg_libXrandr_jll v1.5.4+0 β‡’ v1.5.5+0
  [ea2f1a96] ↑ Xorg_libXrender_jll v0.9.11+1 β‡’ v0.9.12+0
  [14d82f49] - Xorg_libpthread_stubs_jll v0.1.2+0
  [c7cfdc94] ↑ Xorg_libxcb_jll v1.17.0+3 β‡’ v1.17.1+0
  [cc61e674] ↑ Xorg_libxkbfile_jll v1.1.2+1 β‡’ v1.1.3+0
  [35661453] ↑ Xorg_xkbcomp_jll v1.4.6+1 β‡’ v1.4.7+0
  [33bec58e] ↑ Xorg_xkeyboard_config_jll v2.39.0+0 β‡’ v2.44.0+0
  [c5fb5394] ↑ Xorg_xtrans_jll v1.5.1+0 β‡’ v1.6.0+0
  [3161d3a3] ↑ Zstd_jll v1.5.7+0 β‡’ v1.5.7+1
  [214eeab7] ↑ fzf_jll v0.56.3+0 β‡’ v0.61.1+0
  [1a1c6b14] ↑ gperf_jll v3.1.1+1 β‡’ v3.3.0+0
  [b53b4c65] ↑ libpng_jll v1.6.46+0 β‡’ v1.6.48+0
  [1317d2d5] ↑ oneTBB_jll v2021.12.0+0 β‡’ v2022.0.0+0
  [d8fb68d0] ↑ xkbcommon_jll v1.4.1+2 β‡’ v1.8.1+0
        Info Packages marked with βŒ… have new versions available but compatibility constraints restrict them from upgrading. To see why use `status --outdated -m`
Precompiling project...
  βœ— BoundaryValueDiffEqFIRK
  βœ— BoundaryValueDiffEqMIRK
  βœ— BoundaryValueDiffEqShooting
  βœ— BoundaryValueDiffEq
  βœ— DifferentialEquations
  βœ— SQT
  74 dependencies successfully precompiled in 83 seconds. 528 already precompiled.
  6 dependencies errored.
  For a report of the errors see `julia> err`. To retry use `pkg> precompile`
 

3/3

julia> err
PkgPrecompileError: The following 2 direct dependencies failed to precompile:
 
SQT 
 
Failed to precompile SQT [8797ef22-4e00-4af6-a21c-d2d37ca1f419] to "/home/sob/.julia/compiled/v1.11/SQT/jl_kV4824".
WARNING: could not import BoundaryValueDiffEqCore.BoundaryValueDiffEqAlgorithm into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__sparsity_detection_alg into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__append_similar! into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__similar into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.ColoredMatrix into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.MaybeDiffCache into BoundaryValueDiffEqFIRK
ERROR: LoadError: UndefVarError: `__append_similar!` not defined in `BoundaryValueDiffEqCore`
Stacktrace:
 [1] getproperty(x::Module, f::Symbol)
   @ Base ./Base.jl:42
 [2] top-level scope
   @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/utils.jl:1
 [3] include(mod::Module, _path::String)
   @ Base ./Base.jl:557
 [4] include(x::String)
   @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:1
 [5] top-level scope
   @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:48
 [6] include
   @ ./Base.jl:557 [inlined]
 [7] include_package_for_output(pkg::Base.PkgId, input::String, depot_path::Vector{String}, dl_load_path::Vector{String}, load_path::Vector{String}, concrete_deps::Vector{Pair{Base.PkgId, UInt128}}, source::String)
   @ Base ./loading.jl:2881
 [8] top-level scope
   @ stdin:6
in expression starting at /home/sylvain/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/utils.jl:1
in expression starting at /home/sylvain/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:1
in expression starting at stdin:6

                                                   

I’ve cut the message at the bottom as it’s similar to OP.

All of this using Julia 1.11.5 on Linux. Any idea what’s happening and how to fix?

I should note that if I’m trying to install these recent DifferentialEquation packages in an empty brand new project, it works. Suggesting it’s the upgrade path that’s broken (from pre-DI to DI?).

Perhaps start with your old Manifest.toml and Project.toml file, and then upgrade the packages one-by-one to see which one fails to upgrade?

Alternatively, delete your Manifest.toml (after making a backup) and try updating your project again?

I actually came up with a better MWE, with a brand new and empty SQT2 project, where I’m adding packages one by one, then doing the following:

(SQT2) pkg> st
Status `~/workspace/11/SQT2/Project.toml`
  [6e4b80f9] BenchmarkTools v1.6.0
  [336ed68f] CSV v0.10.15
  [052768ef] CUDA v5.8.2
  [a93c6f00] DataFrames v1.7.0
  [1313f7d8] DataFramesMeta v0.15.4
  [071ae1c0] DiffEqGPU v3.7.0
  [0c46a032] DifferentialEquations v7.16.1
βŒ… [a0c0ee7d] DifferentiationInterface v0.6.54
βŒƒ [f6369f11] ForwardDiff v0.10.38
  [38e38edf] GLM v1.9.0
  [682c06a0] JSON v0.21.4
  [194296ae] LibPQ v1.18.0
  [2774e3e8] NLsolve v4.5.1
  [7f7a1694] Optimization v4.3.0
  [36348300] OptimizationOptimJL v0.4.3
  [98d1487c] PolyesterForwardDiff v0.1.3
  [92933f4c] ProgressMeter v1.10.4
  [37e2e3b7] ReverseDiff v1.16.1
  [90137ffa] StaticArrays v1.9.13
  [10745b16] Statistics v1.11.1
  [f269a46b] TimeZones v1.21.3
Info Packages marked with βŒƒ and βŒ… have new versions available. Those with βŒƒ may be upgradable, but those with βŒ… are restricted by compatibility constraints from upgrading. To see why use `status --outdated`

(SQT2) pkg> update
    Updating registry at `~/.julia/registries/General.toml`
    Updating `~/workspace/11/SQT2/Project.toml`
  [a0c0ee7d] ↑ DifferentiationInterface v0.6.54 β‡’ v0.7.0
    Updating `~/workspace/11/SQT2/Manifest.toml`
βŒƒ [85d9eb09] ↓ BoundaryValueDiffEqFIRK v1.7.0 β‡’ v1.5.0
βŒƒ [1a22d4ce] ↓ BoundaryValueDiffEqMIRK v1.7.0 β‡’ v1.5.0
βŒƒ [ed55bfe0] ↓ BoundaryValueDiffEqShooting v1.7.0 β‡’ v1.5.0
  [a0c0ee7d] ↑ DifferentiationInterface v0.6.54 β‡’ v0.7.0
βŒƒ [d41bc354] ↓ NLSolversBase v7.9.1 β‡’ v7.8.3
βŒƒ [429524aa] ↓ Optim v1.12.0 β‡’ v1.11.0
  [bca83a33] ↑ OptimizationBase v2.7.0 β‡’ v2.8.0
  [65ce6f38] + PackageExtensionCompat v1.0.2
  [47a9eef4] + SparseDiffTools v2.26.0
  [19fa3120] + VertexSafeGraphs v0.2.0
        Info Packages marked with βŒƒ have new versions available and may be upgradable.
Precompiling project...
  βœ— BoundaryValueDiffEqFIRK
  βœ— BoundaryValueDiffEqMIRK
  βœ— BoundaryValueDiffEqShooting
  βœ— BoundaryValueDiffEq
  βœ— DifferentialEquations
  0 dependencies successfully precompiled in 16 seconds. 446 already precompiled.
  5 dependencies errored.
  For a report of the errors see `julia> err`. To retry use `pkg> precompile`

(SQT2) pkg> 

Tried this (delete manifest then update) just now for my SQT2, same error:

julia> err
PkgPrecompileError: The following 1 direct dependency failed to precompile:

DifferentialEquations 

Failed to precompile DifferentialEquations [0c46a032-eb83-5123-abaf-570d42b7fbaa] to "/home/sob/.julia/compiled/v1.11/DifferentialEquations/jl_xrk0KK".
WARNING: could not import BoundaryValueDiffEqCore.BoundaryValueDiffEqAlgorithm into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__sparse_jacobian_cache into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__sparsity_detection_alg into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__append_similar! into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.__similar into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.ColoredMatrix into BoundaryValueDiffEqFIRK
WARNING: could not import BoundaryValueDiffEqCore.MaybeDiffCache into BoundaryValueDiffEqFIRK
ERROR: LoadError: UndefVarError: `__append_similar!` not defined in `BoundaryValueDiffEqCore`
Stacktrace:
 [1] getproperty(x::Module, f::Symbol)
   @ Base ./Base.jl:42
 [2] top-level scope
   @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/utils.jl:1
 [3] include(mod::Module, _path::String)
   @ Base ./Base.jl:557
 [4] include(x::String)
   @ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:1
 [5] top-level scope
   @ ~/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:48
 [6] include
   @ ./Base.jl:557 [inlined]
 [7] include_package_for_output(pkg::Base.PkgId, input::String, depot_path::Vector{String}, dl_load_path::Vector{String}, load_path::Vector{String}, concrete_deps::Vector{Pair{Base.PkgId, UInt128}}, source::String)
   @ Base ./loading.jl:2881
 [8] top-level scope
   @ stdin:6
in expression starting at /home/sob/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/utils.jl:1
in expression starting at /home/sob/.julia/packages/BoundaryValueDiffEqFIRK/KTJvZ/src/BoundaryValueDiffEqFIRK.jl:1
in expression starting at stdin:6

Trying not to spam, I found a narrower MWE (hopefully the narrowest):

(@v1.11) pkg> activate Test2
  Activating new project at `~/workspace/11/Test2`
 
(Test2) pkg> add DifferentialEquations DifferentiationInterface
   Resolving package versions...
    Updating `~/workspace/11/Test2/Project.toml`
  [0c46a032] + DifferentialEquations v7.16.1
  [a0c0ee7d] + DifferentiationInterface v0.7.0
    Updating `~/workspace/11/Test2/Manifest.toml`
  [47edcb42] + ADTypes v1.14.0
  [7d9f7c33] + Accessors v0.1.42
  [79e6a3ab] + Adapt v4.3.0
  [66dad0bd] + AliasTables v1.1.3
  [a95523ee] + AlmostBlockDiagonals v0.1.10
  [ec485272] + ArnoldiMethod v0.4.0
  [4fba245c] + ArrayInterface v7.19.0
  [4c555306] + ArrayLayouts v1.11.1
  [aae01518] + BandedMatrices v1.9.4
  [62783981] + BitTwiddlingConvenienceFunctions v0.1.6
  [764a87c0] + BoundaryValueDiffEq v5.17.0
  [7227322d] + BoundaryValueDiffEqAscher v1.6.1
  [56b672f2] + BoundaryValueDiffEqCore v1.9.0
βŒƒ [85d9eb09] + BoundaryValueDiffEqFIRK v1.5.0
βŒƒ [1a22d4ce] + BoundaryValueDiffEqMIRK v1.5.0
  [9255f1d6] + BoundaryValueDiffEqMIRKN v1.6.1
βŒƒ [ed55bfe0] + BoundaryValueDiffEqShooting v1.5.0
  [70df07ce] + BracketingNonlinearSolve v1.3.0
  [fa961155] + CEnum v0.5.0
  [2a0fbf3d] + CPUSummary v0.2.6
  [d360d2e6] + ChainRulesCore v1.25.1
  [fb6a15b2] + CloseOpenIntervals v0.1.13
  [38540f10] + CommonSolve v0.2.4
  [bbf7d656] + CommonSubexpressions v0.3.1
  [f70d9fcc] + CommonWorldInvalidations v1.0.0
  [34da2185] + Compat v4.16.0
  [a33af91c] + CompositionsBase v0.1.2
  [2569d6c7] + ConcreteStructs v0.2.3
  [187b0558] + ConstructionBase v1.5.8
  [adafc99b] + CpuId v0.3.1
  [a8cc5b0e] + Crayons v4.1.1
  [9a962f9c] + DataAPI v1.16.0
  [864edb3b] + DataStructures v0.18.22
  [e2d170a0] + DataValueInterfaces v1.0.0
  [bcd4f6db] + DelayDiffEq v5.53.1
  [2b5f629d] + DiffEqBase v6.175.0
  [459566f4] + DiffEqCallbacks v4.6.0
  [77a26b50] + DiffEqNoiseProcess v5.24.1
  [163ba53b] + DiffResults v1.1.0
  [b552c78f] + DiffRules v1.15.1
  [0c46a032] + DifferentialEquations v7.16.1
  [a0c0ee7d] + DifferentiationInterface v0.7.0
  [b4f34e82] + Distances v0.10.12
  [31c24e10] + Distributions v0.25.120
  [ffbed154] + DocStringExtensions v0.9.5
  [4e289a0a] + EnumX v1.0.5
  [f151be2c] + EnzymeCore v0.8.11
  [d4d017d3] + ExponentialUtilities v1.27.0
  [e2ba6199] + ExprTools v0.1.10
  [55351af7] + ExproniconLite v0.10.14
  [9d29842c] + FastAlmostBandedMatrices v0.1.5
  [7034ab61] + FastBroadcast v0.3.5
  [9aa1b823] + FastClosures v0.3.2
  [442a2c76] + FastGaussQuadrature v1.0.2
  [a4df4552] + FastPower v1.1.2
  [1a297f60] + FillArrays v1.13.0
  [6a86dc24] + FiniteDiff v2.27.0
βŒ… [f6369f11] + ForwardDiff v0.10.38
  [069b7b12] + FunctionWrappers v1.1.3
  [77dc65aa] + FunctionWrappersWrappers v0.1.3
  [d9f16b24] + Functors v0.5.2
  [46192b85] + GPUArraysCore v0.2.0
  [c145ed77] + GenericSchur v0.5.5
  [86223c79] + Graphs v1.13.0
  [34004b35] + HypergeometricFunctions v0.3.28
  [615f187c] + IfElse v0.1.1
  [d25df0c9] + Inflate v0.1.5
  [3587e190] + InverseFunctions v0.1.17
  [92d709cd] + IrrationalConstants v0.2.4
  [82899510] + IteratorInterfaceExtensions v1.0.0
  [692b3bcd] + JLLWrappers v1.7.0
  [ae98c720] + Jieko v0.2.1
  [ccbc3e58] + JumpProcesses v9.16.0
  [ba0b0d4f] + Krylov v0.10.1
  [b964fa9f] + LaTeXStrings v1.4.0
  [10f19ff3] + LayoutPointers v0.1.17
  [5078a376] + LazyArrays v2.6.1
  [2d8b4e74] + LevyArea v1.0.0
  [87fe0de2] + LineSearch v0.1.4
  [d3d80556] + LineSearches v7.3.0
  [7ed4a6bd] + LinearSolve v3.17.0
  [2ab3a3ac] + LogExpFunctions v0.3.29
  [1914dd2f] + MacroTools v0.5.16
  [d125e4d3] + ManualMemory v0.1.8
  [a3b82374] + MatrixFactorizations v3.0.1
  [bb5d69b7] + MaybeInplace v0.1.4
  [e1d29d7a] + Missings v1.2.0
  [2e0e35c7] + Moshi v0.3.5
  [46d2c3a1] + MuladdMacro v0.2.4
βŒƒ [d41bc354] + NLSolversBase v7.8.3
  [2774e3e8] + NLsolve v4.5.1
  [77ba4419] + NaNMath v1.1.3
  [8913a72c] + NonlinearSolve v4.9.0
  [be0214bd] + NonlinearSolveBase v1.12.0
  [5959db7a] + NonlinearSolveFirstOrder v1.5.0
  [9a2c21bd] + NonlinearSolveQuasiNewton v1.6.0
  [26075421] + NonlinearSolveSpectralMethods v1.2.0
βŒƒ [429524aa] + Optim v1.11.0
  [bac558e1] + OrderedCollections v1.8.1
  [1dea7af3] + OrdinaryDiffEq v6.98.0
  [89bda076] + OrdinaryDiffEqAdamsBashforthMoulton v1.2.0
  [6ad6398a] + OrdinaryDiffEqBDF v1.6.0
  [bbf590c4] + OrdinaryDiffEqCore v1.26.0
  [50262376] + OrdinaryDiffEqDefault v1.4.0
  [4302a76b] + OrdinaryDiffEqDifferentiation v1.10.0
  [9286f039] + OrdinaryDiffEqExplicitRK v1.1.0
  [e0540318] + OrdinaryDiffEqExponentialRK v1.4.0
  [becaefa8] + OrdinaryDiffEqExtrapolation v1.5.0
  [5960d6e9] + OrdinaryDiffEqFIRK v1.12.0
  [101fe9f7] + OrdinaryDiffEqFeagin v1.1.0
  [d3585ca7] + OrdinaryDiffEqFunctionMap v1.1.1
  [d28bc4f8] + OrdinaryDiffEqHighOrderRK v1.1.0
  [9f002381] + OrdinaryDiffEqIMEXMultistep v1.3.0
  [521117fe] + OrdinaryDiffEqLinear v1.3.0
  [1344f307] + OrdinaryDiffEqLowOrderRK v1.2.0
  [b0944070] + OrdinaryDiffEqLowStorageRK v1.3.0
  [127b3ac7] + OrdinaryDiffEqNonlinearSolve v1.10.0
  [c9986a66] + OrdinaryDiffEqNordsieck v1.1.0
  [5dd0a6cf] + OrdinaryDiffEqPDIRK v1.3.1
  [5b33eab2] + OrdinaryDiffEqPRK v1.1.0
  [04162be5] + OrdinaryDiffEqQPRK v1.1.0
  [af6ede74] + OrdinaryDiffEqRKN v1.1.0
  [43230ef6] + OrdinaryDiffEqRosenbrock v1.11.0
  [2d112036] + OrdinaryDiffEqSDIRK v1.3.0
  [669c94d9] + OrdinaryDiffEqSSPRK v1.3.0
  [e3e12d00] + OrdinaryDiffEqStabilizedIRK v1.3.0
  [358294b1] + OrdinaryDiffEqStabilizedRK v1.1.0
  [fa646aed] + OrdinaryDiffEqSymplecticRK v1.3.0
  [b1df2697] + OrdinaryDiffEqTsit5 v1.1.0
  [79d7bb75] + OrdinaryDiffEqVerner v1.2.0
  [90014a1f] + PDMats v0.11.35
  [65ce6f38] + PackageExtensionCompat v1.0.2
  [d96e819e] + Parameters v0.12.3
  [e409e4f3] + PoissonRandom v0.4.4
  [f517fe37] + Polyester v0.7.18
  [1d0040c9] + PolyesterWeave v0.2.2
  [85a6dd25] + PositiveFactorizations v0.2.4
  [d236fae5] + PreallocationTools v0.4.27
βŒ… [aea7be01] + PrecompileTools v1.2.1
  [21216c6a] + Preferences v1.4.3
  [08abe8d2] + PrettyTables v2.4.0
  [43287f4e] + PtrArrays v1.3.0
  [1fd47b50] + QuadGK v2.11.2
  [74087812] + Random123 v1.7.1
  [e6cf234a] + RandomNumbers v1.6.0
  [3cdcf5f2] + RecipesBase v1.3.4
  [731186ca] + RecursiveArrayTools v3.33.0
  [189a3867] + Reexport v1.2.2
  [ae029012] + Requires v1.3.1
  [ae5879a3] + ResettableStacks v1.1.1
  [79098fc4] + Rmath v0.8.0
  [7e49a35a] + RuntimeGeneratedFunctions v0.5.15
  [94e857df] + SIMDTypes v0.1.0
  [0bca4576] + SciMLBase v2.97.0
  [19f34311] + SciMLJacobianOperators v0.1.6
βŒ… [c0aeaf25] + SciMLOperators v0.4.0
  [53ae85a6] + SciMLStructures v1.7.0
  [efcf1570] + Setfield v1.1.2
  [727e6d20] + SimpleNonlinearSolve v2.5.0
  [699a6c99] + SimpleTraits v0.9.4
  [ce78b400] + SimpleUnPack v1.1.0
  [a2af1166] + SortingAlgorithms v1.2.1
  [9f842d2f] + SparseConnectivityTracer v0.6.19
  [47a9eef4] + SparseDiffTools v2.26.0
  [0a514795] + SparseMatrixColorings v0.4.20
  [276daf66] + SpecialFunctions v2.5.1
  [aedffcd0] + Static v1.2.0
  [0d7ed370] + StaticArrayInterface v1.8.0
  [90137ffa] + StaticArrays v1.9.13
  [1e83bf80] + StaticArraysCore v1.4.3
  [10745b16] + Statistics v1.11.1
  [82ae8749] + StatsAPI v1.7.1
  [2913bbd2] + StatsBase v0.34.5
  [4c63d2b9] + StatsFuns v1.5.0
  [9672c7b4] + SteadyStateDiffEq v2.5.0
  [789caeaf] + StochasticDiffEq v6.80.0
  [7792a7ef] + StrideArraysCore v0.5.7
  [892a3eda] + StringManipulation v0.4.1
  [c3572dad] + Sundials v4.28.0
  [2efcf032] + SymbolicIndexingInterface v0.3.40
  [3783bdb8] + TableTraits v1.0.1
  [bd369af6] + Tables v1.12.1
  [8290d209] + ThreadingUtilities v0.5.4
  [a759f4b9] + TimerOutputs v0.5.29
  [781d530d] + TruncatedStacktraces v1.4.0
  [3a884ed6] + UnPack v1.0.2
  [19fa3120] + VertexSafeGraphs v0.2.0
  [1d5cc7b8] + IntelOpenMP_jll v2025.0.4+0
  [856f044c] + MKL_jll v2025.0.1+1
  [efe28fd5] + OpenSpecFun_jll v0.5.6+0
  [f50d1b31] + Rmath_jll v0.5.1+0
βŒ… [fb77eaff] + Sundials_jll v5.2.3+0
  [1317d2d5] + oneTBB_jll v2022.0.0+0
  [0dad84c5] + ArgTools v1.1.2
  [56f22d72] + Artifacts v1.11.0
  [2a0f44e3] + Base64 v1.11.0
  [ade2ca70] + Dates v1.11.0
  [8ba89e20] + Distributed v1.11.0
  [f43a241f] + Downloads v1.6.0
  [7b1f6079] + FileWatching v1.11.0
  [9fa8497b] + Future v1.11.0
  [b77e0a4c] + InteractiveUtils v1.11.0
  [4af54fe1] + LazyArtifacts v1.11.0
  [b27032c2] + LibCURL v0.6.4
  [76f85450] + LibGit2 v1.11.0
  [8f399da3] + Libdl v1.11.0
  [37e2e46d] + LinearAlgebra v1.11.0
  [56ddb016] + Logging v1.11.0
  [d6f4376e] + Markdown v1.11.0
  [a63ad114] + Mmap v1.11.0
  [ca575930] + NetworkOptions v1.2.0
  [44cfe95a] + Pkg v1.11.0
  [de0858da] + Printf v1.11.0
  [9a3f8284] + Random v1.11.0
  [ea8e919c] + SHA v0.7.0
  [9e88b42a] + Serialization v1.11.0
  [1a1011a3] + SharedArrays v1.11.0
  [6462fe0b] + Sockets v1.11.0
  [2f01184e] + SparseArrays v1.11.0
  [4607b0f0] + SuiteSparse
  [fa267f1f] + TOML v1.0.3
  [a4e569a6] + Tar v1.10.0
  [cf7118a7] + UUIDs v1.11.0
  [4ec0a83e] + Unicode v1.11.0
  [e66e0078] + CompilerSupportLibraries_jll v1.1.1+0
  [deac9b47] + LibCURL_jll v8.6.0+0
  [e37daf67] + LibGit2_jll v1.7.2+0
  [29816b5a] + LibSSH2_jll v1.11.0+1
  [c8ffd9c3] + MbedTLS_jll v2.28.6+0
  [14a3606d] + MozillaCACerts_jll v2023.12.12
  [4536629a] + OpenBLAS_jll v0.3.27+1
  [05823500] + OpenLibm_jll v0.8.5+0
  [bea87d4a] + SuiteSparse_jll v7.7.0+0
  [83775a58] + Zlib_jll v1.2.13+1
  [8e850b90] + libblastrampoline_jll v5.11.0+0
  [8e850ede] + nghttp2_jll v1.59.0+0
  [3f19e933] + p7zip_jll v17.4.0+2
        Info Packages marked with βŒƒ and βŒ… have new versions available. Those with βŒƒ may be upgradable, but those with βŒ… are restricted by compatibility constraints from upgrading. To see why use `status --outdated -m`
Precompiling project...
  βœ— BoundaryValueDiffEqFIRK
  βœ— BoundaryValueDiffEqMIRK
  βœ— BoundaryValueDiffEqShooting
  βœ— BoundaryValueDiffEq
  βœ— DifferentialEquations
  0 dependencies successfully precompiled in 16 seconds. 313 already precompiled.
  5 dependencies errored.
  For a report of the errors see `julia> err`. To retry use `pkg> precompile`
 
(Test2) pkg>

And that’s both on Linux and Windows, using 1.11.5 or 1.10.9

In a different project, these 2 coexist just fine, I just can’t upgrade:

  [0c46a032] DifferentialEquations v7.16.1     
βŒ… [a0c0ee7d] DifferentiationInterface v0.6.54