Skip to content

Fix figures (#56)

Fix figures (#56) #277

Triggered via push January 1, 2025 12:14
Status Failure
Total duration 42m 59s
Artifacts

CI.yml

on: push
Matrix: test
Fit to window
Zoom out
Zoom in

Annotations

1 error, 9 warnings, and 1 notice
Julia lts - ubuntu-20.04 - x64 - push
Process completed with exit code 1.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L46
failed to run `@setup` block in src/math.md ```@setup cv_notation using DelaunayTriangulation, CairoMakie, LinearAlgebra a, b, c, d, e, f = (0.0, 0.0), (2.0, 3.0), (4.0, -1.0), (1.0, -4.0), (-4.0, -2.0), (-4.0, 2.0) points = [a, b, c, d, e, f] tri = triangulate(points) centroids = NTuple{2,Float64}[] linesegments = NTuple{2,Float64}[] other_linesegments = NTuple{2,Float64}[] non_cv_midpoints = collect.([ (f .+ b) ./ 2, (b .+ c) ./ 2, (c .+ d) ./ 2, (d .+ e) ./ 2, (e .+ f) ./ 2 ]) for T in each_solid_triangle(tri) i, j, k = triangle_vertices(T) p, q, r = get_point(tri, i, j, k) cent = DelaunayTriangulation.triangle_centroid(p, q, r) push!(centroids, cent) u, v, w = DelaunayTriangulation.triangle_edge_midpoints(p, q, r) any(≈(collect(u)), non_cv_midpoints) ? push!(other_linesegments, cent, u) : push!(linesegments, cent, u) any(≈(collect(v)), non_cv_midpoints) ? push!(other_linesegments, cent, v) : push!(linesegments, cent, v) any(≈(collect(w)), non_cv_midpoints) ? push!(other_linesegments, cent, w) : push!(linesegments, cent, w) end control_volume_verts = vcat(linesegments, centroids) cv_idx = collect(eachindex(control_volume_verts)) DelaunayTriangulation.sort_convex_polygon!(cv_idx, control_volume_verts) fig, ax, sc = poly(control_volume_verts[cv_idx], color=:lightgreen, axis=(width=400, height=400)) triplot!(tri, show_convex_hull=false, show_constrained_edges=false, show_all_points=true, point_color=:black, markersize=11) scatter!(ax, [a, b, c], color=:cyan, markersize=11, strokecolor=:black, strokewidth=1) linesegments!(ax, linesegments, color=:blue, linewidth=3) linesegments!(ax, other_linesegments, color=(:grey, 0.5)) cidx = findfirst(≈(collect((f .+ a .+ b) ./ 3)), collect.(centroids)) lidx = findfirst(≈(collect((f .+ a) ./ 2)), collect.(linesegments)) u, v = centroids[cidx], linesegments[lidx] rot90_uv = [0 -1; 1 0] * collect(u .- v) rot90_uv = 0.8rot90_uv ./ norm(rot90_uv) m = (u .+ v) ./ 2 p = scatter!(ax, [m], color=:blue, markersize=11, strokecolor=:black, strokewidth=1) arrows!(ax, [m[1]], [m[2]], [rot90_uv[1]], [rot90_uv[2]], color=:black) lines!(ax, [u, v], color=:magenta, linewidth=3) translate!(p, 0, 0, 1) scatter!(ax, centroids, color=:red, markersize=11, strokecolor=:black, strokewidth=1) text!(ax, -0.8, -1.7, text=L"\Omega_i", fontsize=24) text!(ax, -3.2, -1.0, text=L"\partial\Omega_i", fontsize=24) text!(ax, -2.0, 1.1, text=L"\sigma", fontsize=24) text!(ax, -2.4, 1.6, text=L"\hat{\mathbf{n}}_{\sigma}", fontsize=24) text!(ax, -1.4, 0.8, text=L"\mathbf{x}_{\sigma}", fontsize=24) text!(ax, 0.2, 0.0, text=L"\mathbf{x}_{i}", fontsize=24) text!(ax, 0.2, -0.5, text=L"v_{k1}", fontsize=24) text!(ax, 3.1, -1.3, text=L"v_{k2}", fontsize=24) text!(ax, 2.1, 2.9, text=L"v_{k3}", fontsize=24) text!(ax, 1.7, 1.5, text=L"T_k", fontsize=24) hidedecorations!(ax) resize_to_layout!(fig) ``` exception = LoadError: Invalid attributes point_color and show_all_points for plot type MakieCore.Plot{Makie.triplot, Tuple{DelaunayTriangulation.Triangulation{Vector{Tuple{Float64, Float64}}, Set{Tuple{Int64, Int64, Int64}}, Vector{Int64}, DelaunayTriangulation.ZeroWeight{Float64}, Int64, Tuple{Int64, Int64}, Set{Tuple{Int64, Int64}}, Tuple{}, Dict{Tuple{Int64, Int64}, Tuple{Vector{Int64}, Int64}}, Dict{Int64, Vector{Int64}}, Dict{Int64, UnitRange{Int64}}, Dict{Int64, DelaunayTriangulation.RepresentativeCoordinates{Int64, Float64}}, DelaunayTriangulation.TriangulationCache{DelaunayTriangulation.Triangulation{Vector{Tuple{Float64, Float64}}, Set{Tuple{Int64, Int64, Int64}}, Vector{Int64}, DelaunayTriangulation.ZeroWeight{Float64}, Int64, Tuple{Int64, Int64}, Set{Tuple{Int64, Int64}}, Tuple{}, Dict{Tuple{Int64, Int64}, Tuple{Vector{Int64}, Int64}}, Dict{Int64, Vector{Int64}}, Dict{Int64, UnitRange{Int64}}, Dict{Int64, DelaunayTriangulation.RepresentativeCoordinates{Int64, Float64}}, DelaunayTriangulation.TriangulationCache{Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing, Nothing}, Nothing}, Vector{Int64}, Set{Tuple{Int64, Int64}}, V
Documentation: ../../../.julia/packages/Documenter/Bs999/src/utilities/utilities.jl#L46
failed to run `@example` block in src/wyos/diffusion_equations.md:399-421 ```@example diffusion_equations BCs_prob = BoundaryConditions(mesh, (x, y, t, u, p) -> -4, Neumann) fvm_prob = FVMProblem(mesh, BCs_prob; diffusion_function=let D = diffusion_function (x, y, t, u, p) -> D(x, y, p) end, initial_condition, final_time) fvm_sol = solve(fvm_prob, TRBDF2(linsolve=KLUFactorization()); saveat=100.0) fvm_sol |> tc #hide for j in eachindex(fvm_sol) ax = Axis(fig[2, j], width=600, height=600, xlabel="x", ylabel="y", title="t = $(fvm_sol.t[j])", titlealign=:left) u = j == 1 ? initial_condition : fvm_sol.u[j] tricontourf!(ax, tri, u, levels=0:0.1:1, colormap=:turbo, extendlow=:auto, extendhigh=:auto) tightlimits!(ax) end resize_to_layout!(fig) fig ``` exception = UndefVarError: `KLUFactorization` not defined in `Main.__atexample__named__diffusion_equations` Suggestion: check for spelling errors or missing imports. Hint: a global variable of this name may be made accessible by importing LinearSolve in the current active module Main Stacktrace: [1] top-level scope @ diffusion_equations.md:407 [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/html/HTMLWriter.jl#L814
For 58 @example blocks, the 'text/html' representation of the resulting object is above the threshold (example_size_threshold: 8192 bytes). - 58 blocks had 'image/png' fallback image representation available, using that. On pages: math.md, tutorials/diffusion_equation_in_a_wedge_with_mixed_boundary_conditions.md, tutorials/diffusion_equation_on_a_square_plate.md, tutorials/diffusion_equation_on_an_annulus.md, tutorials/equilibrium_temperature_distribution_with_mixed_boundary_conditions_and_using_ensembleproblems.md, tutorials/helmholtz_equation_with_inhomogeneous_boundary_conditions.md, tutorials/laplaces_equation_with_internal_dirichlet_conditions.md, tutorials/mean_exit_time.md, tutorials/overview.md, tutorials/piecewise_linear_and_natural_neighbour_interpolation_for_an_advection_diffusion_equation.md, tutorials/porous_fisher_equation_and_travelling_waves.md, tutorials/porous_medium_equation.md, tutorials/reaction_diffusion_brusselator_system_of_pdes.md, tutorials/reaction_diffusion_equation_with_a_time_dependent_dirichlet_boundary_condition_on_a_disk.md, tutorials/solving_mazes_with_laplaces_equation.md, wyos/diffusion_equations.md, wyos/laplaces_equation.md, wyos/linear_reaction_diffusion_equations.md, wyos/mean_exit_time.md, wyos/poissons_equation.md
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `stable` and linking `stable` to `v1.1.5`.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `v1.1` and linking `v1.1` to `v1.1.5`.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `v1.0` and linking `v1.0` to `v1.0.0`.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `v0.4` and linking `v0.4` to `v0.4.9`.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `v0.3` and linking `v0.3` to `v0.3.6`.
Documentation: ../../../.julia/packages/Documenter/Bs999/src/deploydocs.jl#L552
removing `v1` and linking `v1` to `v1.1.5`.
[julia-buildpkg] Caching of the julia depot was not detected
Consider using `julia-actions/cache` to speed up runs https://github.com/julia-actions/cache To ignore, set input `ignore-no-cache: true`