Skip to content

Update presentation #136

Update presentation

Update presentation #136

Triggered via push November 21, 2024 15:59
Status Failure
Total duration 12m 13s
Artifacts
Matrix: test
Fit to window
Zoom out
Zoom in

Annotations

10 errors
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/automatic_differentiation.md:26-31 ```@example ad using Unitful, UnitfulAstro θ = [2.7, 0.27, 0.05, 3.0, 0.7, 0.25] ks = 10 .^ range(-3, 0, length=100) / u"Mpc" Ps = P(ks, θ) ``` exception = MethodError: no method matching (::ModelingToolkit.GetUpdatedMTKParameters{SymbolicIndexingInterface.MultipleGetters{SymbolicIndexingInterface.ContinuousTimeseries, Vector{SymbolicUtils.BasicSymbolic{Real}}}, SymbolicIndexingInterface.ParameterHookWrapper{SymbolicIndexingInterface.MultipleSetters{Vector{Any}}, Vector{SymbolicUtils.BasicSymbolic{Real}}}})(::SciMLBase.NonlinearSolution{Float64, 1, Vector{Float64}, Vector{Float64}, SciMLBase.NonlinearProblem{Vector{Float64}, true, ModelingToolkit.MTKParameters{Vector{Float64}, Tuple{}, Tuple{}, Tuple{}}, SciMLBase.NonlinearFunction{true, SciMLBase.FullSpecialize, ModelingToolkit.var"#f#749"{RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0xc6f116ce, 0xc53ffa83, 0xdc800b28, 0xb5a24381, 0xd8b3aaa0), Nothing}, RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋out, :ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0x076926ca, 0x2cfc9925, 0xfb3fb5c1, 0xa7063970, 0xfd19c01b), Nothing}}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, ModelingToolkit.ObservedFunctionCache{ModelingToolkit.NonlinearSystem}, Nothing, ModelingToolkit.NonlinearSystem, Nothing, Nothing}, Base.Pairs{Symbol, Union{}, Tuple{}, @NamedTuple{}}, ModelingToolkit.InitializationSystemMetadata}, NonlinearSolve.NonlinearSolvePolyAlgorithm{:NLS, 7, Tuple{NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.FullStructure}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{true, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.TrueJacobianInitialization{NonlinearSolve.FullStructure, ADTypes.AutoForwardDiff{nothing, Nothing}}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Klement, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.KlementUpdateRule, NonlinearSolve.IllConditionedJacobianReset, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.DiagonalStructure}}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, NonlinearSolve.LineSearchesJL{LineSearches.BackTracking{Float64, Int64}, Bool, Nothing}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :TrustRegion, Missing, NonlinearSolve.GenericTrustRegionScheme{NonlinearSolve.RadiusUpdateSchemes.__Simple, Rational{Int64}, Rational{Int64}, Rational{Int64}, Rational{Int64}, Rational{Int64}, Nothing, Nothing, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.Dogleg{NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.SteepestDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :TrustRegion, Missing
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/automatic_differentiation.md:33-36 ```@example ad using Plots plot(log10.(ks/u"1/Mpc"), log10.(Ps/u"Mpc^3"); xlabel = "lg(k/Mpc⁻¹)", ylabel = "lg(P/Mpc³)", label = nothing) ``` exception = UndefVarError: `Ps` not defined in `Main.__atexample__named__ad` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] top-level scope @ automatic_differentiation.md:35 [2] eval @ ./boot.jl:430 [inlined] [3] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [4] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [5] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [6] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [7] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [8] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [9] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [10] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/automatic_differentiation.md:41-45 ```@example ad using ForwardDiff lgP(lgθ) = log10.(P(ks, 10 .^ lgθ) / u"Mpc^3") # in log-space dlgP_dlgθs = ForwardDiff.jacobian(lgP, log10.(θ)) ``` exception = MethodError: no method matching (::ModelingToolkit.GetUpdatedMTKParameters{SymbolicIndexingInterface.MultipleGetters{SymbolicIndexingInterface.ContinuousTimeseries, Vector{SymbolicUtils.BasicSymbolic{Real}}}, SymbolicIndexingInterface.ParameterHookWrapper{SymbolicIndexingInterface.MultipleSetters{Vector{Any}}, Vector{SymbolicUtils.BasicSymbolic{Real}}}})(::SciMLBase.NonlinearSolution{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}, 1, Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, SciMLBase.NonlinearProblem{Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, true, ModelingToolkit.MTKParameters{Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, Tuple{}, Tuple{}, Tuple{}}, SciMLBase.NonlinearFunction{true, SciMLBase.FullSpecialize, ModelingToolkit.var"#f#749"{RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0x785b56a1, 0x262befb5, 0xa9eaab02, 0x8eef7cec, 0x30611b3c), Nothing}, RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋out, :ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0xdf5ca689, 0x2115b0fd, 0xd1e66181, 0x9eb18beb, 0x69fc4dc4), Nothing}}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, ModelingToolkit.ObservedFunctionCache{ModelingToolkit.NonlinearSystem}, Nothing, ModelingToolkit.NonlinearSystem, Nothing, Nothing}, Base.Pairs{Symbol, Union{}, Tuple{}, @NamedTuple{}}, ModelingToolkit.InitializationSystemMetadata}, NonlinearSolve.NonlinearSolvePolyAlgorithm{:NLS, 7, Tuple{NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.FullStructure}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{true, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.TrueJacobianInitialization{NonlinearSolve.FullStructure, ADTypes.AutoForwardDiff{nothing, Nothing}}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Klement, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.KlementUpdateRule, NonlinearSolve.IllConditionedJacobianReset, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.DiagonalStructure}}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, NonlinearSolve.LineSearchesJL{LineSearches.BackTracking{Float64, Int64}, Bool, Nothing}, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.AutoForwardDiff{nothing, Nothing}, Nothing}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :TrustRegion, Missing, NonlinearSolve.GenericTrustRegionScheme{NonlinearSolve.RadiusUpdateSchemes.__Simple, Rational{Int64}, Rational{Int64}, Rational{Int64}, Rational{In
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/automatic_differentiation.md:48-54 ```@example ad plot( log10.(ks/u"1/Mpc"), dlgP_dlgθs; xlabel = "lg(k/Mpc⁻¹)", ylabel = "∂ lg(P) / ∂ lg(θᵢ)", labels = "θᵢ=" .* ["Tγ0" "Ωc0" "Ωb0" "Neff" "h" "Yp"] ) ``` exception = UndefVarError: `dlgP_dlgθs` not defined in `Main.__atexample__named__ad` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] top-level scope @ automatic_differentiation.md:49 [2] eval @ ./boot.jl:430 [inlined] [3] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [4] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [5] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [6] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [7] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [8] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [9] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [10] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/automatic_differentiation.md:60-79 ```@example ad using DiffResults # Following DiffResults documentation: Pres = DiffResults.JacobianResult(ks/u"1/Mpc", θ) # allocate buffer for values+derivatives for a function with θ-sized input and ks-sized output Pres = ForwardDiff.jacobian!(Pres, lgP, log10.(θ)) # evaluate values+derivatives of lgP(log10.(θ)) and store the results in Pres lgPs = DiffResults.value(Pres) # extract values dlgP_dlgθs = DiffResults.jacobian(Pres) # extract derivatives p1 = plot( log10.(ks/u"1/Mpc"), lgPs; ylabel = "lg(P/Mpc³)", label = nothing ) p2 = plot( log10.(ks/u"1/Mpc"), dlgP_dlgθs; xlabel = "lg(k/Mpc⁻¹)", ylabel = "∂ lg(P) / ∂ lg(θᵢ)", labels = "θᵢ=" .* ["Tγ0" "Ωc0" "Ωb0" "Neff" "h" "Yp"] ) plot(p1, p2, layout=(2, 1), size = (600, 600)) ``` exception = MethodError: no method matching (::ModelingToolkit.GetUpdatedMTKParameters{SymbolicIndexingInterface.MultipleGetters{SymbolicIndexingInterface.ContinuousTimeseries, Vector{SymbolicUtils.BasicSymbolic{Real}}}, SymbolicIndexingInterface.ParameterHookWrapper{SymbolicIndexingInterface.MultipleSetters{Vector{Any}}, Vector{SymbolicUtils.BasicSymbolic{Real}}}})(::SciMLBase.NonlinearSolution{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}, 1, Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, SciMLBase.NonlinearProblem{Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, true, ModelingToolkit.MTKParameters{Vector{ForwardDiff.Dual{ForwardDiff.Tag{typeof(Main.__atexample__named__ad.lgP), Float64}, Float64, 6}}, Tuple{}, Tuple{}, Tuple{}}, SciMLBase.NonlinearFunction{true, SciMLBase.FullSpecialize, ModelingToolkit.var"#f#749"{RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0x785b56a1, 0x262befb5, 0xa9eaab02, 0x8eef7cec, 0x30611b3c), Nothing}, RuntimeGeneratedFunctions.RuntimeGeneratedFunction{(:ˍ₋out, :ˍ₋arg1, :ˍ₋arg2), ModelingToolkit.var"#_RGF_ModTag", ModelingToolkit.var"#_RGF_ModTag", (0xdf5ca689, 0x2115b0fd, 0xd1e66181, 0x9eb18beb, 0x69fc4dc4), Nothing}}, LinearAlgebra.UniformScaling{Bool}, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, ModelingToolkit.ObservedFunctionCache{ModelingToolkit.NonlinearSystem}, Nothing, ModelingToolkit.NonlinearSystem, Nothing, Nothing}, Base.Pairs{Symbol, Union{}, Tuple{}, @NamedTuple{}}, ModelingToolkit.InitializationSystemMetadata}, NonlinearSolve.NonlinearSolvePolyAlgorithm{:NLS, 7, Tuple{NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.FullStructure}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{true, :Broyden, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.GoodBroydenUpdateRule, NonlinearSolve.NoChangeInStateReset{Nothing}, NonlinearSolve.TrueJacobianInitialization{NonlinearSolve.FullStructure, ADTypes.AutoForwardDiff{nothing, Nothing}}}, NonlinearSolve.ApproximateJacobianSolveAlgorithm{false, :Klement, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, NonlinearSolve.KlementUpdateRule, NonlinearSolve.IllConditionedJacobianReset, NonlinearSolve.IdentityInitialization{Nothing, NonlinearSolve.DiagonalStructure}}, NonlinearSolve.GeneralizedFirstOrderAlgorithm{nothing, :NewtonRaphson, NonlinearSolve.NoLineSearch, Missing, NonlinearSolve.NewtonDescent{Nothing, typeof(NonlinearSolve.DEFAULT_PRECS)}, ADTypes.AutoForwardDiff{nothing, Nothing}, ADTypes.Aut
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@setup` block in src/comparison.md ```@setup class using SymBoltz using ModelingToolkit using DelimitedFiles using DataInterpolations using Unitful, UnitfulAstro using Plots; Plots.default(label=nothing) using Printf lmax = 6 M = SymBoltz.ΛCDM(; lmax, h = nothing, Λanalytical = true) pars = SymBoltz.parameters_Planck18(M) function run_class(in::Dict{String, Any}, exec, inpath, outpath) merge!(in, Dict( "root" => outpath, "overwrite_root" => "yes", )) in = sort(collect(in), by = keyval -> keyval[1]) # sort by key in = prod(["$key = $val\n" for (key, val) in in]) # make string with "key = val" lines mkpath(dirname(inpath)) # create directories up to input file, if needed write(inpath, in) # write input string to file mkpath(dirname(outpath)) # create directories up to output file, if needed return run(`$exec $inpath`) # run end function solve_class(pars, k; exec="class", inpath="/tmp/symboltz_class/input.ini", outpath="/tmp/symboltz_class/output/") k = NoUnits(k / u"1/Mpc") in = Dict( "write_background" => "yes", "write_thermodynamics" => "yes", "background_verbose" => 2, "output" => "mPk", # need one to evolve perturbations # TODO: CMB "k_output_values" => k, "ic" => "ad", "modes" => "s", "gauge" => "newtonian", # metric "h" => pars[M.g.h], # photons "T_cmb" => pars[M.γ.T₀], "l_max_g" => lmax, "l_max_pol_g" => lmax, # baryons "Omega_b" => pars[M.b.Ω₀], "YHe" => pars[M.b.rec.Yp], "recombination" => "recfast", # TODO: HyREC "recfast_Hswitch" => 1, "recfast_Heswitch" => 6, "reio_parametrization" => "reio_none", # TODO: enable # cold dark matter "Omega_cdm" => pars[M.c.Ω₀], # neutrinos # TODO: set neutrino stuff to 0 unless otherwise specified "N_ur" => pars[M.ν.Neff], "N_ncdm" => 0.0, # TODO "m_ncdm" => 0.00, # TODO "T_ncdm" => 0.0, # TODO (pars.Neff/3)^(1/4) * (4/11)^(1/3), # TODO: set properly #"Omega_ur" => 7/8 * (pars[M.ν.Neff]/3) * (4/11)^(4/3) * pars.Ωγ0, # TODO: set properly! # massless neutrinos # TODO: proper Neff "l_max_ur" => lmax, "l_max_ncdm" => lmax, # primordial power spectrum "A_s" => 2e-9, # TODO "n_s" => 1.0, # TODO # other stuff "Omega_k" => 0.0, "Omega_fld" => 0.0, "Omega_scf" => 0.0, "Omega_dcdmdr" => 0.0, # approximations (see include/precisions.h) "tight_coupling_trigger_tau_c_over_tau_h" => 1e-2, # cannot turn off? "tight_coupling_trigger_tau_c_over_tau_k" => 1e-3, # cannot turn off "radiation_streaming_approximation" => 3, # turn off "ur_fluid_approximation" => 3, # turn off ) run_class(in, exec, inpath, outpath) output = Dict() for (name, filename, skipstart) in [("bg", "_background.dat", 3), ("th", "_thermodynamics.dat", 10), ("pt", "_perturbations_k0_s.dat", 1), ("P", "_pk.dat", 3)] file = outpath * filename data, head = readdlm(file, skipstart=skipstart, header=true) head = split(join(head, ""), ":") for (n, h) in enumerate(head[begin:end-1]) head[n] = h[begin:end-length(string(n))] end head = string.(head[2:end]) # remove # data = data[:,begin:length(head)] # remove extra empty data rows because of CLASS' messed up names data = Matrix{Float64}(data) output[name] = Dict(head[i] => data[:,i] for i in eachindex(head)) end return output end k = 1e0 / u"Mpc" # 1/Mpc # disagreement on smaller scales sol1 = solve_class(pars, k) sol2 = solve(M, pars, k; solver = SymBoltz.Rodas5P()) # looks like lower-precision KenCarp4 and Kvaerno5 "emulate" radiation streaming, while higher-precision Rodas5P continues in an exact way # map results from both codes to common convention h = pars[M.g.h] sol = Dict( # background "a_bg" => (1 ./ (sol1["bg"]["z"] .+ 1), sol2[M.g.a]
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/comparison.md:223-225 ```@example class plot_compare("a_bg", "t"; lgx=true, lgy=true) # hide ``` exception = UndefVarError: `sol` not defined in `Main.__atexample__named__class` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] plot_compare(xlabel::String, ylabels::String; lgx::Bool, lgy::Bool, alpha::Float64) @ Main.__atexample__named__class ./string:16 [2] top-level scope @ comparison.md:224 [3] eval @ ./boot.jl:430 [inlined] [4] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [5] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [6] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [7] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [8] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [9] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [10] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [11] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/comparison.md:226-228 ```@example class plot_compare("a_bg", "E"; lgx=true, lgy=true) # hide ``` exception = UndefVarError: `sol` not defined in `Main.__atexample__named__class` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] plot_compare(xlabel::String, ylabels::String; lgx::Bool, lgy::Bool, alpha::Float64) @ Main.__atexample__named__class ./string:16 [2] top-level scope @ comparison.md:227 [3] eval @ ./boot.jl:430 [inlined] [4] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [5] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [6] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [7] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [8] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [9] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [10] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [11] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/comparison.md:229-231 ```@example class plot_compare("a_bg", ["ργ", "ρν", "ρb", "ρc", "ρΛ"]; lgx=true, lgy=true) # hide ``` exception = UndefVarError: `sol` not defined in `Main.__atexample__named__class` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] plot_compare(xlabel::String, ylabels::Vector{String}; lgx::Bool, lgy::Bool, alpha::Float64) @ Main.__atexample__named__class ./string:16 [2] top-level scope @ comparison.md:230 [3] eval @ ./boot.jl:430 [inlined] [4] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [5] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [6] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [7] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [8] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [9] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [10] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [11] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L44
failed to run `@example` block in src/comparison.md:234-236 ```@example class plot_compare("a_th", "τ̇"; lgx=true, lgy=true) # hide ``` exception = UndefVarError: `sol` not defined in `Main.__atexample__named__class` Suggestion: check for spelling errors or missing imports. Stacktrace: [1] plot_compare(xlabel::String, ylabels::String; lgx::Bool, lgy::Bool, alpha::Float64) @ Main.__atexample__named__class ./string:16 [2] top-level scope @ comparison.md:235 [3] eval @ ./boot.jl:430 [inlined] [4] #60 @ ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:803 [inlined] [5] cd(f::Documenter.var"#60#62"{Module, Expr}, dir::String) @ Base.Filesystem ./file.jl:112 [6] (::Documenter.var"#59#61"{Documenter.Page, Module, Expr})() @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:802 [7] (::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})() @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:170 [8] with_logstate(f::IOCapture.var"#5#9"{DataType, Documenter.var"#59#61"{Documenter.Page, Module, Expr}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}}, logstate::Base.CoreLogging.LogState) @ Base.CoreLogging ./logging/logging.jl:522 [9] with_logger(f::Function, logger::Base.CoreLogging.ConsoleLogger) @ Base.CoreLogging ./logging/logging.jl:632 [10] capture(f::Documenter.var"#59#61"{Documenter.Page, Module, Expr}; rethrow::Type, color::Bool, passthrough::Bool, capture_buffer::IOBuffer, io_context::Vector{Any}) @ IOCapture ~/.julia/packages/IOCapture/Y5rEA/src/IOCapture.jl:167 [11] runner(::Type{Documenter.Expanders.ExampleBlocks}, node::MarkdownAST.Node{Nothing}, page::Documenter.Page, doc::Documenter.Document) @ Documenter ~/.julia/packages/Documenter/Bs999/src/expander_pipeline.jl:801