Dear All,
I have developed a package for a heat exchanger. Once BoundaryValueDiffeq V5.10.0 was released, I used it to solve my problem, which is a two-point boundary value problem (BVP). Today, I unexpectedly updated my package, along with BoundaryValueDiffeq, to V5.12.0. Now, I am unable to solve the same problem that I previously solved. When I attempt to downgrade BoundaryValueDiffeq to V5.10.0, I am unable to precompile it again. Unfortunately, I cannot create a minimal working example (MWE) for the issue, but the error is:
ERROR: The following 1 direct dependency failed to precompile:
IonicLiquidDeh1DSteady [5940f117-b31a-4bc9-9d4c-2822927a2039]
Failed to precompile IonicLiquidDeh1DSteady [5940f117-b31a-4bc9-9d4c-2822927a2039] to "/root/.julia/compiled/v1.10/IonicLiquidDeh1DSteady/jl_EE5ckp".
[ Info: Precompilation CreCOPlus5100 is running...
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Precompilation CreCOPlus5100 completed
[ Info: Precompilation CreCOPlus5100 nested is running...
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Precompilation CreCOPlus5100 nested completed
[ Info: Precompilation LiCl is running...
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Precompilation LiCl completed
[ Info: Precompilation CaCl2 is running...
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Precompilation CaCl2 completed
[ Info: Precompilation CreCOPlus5100 nested is running...
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Solving the coil ODE is completed and sol.retcode = Success
[ Info: Precompilation CreCOPlus5100 nested completed
[ Info: Precompilation CreCOPlus5100 is running...
ERROR: LoadError: MethodError: no method matching WARNING: both NonlinearSolve and LineSearches export "BackTracking"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearches export "HagerZhang"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearch export "LiFukushimaLineSearch"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearch export "LineSearchesJL"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearches export "MoreThuente"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearches export "Static"; uses of it in module BoundaryValueDiffEqCore must be qualified
WARNING: both NonlinearSolve and LineSearches export "StrongWolfe"; uses of it in module BoundaryValueDiffEqCore must be qualified
__append_similar!(::RecursiveArrayTools.VectorOfArray{Float64, 2, Vector{Vector{Float64}}}, ::Int64, ::Int64, ::BoundaryValueDiffEqFIRK.FIRKTableau{true, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}})
Closest candidates are:
__append_similar!(::Nothing, ::Any, ::Any, ::Any)
@ BoundaryValueDiffEqCore ~/.julia/packages/BoundaryValueDiffEqCore/azDLi/src/utils.jl:128
__append_similar!(::RecursiveArrayTools.AbstractVectorOfArray, ::Any, ::Any)
@ BoundaryValueDiffEqCore ~/.julia/packages/BoundaryValueDiffEqCore/azDLi/src/utils.jl:129
__append_similar!(::RecursiveArrayTools.AbstractVectorOfArray, ::Any, ::Any, ::BoundaryValueDiffEqFIRK.FIRKTableau{false})
@ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/tqPpf/src/utils.jl:23
...
Stacktrace:
[1] __perform_firk_iteration(cache::BoundaryValueDiffEqFIRK.FIRKCacheNested{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, SciMLBase.TwoPointBVProblem{true}, StaticArraysCore.SVector{10, Float64}, BoundaryValueDiffEqFIRK.RadauIIa7{NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, LineSearch.NoLineSearch{Bool}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, Nothing, Nothing, Nothing}, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}, ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}, ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{true, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{true, 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}}}, SciMLBase.NonlinearProblem{Matrix{Float64}, true, Vector{Float64}, SciMLBase.NonlinearFunction{true, SciMLBase.FullSpecialize, BoundaryValueDiffEqFIRK.var"#71#84"{SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, BoundaryValueDiffEqFIRK.FIRKTableau{true, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED_NO_TIME), Nothing, Nothing, Nothing, Nothing}, @Kwargs{}, SciMLBase.StandardNonlinearProblem}, Float64, Tuple{Tuple{Int64}, 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/tqPpf/src/firk.jl:380
[2] __perform_firk_iteration
@ ~/.julia/packages/BoundaryValueDiffEqFIRK/tqPpf/src/firk.jl:354 [inlined]
[3] solve!(cache::BoundaryValueDiffEqFIRK.FIRKCacheNested{true, Float64, Tuple{Int64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, SciMLBase.TwoPointBVProblem{true}, StaticArraysCore.SVector{10, Float64}, BoundaryValueDiffEqFIRK.RadauIIa7{NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, LineSearch.NoLineSearch{Bool}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, Nothing, Nothing, Nothing}, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}, ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}, ADTypes.AutoSparse{ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.NoSparsityDetector, ADTypes.NoColoringAlgorithm}}, Float64}, BoundaryValueDiffEqFIRK.FIRKTableau{true, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}, BoundaryValueDiffEqFIRK.FIRKInterpTableau{true, 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}}}, SciMLBase.NonlinearProblem{Matrix{Float64}, true, Vector{Float64}, SciMLBase.NonlinearFunction{true, SciMLBase.FullSpecialize, BoundaryValueDiffEqFIRK.var"#71#84"{SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, BoundaryValueDiffEqFIRK.FIRKTableau{true, Int64, Matrix{Float64}, Vector{Float64}, Vector{Float64}}}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED_NO_TIME), Nothing, Nothing, Nothing, Nothing}, @Kwargs{}, SciMLBase.StandardNonlinearProblem}, Float64, Tuple{Tuple{Int64}, Tuple{Int64}}, @NamedTuple{abstol::Float64, dt::Float64, adaptive::Bool}})
@ BoundaryValueDiffEqFIRK ~/.julia/packages/BoundaryValueDiffEqFIRK/tqPpf/src/firk.jl:335
[4] __solve(::SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, ::BoundaryValueDiffEqFIRK.RadauIIa7{NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, LineSearch.NoLineSearch{Bool}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, Nothing, Nothing, Nothing}, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{Nothing, Nothing, Nothing}, Float64}; kwargs::@Kwargs{dt::Float64})
@ BoundaryValueDiffEqCore ~/.julia/packages/BoundaryValueDiffEqCore/azDLi/src/BoundaryValueDiffEqCore.jl:31
[5] __solve
@ ~/.julia/packages/BoundaryValueDiffEqCore/azDLi/src/BoundaryValueDiffEqCore.jl:29 [inlined]
[6] #solve_call#44
@ ~/.julia/packages/DiffEqBase/frOsk/src/solve.jl:612 [inlined]
[7] solve_call
@ ~/.julia/packages/DiffEqBase/frOsk/src/solve.jl:569 [inlined]
[8] #solve_up#53
@ ~/.julia/packages/DiffEqBase/frOsk/src/solve.jl:1092 [inlined]
[9] solve_up
@ ~/.julia/packages/DiffEqBase/frOsk/src/solve.jl:1078 [inlined]
[10] solve(prob::SciMLBase.BVProblem{Vector{Float64}, Tuple{Float64, Float64}, true, true, StaticArraysCore.SVector{10, Float64}, SciMLBase.BVPFunction{true, SciMLBase.FullSpecialize, true, typeof(IonicLiquidDeh1DSteady.ionic_liquid_coil_ode!), Tuple{typeof(IonicLiquidDeh1DSteady.bca!), typeof(IonicLiquidDeh1DSteady.bcb!)}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, RecursiveArrayTools.ArrayPartition{Float64, Tuple{Vector{Float64}, Vector{Float64}}}, Nothing, Nothing, Nothing, Nothing, typeof(SciMLBase.DEFAULT_OBSERVED), Nothing, Nothing, SymbolicIndexingInterface.SymbolCache{Nothing, Nothing, Nothing, Nothing, Dict{Any, Any}}, Nothing}, SciMLBase.TwoPointBVProblem{true}, @Kwargs{}}, args::BoundaryValueDiffEqFIRK.RadauIIa7{NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, LineSearch.NoLineSearch{Bool}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, Nothing, Nothing, Nothing}, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{Nothing, Nothing, Nothing}, Float64}; sensealg::Nothing, u0::Nothing, p::Nothing, wrap::Val{true}, kwargs::@Kwargs{dt::Float64})
@ DiffEqBase ~/.julia/packages/DiffEqBase/frOsk/src/solve.jl:1015
[11] solve_coil_ode
@ /home/IonicLiquidDeh1DSteady.jl/src/SolverX/solver.jl:67 [inlined]
[12] simulate(plateFinCircularTube::IonicLiquidDeh1DSteady.PlateFinCircularTube{Float64, Int64}, fluidThermalData::IonicLiquidDeh1DSteady.FluidThermalData{Float64, IonicLiquidDeh1DSteady.CreCOPlus5100}, dt::Float64, tspan::Tuple{Float64, Float64}; solver::BoundaryValueDiffEqFIRK.RadauIIa7{NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, LineSearch.NoLineSearch{Bool}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, Nothing, Nothing, Nothing}, BoundaryValueDiffEqCore.BVPJacobianAlgorithm{Nothing, Nothing, Nothing}, Float64})
@ IonicLiquidDeh1DSteady /home/IonicLiquidDeh1DSteady.jl/src/Simulation/simulation.jl:49
[13] simulate(plateFinCircularTube::IonicLiquidDeh1DSteady.PlateFinCircularTube{Float64, Int64}, fluidThermalData::IonicLiquidDeh1DSteady.FluidThermalData{Float64, IonicLiquidDeh1DSteady.CreCOPlus5100}, dt::Float64, tspan::Tuple{Float64, Float64})
@ IonicLiquidDeh1DSteady /home/IonicLiquidDeh1DSteady.jl/src/Simulation/simulation.jl:3
[14] top-level scope
@ /home/IonicLiquidDeh1DSteady.jl/src/Simulation/_precompilation.jl:198
[15] include(mod::Module, _path::String)
@ Base ./Base.jl:495
[16] include
@ /home/IonicLiquidDeh1DSteady.jl/src/IonicLiquidDeh1DSteady.jl:1 [inlined]
[17] macro expansion
@ /home/IonicLiquidDeh1DSteady.jl/src/IonicLiquidDeh1DSteady.jl:21 [inlined]
[18] macro expansion
@ ~/.julia/packages/PrecompileTools/L8A3n/src/workloads.jl:78 [inlined]
[19] macro expansion
@ /home/IonicLiquidDeh1DSteady.jl/src/IonicLiquidDeh1DSteady.jl:20 [inlined]
[20] macro expansion
@ ~/.julia/packages/PrecompileTools/L8A3n/src/workloads.jl:140 [inlined]
[21] top-level scope
@ /home/IonicLiquidDeh1DSteady.jl/src/IonicLiquidDeh1DSteady.jl:19
[22] include
@ ./Base.jl:495 [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:2222
[24] top-level scope
@ stdin:3
in expression starting at /home/IonicLiquidDeh1DSteady.jl/src/Simulation/_precompilation.jl:198
in expression starting at /home/IonicLiquidDeh1DSteady.jl/src/IonicLiquidDeh1DSteady.jl:1
in expression starting at stdin:
Stacktrace:
[1] pkgerror(msg::String)
@ Pkg.Types ~/.julia/juliaup/julia-1.10.5+0.x64.linux.gnu/share/julia/stdlib/v1.10/Pkg/src/Types.jl:70
[2] precompile(ctx::Pkg.Types.Context, pkgs::Vector{…}; internal_call::Bool, strict::Bool, warn_loaded::Bool, already_instantiated::Bool, timing::Bool, _from_loading::Bool, kwargs::@Kwargs{…})
@ Pkg.API ~/.julia/juliaup/julia-1.10.5+0.x64.linux.gnu/share/julia/stdlib/v1.10/Pkg/src/API.jl:1700
[3] precompile(pkgs::Vector{Pkg.Types.PackageSpec}; io::Base.TTY, kwargs::@Kwargs{_from_loading::Bool})
@ Pkg.API ~/.julia/juliaup/julia-1.10.5+0.x64.linux.gnu/share/julia/stdlib/v1.10/Pkg/src/API.jl:159
[4] precompile
@ ~/.julia/juliaup/julia-1.10.5+0.x64.linux.gnu/share/julia/stdlib/v1.10/Pkg/src/API.jl:147 [inlined]
[5] #precompile#114
@ ~/.julia/juliaup/julia-1.10.5+0.x64.linux.gnu/share/julia/stdlib/v1.10/Pkg/src/API.jl:146 [inlined]
[6] #invokelatest#2
@ ./essentials.jl:894 [inlined]
[7] invokelatest
@ ./essentials.jl:889 [inlined]
[8] _require(pkg::Base.PkgId, env::String)
@ Base ./loading.jl:1963
[9] __require_prelocked(uuidkey::Base.PkgId, env::String)
@ Base ./loading.jl:1812
[10] #invoke_in_world#3
@ ./essentials.jl:926 [inlined]
[11] invoke_in_world
@ ./essentials.jl:923 [inlined]
[12] _require_prelocked(uuidkey::Base.PkgId, env::String)
@ Base ./loading.jl:1803
[13] macro expansion
@ ./loading.jl:1790 [inlined]
[14] macro expansion
@ ./lock.jl:267 [inlined]
[15] __require(into::Module, mod::Symbol)
@ Base ./loading.jl:1753
[16] #invoke_in_world#3
@ ./essentials.jl:926 [inlined]
[17] invoke_in_world
@ ./essentials.jl:923 [inlined]
[18] require(into::Module, mod::Symbol)
@ Base ./loading.jl:1746
[19] top-level scope
@ /home/IonicLiquidDeh1DSteady.jl/test/Validation/evaporator_validation.jl:4
Some type information was truncated. Use `show(err)` to see complete types.
It is so urgent for me. I would appreciate it if you help me.
Thanks in advance.