From 3c630d1f6c731c4ebee8574db7dc0c3ffa68eab2 Mon Sep 17 00:00:00 2001 From: "Documenter.jl" Date: Tue, 6 Aug 2024 12:53:17 +0000 Subject: [PATCH] build based on 998c42d --- stable | 2 +- v0.16 | 2 +- v0.16.1/.documenter-siteinfo.json | 1 + v0.16.1/api/index.html | 37 + v0.16.1/assets/documenter.js | 1059 +++++++++++++++++ v0.16.1/assets/figures/poincareanim1.gif | Bin 0 -> 25242 bytes v0.16.1/assets/figures/poincareanim2.gif | Bin 0 -> 23961 bytes v0.16.1/assets/figures/poincareanim3.gif | Bin 0 -> 362847 bytes v0.16.1/assets/themes/catppuccin-frappe.css | 1 + v0.16.1/assets/themes/catppuccin-latte.css | 1 + .../assets/themes/catppuccin-macchiato.css | 1 + v0.16.1/assets/themes/catppuccin-mocha.css | 1 + v0.16.1/assets/themes/documenter-dark.css | 7 + v0.16.1/assets/themes/documenter-light.css | 9 + v0.16.1/assets/themeswap.js | 84 ++ v0.16.1/assets/warner.js | 52 + v0.16.1/common/3b6f9ba4.svg | 45 + v0.16.1/common/8737a707.svg | 124 ++ v0.16.1/common/a9f9e818.svg | 46 + v0.16.1/common/b5b1223a.svg | 45 + v0.16.1/common/e40a34be.svg | 49 + v0.16.1/common/index.html | 183 +++ v0.16.1/index.html | 5 + v0.16.1/jet_transport/index.html | 44 + v0.16.1/kepler/4ca9fc7b.svg | 48 + v0.16.1/kepler/c569d86a.svg | 46 + v0.16.1/kepler/fb89632a.svg | 50 + v0.16.1/kepler/index.html | 59 + v0.16.1/lorenz_lyapunov/12e1d07f.svg | 62 + v0.16.1/lorenz_lyapunov/6d97d4d8.svg | 50 + v0.16.1/lorenz_lyapunov/index.html | 50 + v0.16.1/lyapunov_spectrum/index.html | 2 + v0.16.1/objects.inv | Bin 0 -> 2351 bytes v0.16.1/pendulum/0803dac9.svg | 140 +++ v0.16.1/pendulum/index.html | 37 + v0.16.1/poincareanim1.gif | Bin 0 -> 17980 bytes v0.16.1/poincareanim2.gif | Bin 0 -> 24541 bytes v0.16.1/poincareanim3.gif | Bin 0 -> 317626 bytes v0.16.1/root_finding/index.html | 127 ++ v0.16.1/search_index.js | 3 + v0.16.1/simple_example/47ad181b.svg | 197 +++ v0.16.1/simple_example/529b4583.svg | 200 ++++ v0.16.1/simple_example/index.html | 17 + v0.16.1/siteinfo.js | 1 + v0.16.1/taylor_method/index.html | 4 + v0.16.1/taylorize/index.html | 87 ++ versions.js | 2 +- 47 files changed, 2977 insertions(+), 3 deletions(-) create mode 100644 v0.16.1/.documenter-siteinfo.json create mode 100644 v0.16.1/api/index.html create mode 100644 v0.16.1/assets/documenter.js create mode 100644 v0.16.1/assets/figures/poincareanim1.gif create mode 100644 v0.16.1/assets/figures/poincareanim2.gif create mode 100644 v0.16.1/assets/figures/poincareanim3.gif create mode 100644 v0.16.1/assets/themes/catppuccin-frappe.css create mode 100644 v0.16.1/assets/themes/catppuccin-latte.css create mode 100644 v0.16.1/assets/themes/catppuccin-macchiato.css create mode 100644 v0.16.1/assets/themes/catppuccin-mocha.css create mode 100644 v0.16.1/assets/themes/documenter-dark.css create mode 100644 v0.16.1/assets/themes/documenter-light.css create mode 100644 v0.16.1/assets/themeswap.js create mode 100644 v0.16.1/assets/warner.js create mode 100644 v0.16.1/common/3b6f9ba4.svg create mode 100644 v0.16.1/common/8737a707.svg create mode 100644 v0.16.1/common/a9f9e818.svg create mode 100644 v0.16.1/common/b5b1223a.svg create mode 100644 v0.16.1/common/e40a34be.svg create mode 100644 v0.16.1/common/index.html create mode 100644 v0.16.1/index.html create mode 100644 v0.16.1/jet_transport/index.html create mode 100644 v0.16.1/kepler/4ca9fc7b.svg create mode 100644 v0.16.1/kepler/c569d86a.svg create mode 100644 v0.16.1/kepler/fb89632a.svg create mode 100644 v0.16.1/kepler/index.html create mode 100644 v0.16.1/lorenz_lyapunov/12e1d07f.svg create mode 100644 v0.16.1/lorenz_lyapunov/6d97d4d8.svg create mode 100644 v0.16.1/lorenz_lyapunov/index.html create mode 100644 v0.16.1/lyapunov_spectrum/index.html create mode 100644 v0.16.1/objects.inv create mode 100644 v0.16.1/pendulum/0803dac9.svg create mode 100644 v0.16.1/pendulum/index.html create mode 100644 v0.16.1/poincareanim1.gif create mode 100644 v0.16.1/poincareanim2.gif create mode 100644 v0.16.1/poincareanim3.gif create mode 100644 v0.16.1/root_finding/index.html create mode 100644 v0.16.1/search_index.js create mode 100644 v0.16.1/simple_example/47ad181b.svg create mode 100644 v0.16.1/simple_example/529b4583.svg create mode 100644 v0.16.1/simple_example/index.html create mode 100644 v0.16.1/siteinfo.js create mode 100644 v0.16.1/taylor_method/index.html create mode 100644 v0.16.1/taylorize/index.html diff --git a/stable b/stable index 49dd460a9..23fed31c0 120000 --- a/stable +++ b/stable @@ -1 +1 @@ -v0.16.0 \ No newline at end of file +v0.16.1 \ No newline at end of file diff --git a/v0.16 b/v0.16 index 49dd460a9..23fed31c0 120000 --- a/v0.16 +++ b/v0.16 @@ -1 +1 @@ -v0.16.0 \ No newline at end of file +v0.16.1 \ No newline at end of file diff --git a/v0.16.1/.documenter-siteinfo.json b/v0.16.1/.documenter-siteinfo.json new file mode 100644 index 000000000..22f81df8b --- /dev/null +++ b/v0.16.1/.documenter-siteinfo.json @@ -0,0 +1 @@ +{"documenter":{"julia_version":"1.10.4","generation_timestamp":"2024-08-06T12:52:16","documenter_version":"1.5.0"}} \ No newline at end of file diff --git a/v0.16.1/api/index.html b/v0.16.1/api/index.html new file mode 100644 index 000000000..ce7c97067 --- /dev/null +++ b/v0.16.1/api/index.html @@ -0,0 +1,37 @@ + +API · TaylorIntegration.jl

Library


Exported functions

TaylorIntegration.taylorintegFunction
taylorinteg(f, x0, t0, tmax, order, abstol, params[=nothing]; kwargs... )

General-purpose Taylor integrator for the explicit ODE $\dot{x}=f(x, p, t)$, where p are the parameters encoded in params. The initial conditions are specified by x0 at time t0; x0 may be of type T<:Number or Vector{T}, with T including TaylorN{T}; the latter case is of interest for jet transport applications.

The equations of motion are specified by the function f; we follow the same convention of DifferentialEquations.jl to define this function, i.e., f(x, p, t) or f!(dx, x, p, t); see the examples below.

The functions returns a TaylorSolution, whose fields are t and x; they represent, respectively, a vector with the values of time (independent variable), and a vector with the computed values of the dependent variable(s). When the keyword argument dense is set to true, it also outputs in the field p the Taylor polynomial expansion computed at each time step. The integration stops when time is larger than tmax, in which case the last returned value(s) correspond to tmax, or when the number of saved steps is larger than maxsteps.

The integration method uses polynomial expansions on the independent variable of order order; the parameter abstol serves to define the time step using the last two Taylor coefficients of the expansions. Make sure you use a large enough order to assure convergence.

Currently, the recognized keyword arguments are:

  • maxsteps[=500]: maximum number of integration steps.
  • parse_eqs[=true]: use the specialized method of jetcoeffs! created with @taylorize.
  • dense[=true]: output the Taylor polynomial expansion at each time step.

Examples

For one dependent variable the function f defines the RHS of the equation of motion, returning the value of $\dot{x}$. The arguments of this function are (x, p, t), where x are the dependent variables, p are the paremeters and t is the independent variable.

For several (two or more) dependent variables, the function f! defines the RHS of the equations of motion, mutating (in-place) the (preallocated) vector with components of $\dot{x}$. The arguments of this function are (dx, x, p, t), where dx is the preallocated vector of $\dot{x}$, x are the dependent variables, p are the paremeters entering the ODEs and t is the independent variable. The function may return this vector or simply nothing.

using TaylorIntegration
+
+f(x, p, t) = x^2
+
+sol = taylorinteg(f, 3, 0.0, 0.3, 25, 1.0e-20, maxsteps=100 )
+
+function f!(dx, x, p, t)
+    for i in eachindex(x)
+        dx[i] = x[i]^2
+    end
+    return nothing
+end
+
+sol = taylorinteg(f!, [3, 3], 0.0, 0.3, 25, 1.0e-20, maxsteps=100 )
+
+sol = taylorinteg(f!, [3, 3], 0.0, 0.3, 25, 1.0e-20, maxsteps=100, dense=true )
source
TaylorIntegration.lyap_taylorintegFunction
lyap_taylorinteg(f!, q0, t0, tmax, order, abstol[, jacobianfunc!=nothing];
+    maxsteps::Int=500, parse_eqs::Bool=true)
+lyap_taylorinteg(f!, q0, trange, order, abstol[, jacobianfunc!=nothing];
+    maxsteps::Int=500, parse_eqs::Bool=true)

Similar to taylorinteg for the calculation of the Lyapunov spectrum. Note that the number of TaylorN variables should be set previously by the user (e.g., by means of TaylorSeries.set_variables) and should be equal to the length of the vector of initial conditions q0. Otherwise, whenever length(q0) != TaylorSeries.get_numvars(), then lyap_taylorinteg throws an AssertionError. Optionally, the user may provide a Jacobian function jacobianfunc! to evaluate the current value of the Jacobian. Otherwise, the current value of the Jacobian is computed via automatic differentiation using TaylorSeries.jl.

source

Exported types

TaylorIntegration.TaylorSolutionType

TaylorSolution{T, U, N, VT<:AbstractVector{T}, AX<:AbstractArray{U,N}, P<:Union{Nothing, AbstractArray{Taylor1{U}, N}}, VTE<:Union{Nothing, AbstractVector{U}}, AXE<:Union{Nothing, AbstractArray{U, N}}, VΛ<:Union{Nothing, AbstractArray{U,N}}} <: AbstractTaylorSolution{T, U}

This struct represents the return type for taylorinteg. Fields t and x represent, respectively, a vector with the values of time (independent variable), and a vector with the computed values of the dependent variable(s). When taylorinteg is called with dense=true, then field p stores the Taylor polynomial expansion computed at each time step. Fields tevents, xevents and gresids are related to root-finding methods of taylorinteg, while λ is related to the output of lyap_taylorinteg.

source

Internal

TaylorIntegration.BookKeepingType
BookKeeping

Mutable struct that contains all the bookkeeping vectors/dictionaries used within _make_parsed_jetcoeffs: - d_indx : Dictionary mapping new variables (symbols) to old (perhaps indexed) symbols - d_assign : Dictionary with the numeric assignments (that are substituted) - d_decl : Dictionary declared arrays - v_newvars : Symbols of auxiliary indexed vars - v_arraydecl: Symbols which are explicitly declared as Array or Vector - v_array1 : Symbols which are explicitly declared as Array{Taylor1{T},1} - v_array2 : Symbols which are explicitly declared as Array{Taylor1{T},2} - v_array3 : Symbols which are explicitly declared as Array{Taylor1{T},3} - v_array4 : Symbols which are explicitly declared as Array{Taylor1{T},4} - v_preamb : Symbols or Expr used in the preamble (declarations, etc) - retvar : Guessed returned variable, which defines the LHS of the ODEs

source
TaylorIntegration.RetAllocType
RetAlloc{T <: Number}

Struct related to the returned variables that are pre-allocated when @taylorize is used. - v0 : Array{T,1} - v1 : Vector{Array{T,1}} - v2 : Vector{Array{T,2}} - v3 : Vector{Array{T,3}} - v4 : Vector{Array{T,4}}

source
TaylorIntegration.__jetcoeffs!Method
__jetcoeffs!(::Val{false}, f, t, x, params, rv)
+__jetcoeffs!(::Val{true}, f, t, x, params, rv)
+__jetcoeffs!(::Val{false}, f, t, x, dx, xaux, params, rv)
+__jetcoeffs!(::Val{true}, f, t, x, dx, xaux, params, rv)

Chooses a method of jetcoeffs! (hard-coded) or the generated by @taylorize) depending on Val{bool} (bool::Bool).

source
TaylorIntegration._capture_fn_args_body!Function

_capture_fn_args_body!(ex, dd::Dict{Symbol, Any})

Captures the name of a function, arguments, body and other properties, returning them as the values of the dictionary dd, which is updated in place.

source
TaylorIntegration._defs_allocs!Function

_defs_allocs!(preamble, fnargs, bkkeep, [inloop=false, ex_aux::Expr(:block,)])

Returns a vector with expressions defining the auxiliary variables in the preamble, and the declaration of the arrays. This function may modify bkkeep.d_indx if new variables are introduced. bkkeep.v_preamb is for bookkeeping the introduced variables.

source
TaylorIntegration._determine_parsing!Method
_determine_parsing!(parse_eqs::Bool, f, t, x, params)
+_determine_parsing!(parse_eqs::Bool, f, t, x, dx, params)

Check if the parsed method of jetcoeffs! exists and check it runs without error.

source
TaylorIntegration._extract_partsMethod

_extract_parts(ex::Expr)

Returns the function name, the function arguments, and the body of a function passed as an Expr. The function may be provided as a one-line function, or in the long form (anonymous functions do not work).

source
TaylorIntegration._make_parsed_jetcoeffsMethod

_make_parsed_jetcoeffs( ex )

This function constructs the expressions of two new methods, the first equivalent to the differential equations (jetcoeffs!), which exploits the mutating functions of TaylorSeries.jl, and the second one (allocatejetcoeffs) preallocates any auxiliary Taylor1 or Vector{Taylor1{T}} needed.

source
TaylorIntegration._newfnbody!Method

_newfnbody!(fnbody, fnargs, bkkeep)

Returns a new (modified) body of the function, a priori unfolding the expression graph (AST) as unary and binary calls, and updates the bookkeeping structure bkkeep.

source
TaylorIntegration._newheadMethod

_newhead(fn, fnargs)

Creates the head of the new method of jetcoeffs! and _allocate_jetcoeffs. fn is the name of the passed function and fnargs is a vector with its arguments defning the function (which are either three or four).

source
TaylorIntegration._parse_newfnbody!Method

parsenewfnbody!(ex::Expr, preex::Expr, prealloc::Expr, bkkeep::BookKeeping, inloop::Bool)

Parses ex (the new body of the function) replacing the expressions to use the mutating functions of TaylorSeries, and building the preamble preex and prealloc expressions. This is done by traversing recursively (again) the args of ex, updating the bookkeeping struct bkkeep, in particular the fieldnames v_newvars and d_assign.

source
TaylorIntegration._preamble_bodyMethod

_preamble_body(fnbody, fnargs)

Returns expressions for the preamble, the declaration of arrays, the body and the bookkeeping struct, which will be used to build the new functions. fnbody is the expression with the body of the original function (already adapted), fnargs is a vector of symbols of the original diferential equations function.

source
TaylorIntegration._rename_indexedvarsMethod

_rename_indexedvars(fnbody)

Renames the indexed variables (using Espresso.genname()) that exists in fnbody. Returns fnbody with the renamed variables and a dictionary that links the new variables to the old indexed ones.

source
TaylorIntegration._replace_expr!Method

_replace_expr!(ex::Expr, preex::Expr, , prealloc::Expr, i::Int, aalhs, aarhs, bkkeep::BookKeeping)

Replaces the calls in ex.args[i], and updates preex and prealloc with the appropriate expressions, based on the the LHS (aalhs) and RHS (aarhs) of the base assignment. The bookkeeping struct is updated (v_newvars) within _replacecalls!. d_indx is used to bring back the indexed variables.

source
TaylorIntegration._replacecalls!Method

_replacecalls!(bkkeep, fnold, newvar)

Replaces the symbols of unary and binary calls of the expression fnold, which defines newvar, by the mutating functions in TaylorSeries.jl. The vector bkkeep.v_vars is updated if new auxiliary variables are introduced (bookkeeping).

source
TaylorIntegration._split_arraydecl!Method

_split_arraydecl!(bkkeep)

Split bkkeep.varraydecl in the vector (bkkeep.varray1), matrix (bkkeep.v_array2), etc, to properly construct the RetAlloc variable.

source
TaylorIntegration.findroot!Method
findroot!(t, x, dx, g_tupl_old, g_tupl, eventorder, tvS, xvS, gvS,
+    t0, δt_old, x_dx, x_dx_val, g_dg, g_dg_val, nrabstol,
+    newtoniter, nevents) -> nevents

Internal root-finding subroutine, based on Newton-Raphson process. If there is a crossing, then the crossing data is stored in tvS, xvS and gvS and nevents, the number of events/crossings, is updated. Here t is a Taylor1 polynomial which represents the independent variable; x is an array of Taylor1 variables which represent the vector of dependent variables; dx is an array of Taylor1 variables which represent the LHS of the ODE; g_tupl_old is the last-before-current value returned by event function g and g_tupl is the current one; eventorder is the order of the derivative of g whose roots the user is interested in finding; tvS stores the surface-crossing instants; xvS stores the value of the solution at each of the crossings; gvS stores the values of the event function g (or its eventorder-th derivative) at each of the crossings; t0 is the current time; δt_old is the last time-step size; x_dx, x_dx_val, g_dg, g_dg_val are auxiliary variables; nrabstol is the Newton-Raphson process tolerance; newtoniter is the maximum allowed number of Newton-Raphson iteration; nevents is the current number of detected events/crossings.

source
TaylorIntegration.init_psolMethod
init_psol(::Val{true}, xv::Array{U,1}, x::Taylor1{U}) where {U<:Number}
+init_psol(::Val{true}, xv::Array{U,2}, x::Array{Taylor1{U},1}) where {U<:Number}
+init_psol(::Val{false}, ::Array{U,1}, ::Taylor1{U}) where {U<:Number}
+init_psol(::Val{false}, ::Array{U,2}, ::Array{Taylor1{U},1}) where {U<:Number}

Auxiliary function to initialize psol during a call to taylorinteg. When the first argument in the call signature is Val(false) this function simply returns nothing. Otherwise, when the first argument in the call signature is Val(true), then the appropriate array is allocated and returned; this array is where the Taylor polynomials associated to the solution will be stored, corresponding to field :p in TaylorSolution.

source
TaylorIntegration.jetcoeffs!Method
jetcoeffs!(eqsdiff!::Function, t, x, dx, xaux, params)

Mutates x in-place using the recursion relation of the derivatives obtained from the differential equations $\dot{x}=dx/dt=f(x, p, t)$.

eqsdiff! is the function defining the RHS of the ODE, x contains the Taylor1 expansion of the dependent variables and t is the independent variable, and params are the parameters appearing on the function defining the differential equation. See taylorinteg for examples and convention for eqsdiff. Note that x is of type Vector{Taylor1{U}} where U<:Number; t is of type Taylor1{T} where T<:Real. In this case, two auxiliary containers dx and xaux (both of the same type as x) are needed to avoid allocations.

Initially, x contains only the 0-th order Taylor coefficient of the current system state (the initial conditions), and jetcoeffs! computes recursively the high-order derivates back into x.

source
TaylorIntegration.jetcoeffs!Method
jetcoeffs!(eqsdiff::Function, t, x, params)

Returns an updated x using the recursion relation of the derivatives obtained from the differential equations $\dot{x}=dx/dt=f(x, p, t)$.

eqsdiff is the function defining the RHS of the ODE, x contains the Taylor1 expansion of the dependent variable(s) and t is the independent variable, and params are the parameters appearing on the function defining the differential equation. See taylorinteg for examples and convention for eqsdiff. Note that x is of type Taylor1{U} where U<:Number; t is of type Taylor1{T} where T<:Real.

Initially, x contains only the 0-th order Taylor coefficient of the current system state (the initial conditions), and jetcoeffs! computes recursively the high-order derivates back into x.

source
TaylorIntegration.lyap_jetcoeffs!Method
lyap_jetcoeffs!(t, x, dx, jac, varsaux)

Similar to jetcoeffs! for the calculation of the Lyapunov spectrum. Updates only the elements of x which correspond to the solution of the 1st-order variational equations $\dot{\xi}=J \cdot \xi$, where $J$ is the Jacobian matrix, i.e., the linearization of the equations of motion. jac is the Taylor expansion of $J$ wrt the independent variable, around the current initial condition. varsaux is an auxiliary array of type Array{eltype(jac),3} to avoid allocations. Calling this method assumes that jac has been computed previously using stabilitymatrix!.

source
TaylorIntegration.nrconvergencecriterionMethod
nrconvergencecriterion(g_val, nrabstol::T, nriter::Int, newtoniter::Int) where {T<:Real}

A rudimentary convergence criterion for the Newton-Raphson root-finding process. g_val may be either a Real, Taylor1{T} or a TaylorN{T}, where T<:Real. Returns true if: 1) the absolute value of g_val, the value of the event function g evaluated at the current estimated root by the Newton-Raphson process, is less than the nrabstol tolerance; and 2) the number of iterations nriter of the Newton-Raphson process is less than the maximum allowed number of iterations, newtoniter; otherwise, returns false.

source
TaylorIntegration.set_psol!Method
set_psol!(::Val{true}, psol::Array{Taylor1{U},1}, nsteps::Int, x::Taylor1{U}) where {U<:Number}
+set_psol!(::Val{true}, psol::Array{Taylor1{U},2}, nsteps::Int, x::Vector{Taylor1{U}}) where {U<:Number}
+set_psol!(::Val{false}, args...)

Auxiliary function to save Taylor polynomials in a call to taylorinteg. When the first argument in the call signature is Val(true), sets appropriate elements of argument psol. Otherwise, when the first argument in the call signature is Val(false), this function simply returns nothing. Argument psol is the array where the Taylor polynomials associated to the solution will be stored, corresponding to field :p in TaylorSolution. See also init_psol.

source
TaylorIntegration.stabilitymatrix!Method
stabilitymatrix!(eqsdiff!, t, x, δx, dδx, jac, _δv, params[, jacobianfunc!=nothing])

Updates the matrix jac::Matrix{Taylor1{U}} (linearized equations of motion) computed from the equations of motion (eqsdiff!), at time t at x; x is of type Vector{Taylor1{U}}, where U<:Number. δx, dδx and _δv are auxiliary arrays of type Vector{TaylorN{Taylor1{U}}} to avoid allocations. Optionally, the user may provide a Jacobian function jacobianfunc! to compute jac. Otherwise, jac is computed via automatic differentiation using TaylorSeries.jl.

source
TaylorIntegration.stepsizeMethod
stepsize(x, epsilon) -> h

Returns a maximum time-step for a the Taylor expansion x using a prescribed absolute tolerance epsilon and the last two Taylor coefficients of (each component of) x.

Note that x is of type Taylor1{U} or Vector{Taylor1{U}}, including also the cases Taylor1{TaylorN{U}} and Vector{Taylor1{TaylorN{U}}}.

Depending of eltype(x), i.e., U<:Number, it may be necessary to overload stepsize, specializing it on the type U, to avoid type instabilities.

source
TaylorIntegration.surfacecrossingMethod
surfacecrossing(g_old, g_now, eventorder::Int)

Detect if the solution crossed a root of event function g. g_old represents the last-before-current value of event function g, and g_now represents the current one; these are Tuple{Bool,Taylor1{T}}s. eventorder is the order of the derivative of the event function g whose root we are trying to find. Returns true if the constant terms of g_old[2] and g_now[2] have different signs (i.e., if one is positive and the other one is negative). Otherwise, if g_old[2] and g_now[2] have the same sign or if the first component of either of them is false, then it returns false.

source
TaylorIntegration.taylorstep!Method
taylorstep!(::Val{false}, f, t, x, abstol, params, rv, parse_eqs=true) -> δt
+taylorstep!(::Val{true}, f, t, x, abstol, params, rv, parse_eqs=true) -> δt
+taylorstep!(::Val{false}, f!, t, x, dx, xaux, abstol, params, rv, parse_eqs=true) -> δt
+taylorstep!(::Val{true}, f!, t, x, dx, xaux, abstol, params, rv, parse_eqs=true) -> δt

One-step Taylor integration for the one-dependent variable ODE $\dot{x}=dx/dt=f(x, p, t)$ with initial conditions $x(t_0)=x_0$. Returns the time-step δt of the actual integration carried out (δt is positive).

Here, f represents the function defining the RHS of the ODE (see taylorinteg), t is the independent variable, x contains the Taylor expansion of the dependent variable, order is the degree used for the Taylor1 polynomials during the integration abstol is the absolute tolerance used to determine the time step of the integration, and params are the parameters entering the ODE functions. For several variables, dx and xaux, both of the same type as x, are needed to save allocations. Finally, parse_eqs is a switch to force not using (parse_eqs=false) the specialized method of jetcoeffs! created with @taylorize; the default is true (parse the equations). Finally, parse_eqs is a switch to force not using (parse_eqs=false) the specialized method of jetcoeffs! created with @taylorize; the default is true (parse the equations). The first argument in the function call Val{bool} (bool::Bool) controls whether a specialized `jetcoeffs! method is being used or not.

source
TaylorIntegration.timeindexMethod
timeindex(sol::TaylorSolution, t::TT) where TT

Return the index of sol.t corresponding to t and the time elapsed from sol.t0 to t.

source

Index

diff --git a/v0.16.1/assets/documenter.js b/v0.16.1/assets/documenter.js new file mode 100644 index 000000000..b2bdd43ee --- /dev/null +++ b/v0.16.1/assets/documenter.js @@ -0,0 +1,1059 @@ +// Generated by Documenter.jl +requirejs.config({ + paths: { + 'highlight-julia': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.8.0/languages/julia.min', + 'headroom': 'https://cdnjs.cloudflare.com/ajax/libs/headroom/0.12.0/headroom.min', + 'jqueryui': 'https://cdnjs.cloudflare.com/ajax/libs/jqueryui/1.13.2/jquery-ui.min', + 'katex-auto-render': 'https://cdnjs.cloudflare.com/ajax/libs/KaTeX/0.16.8/contrib/auto-render.min', + 'jquery': 'https://cdnjs.cloudflare.com/ajax/libs/jquery/3.7.0/jquery.min', + 'headroom-jquery': 'https://cdnjs.cloudflare.com/ajax/libs/headroom/0.12.0/jQuery.headroom.min', + 'katex': 'https://cdnjs.cloudflare.com/ajax/libs/KaTeX/0.16.8/katex.min', + 'highlight': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.8.0/highlight.min', + 'highlight-julia-repl': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.8.0/languages/julia-repl.min', + }, + shim: { + "highlight-julia": { + "deps": [ + "highlight" + ] + }, + "katex-auto-render": { + "deps": [ + "katex" + ] + }, + "headroom-jquery": { + "deps": [ + "jquery", + "headroom" + ] + }, + "highlight-julia-repl": { + "deps": [ + "highlight" + ] + } +} +}); +//////////////////////////////////////////////////////////////////////////////// +require(['jquery', 'katex', 'katex-auto-render'], function($, katex, renderMathInElement) { +$(document).ready(function() { + renderMathInElement( + document.body, + { + "delimiters": [ + { + "left": "$", + "right": "$", + "display": false + }, + { + "left": "$$", + "right": "$$", + "display": true + }, + { + "left": "\\[", + "right": "\\]", + "display": true + } + ] +} + + ); +}) + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery', 'highlight', 'highlight-julia', 'highlight-julia-repl'], function($) { +$(document).ready(function() { + hljs.highlightAll(); +}) + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +let timer = 0; +var isExpanded = true; + +$(document).on("click", ".docstring header", function () { + let articleToggleTitle = "Expand docstring"; + + debounce(() => { + if ($(this).siblings("section").is(":visible")) { + $(this) + .find(".docstring-article-toggle-button") + .removeClass("fa-chevron-down") + .addClass("fa-chevron-right"); + } else { + $(this) + .find(".docstring-article-toggle-button") + .removeClass("fa-chevron-right") + .addClass("fa-chevron-down"); + + articleToggleTitle = "Collapse docstring"; + } + + $(this) + .find(".docstring-article-toggle-button") + .prop("title", articleToggleTitle); + $(this).siblings("section").slideToggle(); + }); +}); + +$(document).on("click", ".docs-article-toggle-button", function (event) { + let articleToggleTitle = "Expand docstring"; + let navArticleToggleTitle = "Expand all docstrings"; + let animationSpeed = event.noToggleAnimation ? 0 : 400; + + debounce(() => { + if (isExpanded) { + $(this).removeClass("fa-chevron-up").addClass("fa-chevron-down"); + $(".docstring-article-toggle-button") + .removeClass("fa-chevron-down") + .addClass("fa-chevron-right"); + + isExpanded = false; + + $(".docstring section").slideUp(animationSpeed); + } else { + $(this).removeClass("fa-chevron-down").addClass("fa-chevron-up"); + $(".docstring-article-toggle-button") + .removeClass("fa-chevron-right") + .addClass("fa-chevron-down"); + + isExpanded = true; + articleToggleTitle = "Collapse docstring"; + navArticleToggleTitle = "Collapse all docstrings"; + + $(".docstring section").slideDown(animationSpeed); + } + + $(this).prop("title", navArticleToggleTitle); + $(".docstring-article-toggle-button").prop("title", articleToggleTitle); + }); +}); + +function debounce(callback, timeout = 300) { + if (Date.now() - timer > timeout) { + callback(); + } + + clearTimeout(timer); + + timer = Date.now(); +} + +}) +//////////////////////////////////////////////////////////////////////////////// +require([], function() { +function addCopyButtonCallbacks() { + for (const el of document.getElementsByTagName("pre")) { + const button = document.createElement("button"); + button.classList.add("copy-button", "fa-solid", "fa-copy"); + button.setAttribute("aria-label", "Copy this code block"); + button.setAttribute("title", "Copy"); + + el.appendChild(button); + + const success = function () { + button.classList.add("success", "fa-check"); + button.classList.remove("fa-copy"); + }; + + const failure = function () { + button.classList.add("error", "fa-xmark"); + button.classList.remove("fa-copy"); + }; + + button.addEventListener("click", function () { + copyToClipboard(el.innerText).then(success, failure); + + setTimeout(function () { + button.classList.add("fa-copy"); + button.classList.remove("success", "fa-check", "fa-xmark"); + }, 5000); + }); + } +} + +function copyToClipboard(text) { + // clipboard API is only available in secure contexts + if (window.navigator && window.navigator.clipboard) { + return window.navigator.clipboard.writeText(text); + } else { + return new Promise(function (resolve, reject) { + try { + const el = document.createElement("textarea"); + el.textContent = text; + el.style.position = "fixed"; + el.style.opacity = 0; + document.body.appendChild(el); + el.select(); + document.execCommand("copy"); + + resolve(); + } catch (err) { + reject(err); + } finally { + document.body.removeChild(el); + } + }); + } +} + +if (document.readyState === "loading") { + document.addEventListener("DOMContentLoaded", addCopyButtonCallbacks); +} else { + addCopyButtonCallbacks(); +} + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery', 'headroom', 'headroom-jquery'], function($, Headroom) { + +// Manages the top navigation bar (hides it when the user starts scrolling down on the +// mobile). +window.Headroom = Headroom; // work around buggy module loading? +$(document).ready(function () { + $("#documenter .docs-navbar").headroom({ + tolerance: { up: 10, down: 10 }, + }); +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +$(document).ready(function () { + let meta = $("div[data-docstringscollapsed]").data(); + + if (meta?.docstringscollapsed) { + $("#documenter-article-toggle-button").trigger({ + type: "click", + noToggleAnimation: true, + }); + } +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +/* +To get an in-depth about the thought process you can refer: https://hetarth02.hashnode.dev/series/gsoc + +PSEUDOCODE: + +Searching happens automatically as the user types or adjusts the selected filters. +To preserve responsiveness, as much as possible of the slow parts of the search are done +in a web worker. Searching and result generation are done in the worker, and filtering and +DOM updates are done in the main thread. The filters are in the main thread as they should +be very quick to apply. This lets filters be changed without re-searching with minisearch +(which is possible even if filtering is on the worker thread) and also lets filters be +changed _while_ the worker is searching and without message passing (neither of which are +possible if filtering is on the worker thread) + +SEARCH WORKER: + +Import minisearch + +Build index + +On message from main thread + run search + find the first 200 unique results from each category, and compute their divs for display + note that this is necessary and sufficient information for the main thread to find the + first 200 unique results from any given filter set + post results to main thread + +MAIN: + +Launch worker + +Declare nonconstant globals (worker_is_running, last_search_text, unfiltered_results) + +On text update + if worker is not running, launch_search() + +launch_search + set worker_is_running to true, set last_search_text to the search text + post the search query to worker + +on message from worker + if last_search_text is not the same as the text in the search field, + the latest search result is not reflective of the latest search query, so update again + launch_search() + otherwise + set worker_is_running to false + + regardless, display the new search results to the user + save the unfiltered_results as a global + update_search() + +on filter click + adjust the filter selection + update_search() + +update_search + apply search filters by looping through the unfiltered_results and finding the first 200 + unique results that match the filters + + Update the DOM +*/ + +/////// SEARCH WORKER /////// + +function worker_function(documenterSearchIndex, documenterBaseURL, filters) { + importScripts( + "https://cdn.jsdelivr.net/npm/minisearch@6.1.0/dist/umd/index.min.js" + ); + + let data = documenterSearchIndex.map((x, key) => { + x["id"] = key; // minisearch requires a unique for each object + return x; + }); + + // list below is the lunr 2.1.3 list minus the intersect with names(Base) + // (all, any, get, in, is, only, which) and (do, else, for, let, where, while, with) + // ideally we'd just filter the original list but it's not available as a variable + const stopWords = new Set([ + "a", + "able", + "about", + "across", + "after", + "almost", + "also", + "am", + "among", + "an", + "and", + "are", + "as", + "at", + "be", + "because", + "been", + "but", + "by", + "can", + "cannot", + "could", + "dear", + "did", + "does", + "either", + "ever", + "every", + "from", + "got", + "had", + "has", + "have", + "he", + "her", + "hers", + "him", + "his", + "how", + "however", + "i", + "if", + "into", + "it", + "its", + "just", + "least", + "like", + "likely", + "may", + "me", + "might", + "most", + "must", + "my", + "neither", + "no", + "nor", + "not", + "of", + "off", + "often", + "on", + "or", + "other", + "our", + "own", + "rather", + "said", + "say", + "says", + "she", + "should", + "since", + "so", + "some", + "than", + "that", + "the", + "their", + "them", + "then", + "there", + "these", + "they", + "this", + "tis", + "to", + "too", + "twas", + "us", + "wants", + "was", + "we", + "were", + "what", + "when", + "who", + "whom", + "why", + "will", + "would", + "yet", + "you", + "your", + ]); + + let index = new MiniSearch({ + fields: ["title", "text"], // fields to index for full-text search + storeFields: ["location", "title", "text", "category", "page"], // fields to return with results + processTerm: (term) => { + let word = stopWords.has(term) ? null : term; + if (word) { + // custom trimmer that doesn't strip @ and !, which are used in julia macro and function names + word = word + .replace(/^[^a-zA-Z0-9@!]+/, "") + .replace(/[^a-zA-Z0-9@!]+$/, ""); + + word = word.toLowerCase(); + } + + return word ?? null; + }, + // add . as a separator, because otherwise "title": "Documenter.Anchors.add!", would not + // find anything if searching for "add!", only for the entire qualification + tokenize: (string) => string.split(/[\s\-\.]+/), + // options which will be applied during the search + searchOptions: { + prefix: true, + boost: { title: 100 }, + fuzzy: 2, + }, + }); + + index.addAll(data); + + /** + * Used to map characters to HTML entities. + * Refer: https://github.com/lodash/lodash/blob/main/src/escape.ts + */ + const htmlEscapes = { + "&": "&", + "<": "<", + ">": ">", + '"': """, + "'": "'", + }; + + /** + * Used to match HTML entities and HTML characters. + * Refer: https://github.com/lodash/lodash/blob/main/src/escape.ts + */ + const reUnescapedHtml = /[&<>"']/g; + const reHasUnescapedHtml = RegExp(reUnescapedHtml.source); + + /** + * Escape function from lodash + * Refer: https://github.com/lodash/lodash/blob/main/src/escape.ts + */ + function escape(string) { + return string && reHasUnescapedHtml.test(string) + ? string.replace(reUnescapedHtml, (chr) => htmlEscapes[chr]) + : string || ""; + } + + /** + * RegX escape function from MDN + * Refer: https://developer.mozilla.org/en-US/docs/Web/JavaScript/Guide/Regular_Expressions#escaping + */ + function escapeRegExp(string) { + return string.replace(/[.*+?^${}()|[\]\\]/g, "\\$&"); // $& means the whole matched string + } + + /** + * Make the result component given a minisearch result data object and the value + * of the search input as queryString. To view the result object structure, refer: + * https://lucaong.github.io/minisearch/modules/_minisearch_.html#searchresult + * + * @param {object} result + * @param {string} querystring + * @returns string + */ + function make_search_result(result, querystring) { + let search_divider = `
`; + let display_link = + result.location.slice(Math.max(0), Math.min(50, result.location.length)) + + (result.location.length > 30 ? "..." : ""); // To cut-off the link because it messes with the overflow of the whole div + + if (result.page !== "") { + display_link += ` (${result.page})`; + } + searchstring = escapeRegExp(querystring); + let textindex = new RegExp(`${searchstring}`, "i").exec(result.text); + let text = + textindex !== null + ? result.text.slice( + Math.max(textindex.index - 100, 0), + Math.min( + textindex.index + querystring.length + 100, + result.text.length + ) + ) + : ""; // cut-off text before and after from the match + + text = text.length ? escape(text) : ""; + + let display_result = text.length + ? "..." + + text.replace( + new RegExp(`${escape(searchstring)}`, "i"), // For first occurrence + '$&' + ) + + "..." + : ""; // highlights the match + + let in_code = false; + if (!["page", "section"].includes(result.category.toLowerCase())) { + in_code = true; + } + + // We encode the full url to escape some special characters which can lead to broken links + let result_div = ` + +
+
${escape(result.title)}
+
${result.category}
+
+

+ ${display_result} +

+
+ ${display_link} +
+
+ ${search_divider} + `; + + return result_div; + } + + self.onmessage = function (e) { + let query = e.data; + let results = index.search(query, { + filter: (result) => { + // Only return relevant results + return result.score >= 1; + }, + combineWith: "AND", + }); + + // Pre-filter to deduplicate and limit to 200 per category to the extent + // possible without knowing what the filters are. + let filtered_results = []; + let counts = {}; + for (let filter of filters) { + counts[filter] = 0; + } + let present = {}; + + for (let result of results) { + cat = result.category; + cnt = counts[cat]; + if (cnt < 200) { + id = cat + "---" + result.location; + if (present[id]) { + continue; + } + present[id] = true; + filtered_results.push({ + location: result.location, + category: cat, + div: make_search_result(result, query), + }); + } + } + + postMessage(filtered_results); + }; +} + +// `worker = Threads.@spawn worker_function(documenterSearchIndex)`, but in JavaScript! +const filters = [ + ...new Set(documenterSearchIndex["docs"].map((x) => x.category)), +]; +const worker_str = + "(" + + worker_function.toString() + + ")(" + + JSON.stringify(documenterSearchIndex["docs"]) + + "," + + JSON.stringify(documenterBaseURL) + + "," + + JSON.stringify(filters) + + ")"; +const worker_blob = new Blob([worker_str], { type: "text/javascript" }); +const worker = new Worker(URL.createObjectURL(worker_blob)); + +/////// SEARCH MAIN /////// + +// Whether the worker is currently handling a search. This is a boolean +// as the worker only ever handles 1 or 0 searches at a time. +var worker_is_running = false; + +// The last search text that was sent to the worker. This is used to determine +// if the worker should be launched again when it reports back results. +var last_search_text = ""; + +// The results of the last search. This, in combination with the state of the filters +// in the DOM, is used compute the results to display on calls to update_search. +var unfiltered_results = []; + +// Which filter is currently selected +var selected_filter = ""; + +$(document).on("input", ".documenter-search-input", function (event) { + if (!worker_is_running) { + launch_search(); + } +}); + +function launch_search() { + worker_is_running = true; + last_search_text = $(".documenter-search-input").val(); + worker.postMessage(last_search_text); +} + +worker.onmessage = function (e) { + if (last_search_text !== $(".documenter-search-input").val()) { + launch_search(); + } else { + worker_is_running = false; + } + + unfiltered_results = e.data; + update_search(); +}; + +$(document).on("click", ".search-filter", function () { + if ($(this).hasClass("search-filter-selected")) { + selected_filter = ""; + } else { + selected_filter = $(this).text().toLowerCase(); + } + + // This updates search results and toggles classes for UI: + update_search(); +}); + +/** + * Make/Update the search component + */ +function update_search() { + let querystring = $(".documenter-search-input").val(); + + if (querystring.trim()) { + if (selected_filter == "") { + results = unfiltered_results; + } else { + results = unfiltered_results.filter((result) => { + return selected_filter == result.category.toLowerCase(); + }); + } + + let search_result_container = ``; + let modal_filters = make_modal_body_filters(); + let search_divider = `
`; + + if (results.length) { + let links = []; + let count = 0; + let search_results = ""; + + for (var i = 0, n = results.length; i < n && count < 200; ++i) { + let result = results[i]; + if (result.location && !links.includes(result.location)) { + search_results += result.div; + count++; + links.push(result.location); + } + } + + if (count == 1) { + count_str = "1 result"; + } else if (count == 200) { + count_str = "200+ results"; + } else { + count_str = count + " results"; + } + let result_count = `
${count_str}
`; + + search_result_container = ` +
+ ${modal_filters} + ${search_divider} + ${result_count} +
+ ${search_results} +
+
+ `; + } else { + search_result_container = ` +
+ ${modal_filters} + ${search_divider} +
0 result(s)
+
+
No result found!
+ `; + } + + if ($(".search-modal-card-body").hasClass("is-justify-content-center")) { + $(".search-modal-card-body").removeClass("is-justify-content-center"); + } + + $(".search-modal-card-body").html(search_result_container); + } else { + if (!$(".search-modal-card-body").hasClass("is-justify-content-center")) { + $(".search-modal-card-body").addClass("is-justify-content-center"); + } + + $(".search-modal-card-body").html(` +
Type something to get started!
+ `); + } +} + +/** + * Make the modal filter html + * + * @returns string + */ +function make_modal_body_filters() { + let str = filters + .map((val) => { + if (selected_filter == val.toLowerCase()) { + return `${val}`; + } else { + return `${val}`; + } + }) + .join(""); + + return ` +
+ Filters: + ${str} +
`; +} + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +// Modal settings dialog +$(document).ready(function () { + var settings = $("#documenter-settings"); + $("#documenter-settings-button").click(function () { + settings.toggleClass("is-active"); + }); + // Close the dialog if X is clicked + $("#documenter-settings button.delete").click(function () { + settings.removeClass("is-active"); + }); + // Close dialog if ESC is pressed + $(document).keyup(function (e) { + if (e.keyCode == 27) settings.removeClass("is-active"); + }); +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +$(document).ready(function () { + let search_modal_header = ` + + `; + + let initial_search_body = ` +
Type something to get started!
+ `; + + let search_modal_footer = ` + + `; + + $(document.body).append( + ` + + ` + ); + + document.querySelector(".docs-search-query").addEventListener("click", () => { + openModal(); + }); + + document + .querySelector(".close-search-modal") + .addEventListener("click", () => { + closeModal(); + }); + + $(document).on("click", ".search-result-link", function () { + closeModal(); + }); + + document.addEventListener("keydown", (event) => { + if ((event.ctrlKey || event.metaKey) && event.key === "/") { + openModal(); + } else if (event.key === "Escape") { + closeModal(); + } + + return false; + }); + + // Functions to open and close a modal + function openModal() { + let searchModal = document.querySelector("#search-modal"); + + searchModal.classList.add("is-active"); + document.querySelector(".documenter-search-input").focus(); + } + + function closeModal() { + let searchModal = document.querySelector("#search-modal"); + let initial_search_body = ` +
Type something to get started!
+ `; + + searchModal.classList.remove("is-active"); + document.querySelector(".documenter-search-input").blur(); + + if (!$(".search-modal-card-body").hasClass("is-justify-content-center")) { + $(".search-modal-card-body").addClass("is-justify-content-center"); + } + + $(".documenter-search-input").val(""); + $(".search-modal-card-body").html(initial_search_body); + } + + document + .querySelector("#search-modal .modal-background") + .addEventListener("click", () => { + closeModal(); + }); +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +// Manages the showing and hiding of the sidebar. +$(document).ready(function () { + var sidebar = $("#documenter > .docs-sidebar"); + var sidebar_button = $("#documenter-sidebar-button"); + sidebar_button.click(function (ev) { + ev.preventDefault(); + sidebar.toggleClass("visible"); + if (sidebar.hasClass("visible")) { + // Makes sure that the current menu item is visible in the sidebar. + $("#documenter .docs-menu a.is-active").focus(); + } + }); + $("#documenter > .docs-main").bind("click", function (ev) { + if ($(ev.target).is(sidebar_button)) { + return; + } + if (sidebar.hasClass("visible")) { + sidebar.removeClass("visible"); + } + }); +}); + +// Resizes the package name / sitename in the sidebar if it is too wide. +// Inspired by: https://github.com/davatron5000/FitText.js +$(document).ready(function () { + e = $("#documenter .docs-autofit"); + function resize() { + var L = parseInt(e.css("max-width"), 10); + var L0 = e.width(); + if (L0 > L) { + var h0 = parseInt(e.css("font-size"), 10); + e.css("font-size", (L * h0) / L0); + // TODO: make sure it survives resizes? + } + } + // call once and then register events + resize(); + $(window).resize(resize); + $(window).on("orientationchange", resize); +}); + +// Scroll the navigation bar to the currently selected menu item +$(document).ready(function () { + var sidebar = $("#documenter .docs-menu").get(0); + var active = $("#documenter .docs-menu .is-active").get(0); + if (typeof active !== "undefined") { + sidebar.scrollTop = active.offsetTop - sidebar.offsetTop - 15; + } +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +// Theme picker setup +$(document).ready(function () { + // onchange callback + $("#documenter-themepicker").change(function themepick_callback(ev) { + var themename = $("#documenter-themepicker option:selected").attr("value"); + if (themename === "auto") { + // set_theme(window.matchMedia('(prefers-color-scheme: dark)').matches ? 'dark' : 'light'); + window.localStorage.removeItem("documenter-theme"); + } else { + // set_theme(themename); + window.localStorage.setItem("documenter-theme", themename); + } + // We re-use the global function from themeswap.js to actually do the swapping. + set_theme_from_local_storage(); + }); + + // Make sure that the themepicker displays the correct theme when the theme is retrieved + // from localStorage + if (typeof window.localStorage !== "undefined") { + var theme = window.localStorage.getItem("documenter-theme"); + if (theme !== null) { + $("#documenter-themepicker option").each(function (i, e) { + e.selected = e.value === theme; + }); + } + } +}); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery'], function($) { + +// update the version selector with info from the siteinfo.js and ../versions.js files +$(document).ready(function () { + // If the version selector is disabled with DOCUMENTER_VERSION_SELECTOR_DISABLED in the + // siteinfo.js file, we just return immediately and not display the version selector. + if ( + typeof DOCUMENTER_VERSION_SELECTOR_DISABLED === "boolean" && + DOCUMENTER_VERSION_SELECTOR_DISABLED + ) { + return; + } + + var version_selector = $("#documenter .docs-version-selector"); + var version_selector_select = $("#documenter .docs-version-selector select"); + + version_selector_select.change(function (x) { + target_href = version_selector_select + .children("option:selected") + .get(0).value; + window.location.href = target_href; + }); + + // add the current version to the selector based on siteinfo.js, but only if the selector is empty + if ( + typeof DOCUMENTER_CURRENT_VERSION !== "undefined" && + $("#version-selector > option").length == 0 + ) { + var option = $( + "" + ); + version_selector_select.append(option); + } + + if (typeof DOC_VERSIONS !== "undefined") { + var existing_versions = version_selector_select.children("option"); + var existing_versions_texts = existing_versions.map(function (i, x) { + return x.text; + }); + DOC_VERSIONS.forEach(function (each) { + var version_url = documenterBaseURL + "/../" + each + "/"; + var existing_id = $.inArray(each, existing_versions_texts); + // if not already in the version selector, add it as a new option, + // otherwise update the old option with the URL and enable it + if (existing_id == -1) { + var option = $( + "" + ); + version_selector_select.append(option); + } else { + var option = existing_versions[existing_id]; + option.value = version_url; + option.disabled = false; + } + }); + } + + // only show the version selector if the selector has been populated + if (version_selector_select.children("option").length > 0) { + version_selector.toggleClass("visible"); + } +}); + +}) diff --git a/v0.16.1/assets/figures/poincareanim1.gif b/v0.16.1/assets/figures/poincareanim1.gif new file mode 100644 index 0000000000000000000000000000000000000000..ae5c0abd0b0195687407a99d268d9a46f52db538 GIT binary patch literal 25242 zcmdSBhgXyRn(uul1PDDe=@6Q9M4B`q^e$BeK?SkUMFj;xOz54UD7^_t5s=g>ji8wQof2GyrVc&g7#@zkE0)}EP}nVHv}nAe|K z;Hf{mckkYP%o+aA%F4F)0C(Rt>Hr}M&(0R?CsmPC=|-4_sq9_+qd`B&(F`l z`_RAdETHc^2v7fc$iR7MXlU5LS@_^tME6ca|54=NIU0?Ak7wlk1D=tyk9|8IN6uru zoyLux$H&Jf;u$+n8b43QGk%_er++%cTqjIQiJE$dEMlC-LH%K`uYYu z3m1)x=S@Ekniemb@hqM-FJ82@wPEorpLeWWbai!g|5)u_IOyr=>BF;jF)%PNIJYs3 zXX9dIWaQhoZ)0nRW1Ht=n-}AF){iIVS0^VYf8g1cUB?d_eNo!#BtJv@iU zdndU4{ry8cXSk!Iqhma07bhntr+ChBXLv4f=jZ1acyPbr#F5=lH#JdJHdGfE6(a!Q z(}D9CLMRS^0pZ`d@jFcbC=S4puxb^iHu^$o1ue0KY0ZH!Zk)Q{$#j5SsT3;2__}>1@VHq zS$Uo&K;{P}`uPBaq_t%^aWX#?HMj}Qrf3P&YV#!)B^{9ug03{xC##BA zr%s<1NK-{VEPm|NpL7eAK1;-#txpUnQaUwzu_f>+!tN36NK_+<-;n_BOG1?qYD<1i z&+g-5Yq%Jwhi-=AIG(y3I43Ufz3hvPVFY;QU%UnvI#>w+T%Snv76}lXs2!vVG1OGO zG+BdKCxZ+~ZCOlpU#9RQrDjop6L6iW5dunYkw}2V-BH?5DSAt+kw_)+GiM;X5B~!d zYSMWU7`>j0FAtM_mbJ3PH+P!|@N}^sG1L*ECQSOPj1mwHGy54VKm%b85O zstG`tBw9%+^k%>uS9H`hA&y#FY5t6t_lB>#!j?hoCyd-J5Qc}S8!`6-WFN-?!@C;( za`0k93NGY6)g{1C1tt!_IAM}E>5t-`e7HB79xk)t{x}}zPVzbSA!)RLa>9ic8m-10 zJRbxf#%;~yJ#EDj0Sxe>7Q#*cLpl})D%0)F`TZrT~JTfGMo7iCq4y&xCa~ z)z_Mb+fTn4B2@&Egk%yR$-&#)eSO@HuVA+Wf*gZ52|PTV$|u3VGYBRwajQuZXCet` z^4(n@oL$f=s9MVH+EBU&ASv=~cTEdO94mSbj4J?)`h#s&-7OQLAa3*(z!WEj76eLN zUS>1Ek-MGH)pM#J-h9ExN#`rPWPnvrWrR`0ROk`n{cX|yU%G|`gqvJ-N3yV zU2}g4q9Qj$0-@jJ4B`RM!KJdW>v5gK&S)g?8rH%F?MJ<=l!Q_G1wa8bp|Tu-Qp+<# zID7Ohh>%nxp_vPO4nPtuYO3;7qTyE)X9>8hD1WW_FpAxo^~7PoD%6yIe(|22B)BLQ zlq3lFN&{tkh?LM)P!T8CM%X5+h@lL({K1VgH}4Ert0R= z=i&hqAbKH0GweT4jvC$u0U*Q)ai-xRo$=)Xr`OLIls^u37&u=EPRrq)ch;7E_^grk zB?$OcO7eW7m_# zdINsA#iQb9CGD4u|3{IHvdzcs#_@yiYv_KN6x!j?&u-D8$6K-{-ObCPXX3GhMH(5B z9fq-LSTP|rR?}+Ol1)POG>Z7-b9L)oCsck~HCI4dk|U5ldxkO86C( zsVp2~6#kJ8pp#lwr>3EjupIz|uwYk7S1O;xQe&R|IpOJ>ACoU6vsFiKJdmpd{4g(a z3DPvAWM`mWR(Z*L^7c2iPA>b%(BsoU5JAj!D>uV6Q$(s!m*m~RWvRUapfjr4z$R?^hHjRYqr)X0`rO*hc{{99)eEsH9kAMmeZvtW>wf>Q(9I83ywN`{pWMI zmf;oU2@6)~T4#70y5JEtSY?Y+t(I3We*s~Z;_bi1K^2R1?KQ*+o7_y=__aJE)Z+B+FPt+zomhZLm(Fu{kU^BqPP#PXjlf4$AK0xzn; z>8x7jU(tKKWIz;u&<#c~@>AlNsojA)(uF|l^c;ohw!O8-nhpG|TTW7DNzyhsa9zpY z>pdy6AnXCr35-Y{XNx!=ulpe@zyoF?etIR;m13`x8R7oU8pLbY_18)hTGa1g8 zD3d+M`;rfaQXgzXo_P%sQ@TO4l2*VdAJEvq&S1jD-q45p%3rX z%B*Wr(q^N$8d2;}p9MajjoUt(fj)xnG{WxG982C}T0WPt-jZg%yw7|uMft8*_^$E! zZXEg|WN1{(sMWCE8kOE!?mhyQeryANblZNb4E`(E{1wgoZ&gy8$xz?P_O^`mzE|n3 z!x+GEHGsw_VEI+RQcS=~MS!EbKU8N@0ad@4`KsVD+4D-0~Zbhml%S4 zVyT^RjMOec-a*(mA@1H`V?hktK``oIP8lD~F<*OVK&%#Z{1Ghi$S0ZKKh-SolS~My zO3)44powe2ledExUIiD(P-iZ|vao?UWBy;DLHV(vR7If_1EGOOp|*@+p)z4DW3VO8}@z4YbN&1&&oIRW)bAiB1obl zdMYA%M9l1?{kGI+8xs09BfM^sioie& zE)2|qpLpy)Q5B_ZgHm?1Qy@mrN_CjDTnZs|vRrnmSVyYfaw_#U1OiK|@F0Z^0JfY| zRE8<}Al631n4R9+KV-X~dJArvP-w%?uXfY;eU@!28O*^Je0YctvJDsO1s{W0lpE-X}E`J(9K7q&|i_f2^ z&Yzmd|9+A`!(1?M2mSL-!NTi;rTBs|dkSo7!Ny6!%mk^BA@ygmT*jGXDo(Hr0R=Za zGi~6`n1_V5pL*H=#L$pbg0?Vlj&ijOW{8B&#y@g?mWxB@ws+pjw$IFYocftR4=s?P zsGSi+l1nv9rIeZx1EYS7q;oPb0)q8}1q(h0! z7jZkeXv&PQxx-(LL-bB_OIap;l$m|GbmMqVVJlmZ-en*ZPQ8ra)Iw7dDMMJdavwUR zJm{h{Hw4jR2)P-VgA73eTf`~|@h1u84qsC3<=BNLsYE;<6$-*UCo2d^%haL8Is$D8dT&{jcQj-m;?#ikbX|J}(u1W5wc{*FuL|iM(SNmA2 zw%xAQ8CBbuRh!>d`)sMUEHJT7sHQ=;CRe*MALmf*&Rd7ktjl{`_b#ZeG^?(?tFB|U zuF0;ZJ*cKNr@o}U-dUM~3j;cvY`8dW09Y~LS`gS0L*#{lCSpj>8pwc#8G(jDt%lMk ziQ{B-&Q~di(T&WtjjU6R>}QRT<3=upCLYVC%U(^ame(yw>YIh?O`(zWsQRR(ru)$5 z3~1vte`ASeG~f>(p$+G|8&E7+)Y*u8a3tF6DXb$6^a`>?eju%Yx?+e61T)8Mv>*l=^l zcB|m_x$Jh6?smuJ_6;ajUl{AIjh(=0wtIHB!Is;yh}*OI+Lau!nqk<29PD^I7PW>I zCh7Rh*O8^!@xZY|IjmzYr=z#MBXF%lj-)e_uk*8JXLfsM%vz@gNtXy;SEgoH)|0NR zurA~AsuUUD&yLO6iK)3$UYM}%CgIrX?&q~r&+8pu_mDSt=*1qev|C$twTJcet;G&Z z*$;I;AF+HrN*+0WR@Bw)wQL!&npm@5>$RB|zHQmCE9|v@7Ivu6IH}Mveb)6OuXi>t zZm!$@*OdL@)bmrlu=CnxoI)qasfU1~k5E7HBC)S=w7=@8{~qf=iNe5=<-md00CAEH zNsm2Q&vVxG5ccyn_;eRnPd^W?r|+_Ucdl)>J!|B(yVc1Fep2iG*V*co&YR@(VOQ8X zuIl$l^b9Ib52#Kzso!nZOoC~%b?Q3x>QCE?To1X;)@7dGZ_#6aH$3=$U6*zKpiPp^ zqv@b0B0Y9VHbOlk2J3@H`7I_+E$K3;BeF0r5!f|DdbLxkr~19m!fjsYe{<`3dp#tb zU|H2F99_k}m#2d-<=CKM4W7hTeYjlp$thzQsm zDNbB|93}lYdGq5NlIryQ2f#i9R-A#{n<4U^fkymTDx@U&K0|pi17n}X=~GR>XD@lr zGA7T?z^RzN&$36%WTQ&Y?!dUde{G!c#33ldZnwoH)hC>LCWXI6S*U18&f#3h=+Wf+ zRz$vc$DnVL9Y9w(;#YWvh8|n}sv%(T%%LBF5})+_hm3c%gXLjeY)= z;$07Cf6s{9ZzvbuM%+f>>ivAZZ~I5wwvJeI5Dg0bZW!);JCbrK$~*9Vui=O9hA|OK zaW@v6oLiqJw?7kIO!scfylBs&{Pku1=a+lf{Q4^Ypdn25P)YC4ucE(N$%m^7Rufl; z>YRtG>X+k(m&x~+Uwv3Y*sjI-t;J`oQM9f}Ev->O*5i2A$<@~dZPzLN)~Pbq<6G95 zm)7kFHYj;E;?y=sZ8vOvH|)|ks9H8imNrVko3`AWlxmw$+szW6&C*YscFmi_OPf^S ztrD&+Th%Qh+bv3;EvipjrA=FeOIzEZZAz}~5|wR;?e;usdpm8Ls%e{GX?qT|Gtaq0 zsj>sM-T8^ynM>Q*#x?GMmUePMyFWR1=aqK>+ua=0Zf@G{T;ncoaW@;Zm&3XDQ+e;= z$=*}cUUu4EZsXqh;+`{T|0(Bwj`IH5lYJ-DzH{1scH{o(;=Us2z=`wVsq(?elY{H1 z1I4rh=f;EM#RCP<;dRbKC*{MVCx`N=!?tHjUF<8blUH7`u7>Iz`8XfF2|G&2I|}JN z@?AUnLVnyMdK|2G-0gTg5^)@tcf8SkJiT$8Lw>R+eDdqYNvGqGj6bY$HpKdekklJGQ@^L3=zFxe;bp73I+6~KUi0?NxyQkkj5r7g6`P0%6 zY9@>Ah-tw; zK>I(Y&KK)m zX@CrMyv!ph(Ua&?qfKz@e<-1Cd_y4@lD@;wr7p4DX!jn}UHR*h6wyouA9d<6aXd98 zb1AN06{kJi-`DH2p`eXRa~|9+EHRbe$Z+66Hu8{ie}eIla#hoJ2f2pPzZOpq_nt8H zg_}d|_eacdIrQH&Q@ZwQbv*MaO{_8}C9Cg&mxQ=Tz*aLrx@qC3m?ieqqEzFb%>ry( z(g-d#9{{dp;aqpFIpzH7jdrPZ=BeBCsGnO**#kF|C#G~D6KiRM(QHbnBKglbqSZv* zYlH6Q4u>;CGdE*PJ=`pKfOJV{svixH+$T9(y;MKe=lnVFSd_9*rM2IrxW{agvBvuB z5;K8th!K7UEtz(R<~!&JEgNh24)lhYIPPs_oDhgLU7% zGI|aApswGTn9uk9^C)+9^X8kg?_Jk$3VTe(93BU5ukOD( zn(K4E@L%Eher_MrFtHx_c4Rw61%N7mIwO$95;LIm_ZUCn!dDbt(**Y!lu0h~aL+6~ zEs3vUrPGlVO^s z?QK|;+oQxOCcYRAsa*eXX9YG^PCiZSKv9HF75Am%toGLJXV1LP<_y5v>MDZ0=n&P1 zT%N^P9_byINCitC-e6jtlm2&p%{;S`RoV%z&jV7(E%^zq=@_@QMDwfh{xI#hcB_1c z_bVM|=VO_!x{<+;B8`v8+=5l^{p^Wp5Y`qek?E$qRN~yOwxAU)tMyo?Kkhls_p#(v z@t&jB=TAo+Eu_orsGZ~c65I*+##>}>1Vq2^T+FkOYc9X>Qm`dy=F0-;*Rs^>Z$mt{ z&Jy4?aRwLb5_ac%PhJ3>vZ(m?soN6S1F(2QpQ#sbsHEGIhx}-e8BGowx=e=u-@z zXqh@Oj|6Kur5GDwhi&CPgc-J`n96J2e0XO++>9;t7B6<>{%fg7E4NfLDy>@<@gH2b zq7(F3+P>YYmU4A*O0cBY7@Y{`6(-ykQg%+2xRToSEKJRTXrxoAzOz6gK>&-h!3{)` zn5DC=8%C;d`kM)^>|2GunSLH(0~;vc28p=?G#H~x)U}OeU(cH#J(9PW=)AkcA`Crm|h#`T2*Msj1K0%-#OZu9@<8?PG1KM_Zj;=0JJJR-y3e z^FT3oIQa`x5a}b3GRttyccsGSx=sJ5UejdZZrIWK!`7$X`!)A34n`YrZ>~sJgRH;| zV;EwM!Z!od;gD-%jZ^_*Qdp2R>Fu$G;5VTp&ll2JeqrHCJ1)wFS3%7_=o0Nc$67>J zwT4J8T;xJi%+)%EEcz&f@4z}_y6orBua#RRO&`9vx`mSRq_aQf&wK2FyQxjy;8L_b zcXhd2UDV}+gT>+sF_)SlO0ZO`gV*NylN85#{x1Us$<0FJuC)c?Z@0VSbYF~pQ^=Dx z+3xumS~9voo+rn*-TS`l#o)oz7sb=9J~UbB08vtoO5aw0sP10>C8r#X^sRxAP|2># z*K>4UZ4Cx?xpqp6(F?UY|ODWjM8;$zLlTTViYa;b-^N!UV3${H2!Vn z_k;qfHiy+CId4o`LgAeH+6v>O7q%dwc)Hc`!N|n7KveluMxCg=X8ZVL*UQQB>v_(r z3zNfS*T&l@@}4&=O!eu$8v8c=O(9zZ<#nJ%Xm03zv_og4>&pzHfGq(ADuLae<9qnN$&%hCm_0)X+K2AZN zUn#89t$in;YD!M5J+#|F^M(Jof*Cw3x%W}~uJ5s>oXpqI{`;DH?o8L^w6a16&D&jH z$=9x*1jm8TC}iNmmjXIX9w3< zENoO&KUvujJpK7yV)T{nd6J~Z{m>Z^%_D6lZ^@u52@|8qm)dkYw*ygLcj%O=I!|*u zwOhOYQGowQbcmn+N)U3;tI**cD^m#b8|vs7~J z_26mC;o6B8wZDPlPlgn}_DIUD*-xjnQa_Hbq3WG8aF^G(8z??fTZVsy<{d78x~ni4o(ZT$``?HOoY+in$Uy z#5T*fG%F0NI$9B5-)mMMx+N>mto=j!h zN~YPBmI<7GbdZET8*XEn(|EAc#t7D==E>rWPUbqx=4Q=(>DvC%M{_f({r#u*%;I*> z(kw5%ls8^E-if(yA=tOiH4JiU+L28~&JUGv!Cs1}3=W@K0pF?Ipcd@g zSmoMSM2!cQ8>}71+ELA~osx}-HB{~yz~W}HDLdFA9qnLC?P}YOWOwb@AnmI0j<0rD z898l%&JI6Toyw(-VVO=*9UY`)XN9d!;!#How6i=;ry{#Ep;9LXt5ZDQS+>;K`~V{tnP4} zHeqf@dUZz`X*U^b_n>W;%Ihx0knYn2y%hfL#L8~fPQAlPy~Z3p%@aK>(wflBn7v+_>p||}0bm*wZ z?#c2u{b_@cw1)nQBc#O$s13A8Mn4$N6T~j5He+pS?+)BW2P(lB=dDe>W0ALJhz+pF zMeAV~6iV~vaFkh-k8Km5SF*`DvH1+x2S!Yz%6==K*mQ~bC3fg$c$4o^Anz8$Smb6H zyu}yzHo%<=fL@r2g##F6o&U*pO9<0*s_sq_GHy;} zKAQOKHj(8&k^NyJCvzgVY~oAnMBd0m{;!FG{fV!HlWrdPRSu;+BhsE^vXqV81^_nC zh!wMuc}9~}>q#bYd9+pp)gzM=v%VBF#Pk-+b} zA3`XrjA35{tLitbwZ^}_`>7pU*5oD!sRXE%6#eDy$Fz!A1)u{#Audd*VJsFxf86~n zA|CTovci~l`e9%Q4Foz@l4BBt+lxCo++6NtQ&kn`hZSQ$q~pfZuRxc|osPCQ(M&muF^El$;-4x?hzr>;`zxw(mN=6P(BmyFx?Lao~bv0tw4N zw*)Nb`xx0a39mn+qa;xazSQ48r}ysum{!+Ee&(IEAhaS6THqb%>AjPq{TlsR>-C?o zS6l2lNM$UiF(X%s=!}e;j~n`q^(w-bu5YwC6c>oi8@*~bH}vIxUwz%_;nrMNia|sD z`RUQ_>W{vL2E5-##6N?CT(X@(K`&>|_>fC4&G^DJ_-Fm-ZrRTIGd|9q4Pbq_G#dyH z;QtxK^U?NaF#qT5pCQ8KOFu)!+W6=*YM1QhqqHvP z%)irt%s3Gtx+Vqy)uMcLAbAElae7XE9#wtKyA@<=%yM;L0&p8Y6j^)b>2`+5{ zi;1q^>=u*U7jhPpy$+TaQ;Q=gRI|tDU-Af#E>F{=nmP^))dpH^XLH)aUR6){WcdDvpt*{&qI{-jZ zMSH5r;Rl-y<|=V)Jm1__3o$vgrm(K~{9hsP3q z3Sh%y6k*-g3P&WVsm00jv^~WhOz+K&Rog|$y!M?W}TbRPmvM-}w zt!On&b~o==5Lpl9-tD^eq>iNcgnn?~YyNbN`|gc1zOGh3=8ip5cD>5N+2-HT(_L9K z*N*1aP1dU_{?!#L;qbk?s${V*RW+1dzq)jJDBI-Ay`Ji_)zLzH^yt@=|4&4Z@rQjX z z7TY>{Uw}xmwNfPk%_Bja&#h9y5(@{^mvi zALgxJ1-bTXHS^sD` zNp>&v`c?oDhF%&40-qvOi98@vZqER^Gqn&ejhl8?uYP%boOgS1};S@n27J1-9-t z@FqXpVbv-9ojXQ5M!N>KgIR|7+zFBR7~!e^#28|k}X0U#FM!ax`tw;G{*d0S27*VeY0VMCuIgwRuIC;}2g zLnLH3)xJ;R0*X`yKz@jw4v?!?F5YagRt6wwR#iYgdIrOkam%DzvUSV|=;kLz`tpBG z<+hipqU%Sog0RnY`uX2d+l$Jxg8FEA_+S8`gw{Y~ACJTqxVsxE*M|j>qnbcs?c^_D zd^j(1g#*{uJy%T)F)snnnp^A0Nu@-+R;gpJ*J=PSS`R}`#|i><(C{OQ2?{gP{8&%D zUTYCMN+5P-LD@*~4{&s26ZJ>5oZqB%vjn7P{AfTMoAr6e7s6o(SLOm|zwf&G<-17BbIAJ^||+3TP%Vl7PmAJ^{@P3};M+k~Ax zDF|Ppb4^pAoJ8fl;N8xvv7(>mMbB(>%5rb|RtWNZdGh(^$XBcP2dX@uR6e-<(Wc7t zCo5cjr&>k9?>6=SK&r_-3}r1GuFwD=K#=|!uPYFEqyLV-At&jckr6;Boh`v3 z0iuH;DUet`3Ici}7Yyw|OQ1>^{d3wM*YsMJkipyLDhU5)d!Ttw8dI5vKyAxnS_nOR z5tY}m)(arQq2-!E2osTupI1plW{HRq(=);6(*zFCS2_hN?3%!1?% zNmC>lVJ?q=@TNs%n5pZ4I0uCOqf4)sXN$`(vd>M68et^e*K}j9^fPGrKkj{{1(0gV zq)7V3zMJ_E+SGqO)ii~-Tj*{(ZnrW%$=hyYeYLjT4i6MAwo&`w_}pmegD|E;I7_py zORSysg~!6M<8F`4r~-SJLW=OcKEx^cy?!-=k-G!xRN=0DI($ygJ#<;#u=fe2*WUYc zL%EBO@($qR--fXn#M{u9YO;h^reYXXtw>}l9`~tT^M)+c9Q36A>l+VEFDt>R!pFZy zd2sXk_6yOJa0U=1WX$|ib1xu#u%-tmRtHGC>&2jk@RmpqF?>T2-1(6rus!UO)=7W4 zM2_?2jXS#%pdqll+eSv=E|wAuqLG0DhkWk~+;`*87FEWSUN-KLUMlPv=5w#p+P@P$ zw|Ij>Y1%BVQ4$Ghmz|5BKDN&CC4gj*v+JMyfJoC?!MLYK%!8AZ_=OtJb_p$wjlroM z)jl^)aP9H=aN1XxJ;J=zy zIz9kXd0)P~rHQLS>LbgEwyozyD$S<$C zCGS-5{duTEy)@sKKG7gvl{1p zT7Uu3CW>JQYdi~^$mChCmcf)9w_51#*KU=A|6GC};*~-ONcV5S`41i-sR!b9=G2h^ zQX`Uy(7RTvm`5AnH;Mn32T1ScwMstgCy2lJ=-6H|oggjeOUkBGy40DV^?p#YQ_@=N zf#Q}FUMb|>4EY&tKV7}OG90%55WcHZo;Ut^zk1uE>n|m^`1+(IH-{M8GQI>Kev*1P z4gSlt)A%OmVrUU`=X(oYDO?J=B6I^Cc{Q{<(PO9oZN9VLp5AYz@EE6`Cc*qas}%n8 z)6VB#4+xo>QWGC))Wl9#qf6qF)tBf+3rG!g>J zi+UKeo59&mE2nX+e#OLRNev*>y2>3s=(@~#C2SA;2y_cCJIM;iY%T{{uf+l&Nt%9a zB3o1Q!;g{+n5=*;*Wxx}P#B3a_oY`2-NKr~*~iYmiuMA50l60&64%fwCM?SC zebcpLK3Wj6mL5N{u>NypypIpQNYLni7<_*jwT}#Mg%XQ6@6T!d?e*KE4vORrkDpt8 zng9Cwt&uLW|GJ#fP}UzZ^=|GU12U^V_P0#Uy_v2!W@R%smy4IF%^^->h)JdARBd>f zTAn|^>^?zXJzM^}|6jdavpu6xT>DQlY6swU80wVnH@v;rJ3iz(`f@ZIk^OUdtp0aCvJz2>yu*;_?tIfZhugt0;CXC0n#_7va?*5`yCmgffP1#t~Kz zTC~6@Zgq3-A)pdl&j6S!4TADQSOg>cTDVCMe5|v5Rl*{}x(p$WOxzL!$;`BmrO=_D z1IDf@MTFfL8z}+n=pLU*gBm-dvXMot7itq4CPq!19_N4}VqTx4j>gMw5TN<-Lm%k#_w z=2oJjGw1StPu~~aK9AU>nN#O~Pv4vB&$ZYSUDO7@{_`w}{_~~(|IQBjzbE@h#|9war zwd!`KXw|RJELUna>g6|UR(eC8)|XGztk$nztZvp#8_SE9wI+wUG=Z-C7P|j<`rg6v z#5nGB@Mq=ibP89j?ck?x;oWY@(X$_rS!5RA&iz3uXd7a zypiA@VmN+gUxT-jfm~g%vMcihf(nIxY3hQA38RM_nueGCw_9RoyhvL)Mb=C-^ouHGHyJu&bYgRH? z8e)RqQ(dm|!KW{`ZtC5x+`Fs0!h@w04f+!=g5s32MZXqLTMUVO4{@V`FzO*lYion7 zF9?t>SMPs)z<0u==dnfI;=!~cv3)5iibSiQ{%nyzaLyMuh7frZwKo?X#nkk|(4!Dx z5xaj$m}jn3SK4X`WhW6|WaHm1a{29D@q?zDWlm&4?^&E1@pe@$Z`9g-aT<{*0B2h? z)*nLh_73=nuin4>GCjhy@v+>H|J%$vYL#1o=SPRzJ?)7ay#mA9uH|ox*i`G!hmZ<5 z>@MQj=k09+F|zC@6G|E`Tn2KkFl%PUwzHBZjuWUaCVK9|#3KWt-4rxHG>jeVca$PUlSPn9@q;CC z2njI$7c9m`u^Z6BbTCjLrI$*$JPxs0oK8urn z{`zAVYAP8;cV!+^D#oEcZeXT_G2@-F{cevTmrxuFJ0sP8EB|1^v10vT(xqMGaLRSm>2TV8G5_$p*CB5G@CTAu z^k~M9;l?{j3vv+Iv^=>qWLm9Irc5=%~2WaQpC`eP`&neLsGFr2Kjq?a+B`9WDvR|%J zeZ!SEc2W$CUjiy9J8#7*gNSSh2aPV1CWTrkYAF-Zx1gM5VPO>03y&k2R8q-am=Ke- z2Uay|&3Zgb$5^3dDquQD21CDO4lV0S(bwCdR^;i7?OJW(@!Mgxdg;ug*f#0v?QoZ{ zbk;?!cDae|2>0%E_CsvD;>mU-k~{-Wtc_J+-a!ZHWpFWcU^V1+qR?R(Jbc<6I(K&7 z#dc?0zShxkQA+D!TzW<_}uhtk}vh|KbG==9}x=|PIwaJ2tH#Bkc~zhkSnid=_g;;B8;PsC|U1}Tl`*s zH+)10)Ualn`_e>ZfNR3_`*71xFB!Rd;d*kf7eL1js^qAgo)Z{ zFBb*RE`+X+&83uzHh5##SEkme#T>iH1pEoNeBM9;)b698A+CCS&6t>fPSgCqGO#4q zyJuKr7vIx#$WO;xTUpf$Az!lVPUM8XHhdTSQrHf*$SbO$Nf0h+exB=4GDt+0TQ>S& z)v+}3)7*N+r%vvT%1+VA<0|7qoP@Z^>T9X06ZX2Gz=;5?6nptrxy{14^o%c_=IC6`@KOb z%RL$_DB$xrpM*R=h%bXBAYBD`?Tvm2qSKnC%3^WeZiLZ6tOy_=FJG_&a3i%kO)1I@ z{Sa&ijCYZd%QS}OGoHK%A_~~)K(e++V}OVj`&ff_(U(2+N?G3(KL!}jFfC+ymcC8_ z?fe6RXw_(0=YR%F3E$-5jS}a8kgXgCFewDtEVTPTOQ$TlIyh9~#lFKVkDW0P*~t97 z839NLH;DxvDA@G1un_&p`v0x!(EnRI6{yj_v;K>D{;l=D`){m&r$1T$D+7PB{#pKP z{g>PRo%Mh3pV0dM;V@o&-h&?;a1eeD6pm?(-3KBV#O_Nj7t8KPp(DfY54~f?9>8SJ z$R0@W+MP3qD}?v~ir3qnD@5Sss|TT%jiGZv;=M;~e$oM1`bshjM{F`}t^~bkHJ`b; zS0_t06pGr?ar05%Ka|<{82a$>M&7(vY4cyZEc&k$$^S0v{~viOZI?7iJm*;kKp+SL z!+Rl@p@IR`!u1=;DO3=|_+81C3TB>K6+;e4^t6y1`?|EyWjAjtha*@40?@UlZY&W! ztPo5B!<&)940|AmUJDA0xwIFh-$U?=YquRV4=zQNz}OHVSRY)x>zLdc)Ff^KbK%o` zyQ2cY~=&@%F678aKku{>AWcwQTkui zoQYeLR~CoAFZq&4f)HW^#0W%CRv|340V4zgBmzRD)Dh{SgE27J7sABMJ*N$ zn*<0DNK~|F!@d|+DT3IFib_R07*JubIA5?&AE-`8oo71sf4Jw~bAIo8Zj_hAAXquh zyiT2x9=kRkC&YAkzvs%vmeBZ-Pm@|s^R8kSX-U~c6|3xC@?>`N_ex!+Nk;#deHd7UFYcsZ)pcG6(8G7*I2VK8c;e{)pnRHS(6$N zonl_?rQ^=0LOfX;R-XVDnh(qyVkXiZJ|Iv-n@mRnN-!t|h-cr0;(LjahV`y=Eu;PH zI@)1YH|~sx5|%^)|5}=q&n-V;}I&BAc|CXg;rWJzVIJebJ3J9-0n94|E|>L+W|WD z^Xvdx@mxFL$Q(NWyLhsK4+JerkOv$)Dc+8)-jmnl`6MdjW7ft_S4V+Qz0#vZmP5SZ zXu~WW_`BHwv!(X5?@P#-AATAM+X0D(dML1Yb>QJgT3GPgOgbR#RYM@7JzHE35j{8i znvNHbw=0?K2yKtDg+d+TO<9c71Q_~|aT8{YMvTc;v(uKA*N1js#urxlB6QFa32Yls zmdArZW?CdO2Xaz6A<5&bDAvWzWRk4W*DfA{cS=YyU!EUeF`VfhRouU&FkRSk+$r9$ zI?0|Y%gE#+nd}X>l*e;KzQFD?&WcGLEn2qfP@+-BMru9AqF2og zEV(XHbBiaA_5Yp^{X1UT0i>@t^}fs} zJ);xheDe51?<*A14R5LC*Mhz6tMU^??cMD7^4d;JNI+i@c2z6amiessI|mdEP5x)~ZIUEz=3ed+Goh@D{*FmMac6HquU|%2FnofraB#* z>h_QEymfZsz*Ka<&q19#`NrGm1al9D{(PuT(G<-b@P zm0v(C6;#wOZwstQ%*%gRb!DYtr>M)uC8#n%GsQT!&uw}%w;B6g@Yx?Vu9Tj;n7nN? z?)%C)Y<}l1(HHFoz5uKES9Icf!*=ZZ)E`$X0LZn5W{T<0;=>hC_;iGVE~LN3KGTYrK70(M0)>YHb-&?euJgNaN5$Dt zsDs|w;eSQZ6ylx9Bm{*OL8f%TE)&DDbN*Jg56?x6Jumjds6wIZvR%*=2uY5RK)K^N z>$vDO9<_7;PYvZ_1321gsVDmOC!rFm@J?#9Y|YjNB|};_Q*WjqS&P=g*OBObBFIcx zsIfWM=!?1O#V)vwO@1Rmoc}uV-t-E2=gueZTj!GZoVn!PaV~l9m_y$6-Y@b#Z~uhH zc|oKOMWR;ndC{0X=iw-A^@3&a{>kQ}aqV09xiRYI=Wit{es+SCq>(&A{t}lxNlGS_ zP;;YIF8+1ArN(xXD6Ak7BcWpP7xmI5yjg~FM)|Z z3_yWB7HiuzgCA>BBGrUlQl}4spu)E#?n13j30(?31cNU>JypX%SOt*i;seA`0R7a@ zxK;|1Lb*^c!Z@5%&*L>zZ{)j3l$lY4c~UnAKJW3M;v0-@tk<&cFaOB8J1{@b{K~jr z`S$OO;$6RlHn?c*|aLtZZzvT{J=q57gR--8`58NljvAa9E(C zB#>;zOE4tNP$fbEN@uPu+o;1*gz)KA%eNMg=!%`6%$*$u+USPQgG+Qi)ZEgiW|(!nV|o(38u!=$gr^hP308 z;D^oXmImI>N@s@YA2ef5{8(%DNj+yDY^`L-a5??Uj4V8dL)V$^r7T~6yL@hg5eQFW zmw?w+4`(on=$(X&e4~@lxyw^n|kJc14_}&RA4zF zW~(Qr_dY7M5iOf(J;;+!V$5w9d}2Fq$M7Gk`p8X@`oqEcO3(EW*+77fv@OTznLNIh zZMD3LF4MTkMH)3C0WP;r^{UDMS2t(q|GiH1Usuo1ck`8KYKIA2h#?im#|;?AI3Ykh zJirmQ@Awo1En6ij>2!70k@bXu0u;Wly8xLUF~nVL%F6ACg?}Uf&>F;bpPDFd|40J* zc}y|z7zY^-3f)+|0PBR6X=gzY$L@&hO#hG-0UEPEg2!tB=xJ(X8ge}$-5+p}$$avc zvA667j?=2qg^H1!PxbJ}x`r`X<`T#PpK#f?Aj8vKn@md~8aU=duKW&V=7LZN>D(3Y z7VAWBTRn445v_)+O-q?AkDHfSusY#M%&RKqUV+>cIhn8BLP?DBky`4p!les-QWUjY XhdOo3P1s%lqpdlX;s$4&?c2#6pC#mcTF zB_*XJd!@72W#Y$V?@@LxAJL(tq@-MZt$vR%q-OE9);&^2b#!!ee_rT^*6Pz%6_UIY%%H|#|*Dr&=+Z9f|x<^dStFL_y zwL7l^avVEuoLVoO{WD!$T;ATpFa6y;{L)6+9Dvc7)$nB6*?6B+xhpeEPPH+S|nFE=l5_9p-1 zyYC-ezkhZwEG#UVI4=I+Ts*W(cj*-t8I^{hqC_uWzJyZ)|LAMmTN8xo;LFZH^6W-s23ll@q>oa<#p^ zy|c5smyg(MtKR!Puy>F1oBfr={r&xevXq0LIR_0z2L}g-hlfW;M<*vIryV~}ukOx< z+Ro0-E++dg&d)9`F8(Zx|GCHI<>kiG)xply)z$Uh=FRER&Gpso?d{#|9SVhFMBzSE zHZ)L_*Hsqe<3|VG9|y)uFoqz22JrlKHvT#$05%FhL1@&R?J0lqsLuk}1a=K$U48B`*SA6SD;J5BcRj7{WHI%H;q&s2I9cw~KD2ZRxu$Z9&Un!mm+i5+&(ofjEBZ8!wO6@LZRC zsEhp8^0L+nBM1$ks;Nl4JXY@l7c>A~9gOu~9~8WvR2)B(`&Nb_8eb$R-eF!EMkF^m z{r)84eG(N5F>O`52*Bm!ay6Jj3Q&(5p*;4@bDX_@0;?Pc)W43FjK~We9^N^94mZ{d z<26x09oM3imBK-I;?_g@pTo!*KCz}<3`zo-{0KRZF8*c=VW*K9IXBwhgH*4*;VQBi ztW1g+)T?la{7DN4SCk_kOqMeS;*zbZgC2sh#!M}GD%&wI-QfY!xOy)c1E|LT42DbGt!NN1 zme{2Rlh(JZA`FK)ZGzday5|ycnYdEJ#lLPag$a(-YzBUa7DsTnQ#m!`r5k>Dj&Ay9 zYu%sn4FyL;2$dTc@Pow;f^maT7X-PlUr*a97-xY1Tl8Cn6sznOJ1!uWis9?G0-UzI zEQp?Jhy2%}!=h|`6|THYq_LWPDpY|zBLX<(hY=RcF(^J6buqOjBc+j7dSVO{o(78z zSpk3(wi32ID>zCK9pKPgp#!vZXXMOn5)=tY0VhR7oPV!3kxV988(5HIn4b`R4;S8q z!nCj^z^p%PX`tyXKnRf*>FPK+2}4yIEspcs2tP}d!)oyoL-&yw6V+JubgQ~(05_O? z9Ybc8U%sY+R=KR%7r)AFRObS2-1le10yZJ^K=SQtI$vlRGPGicubviN*9)rDwfHVo zHOfJ-2Yj?E1Z-)bXoV*q6SqOe(Dl%egjaQVKW8zVULlOy)x;1bP1v~?wH~E2`@ev; zYl1~%bY#`2AAPKw05opzUoHoMDMIIuHIY5pW1hr;3oaiYimSbW{n=O4LSj70j(An+- zvu1nLO$!J}h34SiVy{)UfH6M~x#TYYo z1!$SaAK_}&{NS!RP$u&Y!$qOqA8<4}dcGdRAqNt7xvTIC5*jS7Q5UOEf5x+XdW^Nk5`8|iVHqc!VEy0|ci8rW~M>2nu<>)8Y=TM;QGhEBh5ZSj+L=Ru-3aBjedOi?|Z zmdcM#LuV^Dmj}F&#HnE{5mxyUuvfC94662O+zkb~Kv#@72Jb54Wl#p1*J3vPHxPo~ z4hXummwB=peKLUU6U}Eso9m^B-_^#-jnjrshq0wPL9QAELZa6RV{1Lv7|pIZroTMQ zSHy1qIlo$=!rh+xkbIOZ=GhU4XafjvxRRb+bo;IvOmA$dmRkDoht*`!^w%0mMAksn zS3PaJM5;_bC7L)*Rc$UK%jv?xHzN6vr|C64swwk*KT6)qVB0Xg@B6aZ6X;gJCI7H4 zzlJQ5;l*!GGXgP^6d^K>&&BAms2Kut{{-8F6@Jn+IL`*$kI3k=8iJSio)P% zCQLVG)`YA+_EdT<3OP13m>+*#x3>4SD^CMmIEMlkA&&^@Wt}2oH>zR{dd1qty6_bM z4mr9w$8kN%wr$i4^-YoEryc3Il-9ahDh z@}=lEtRpNeGT1x~2@;OhTHSYqnL`KD!nuibvL6eQ*mf91wbV%C+22zg4F^+FP#ul8xpRj7EpNH@K`LSS)bG63a9B= zgrZnAL!|}CboFKh_T=M`ShboxgsF=YzYRZ)`-~F94(9{jF+D#{w4BR(m4|4H`2)Hw zbn{`oj>D`I#LI7aAR|&LLP{i7Z)a3nXVxB5=llkH|JVSp*x9ta$n9oO6Y$f1*$2a# zU1ocq)v!xpgKIP4hVM-F4vUq#G-e8L60LqhyQ6hoQ7F$~!h|j8NH%3s9{QB$U6GnD zP-Dh0%~q9*^4|9j`!tEAt^y*1HADKV%J=WWD{f^FpB3vD3Q)OS-<$n?;tVdUu8fmR%zH5<^dTC9JWBi& zBh?9v&w&ZZdpUSD63@}CmS8zmy>pHm^w^+hy|OTqM|D3QN??HQFm_z-;}s#=B-s-$ z)~_0V1im2626VCWSV5i4IE~Mx^HLQVEa;ImMh1XQ+_VnD8H6cvrH+ z7&%~QlV7HO>O6HJ=SGrG>Aga0_L|4~Jo3m^VDi&(;3uvGYe)yygEC%5Oz(qnEIkvD zAYARz3zLC?#1tTi)dk^YGR6;M3l1@Jlwo15d$yB3GoSQlJ@kJn9&qPGa%P3WI0SIR z#COQ-`d+Y*4|zU5_tV2>_kGEpgogHNh@e9rn+$bK_W985^UK!};vfV^a3T=I#NnQd zZR@z{Z^aQ{!{Grw!nS?+TwYh>T~Of1u0Rs~AWFfYBon|p5jJp0e9HpMrI4mUgy0a; zG*)mooQLSYd@VE)e03be4GV@gLzIx@>^&Fh*)=z*xV#qON_ud(w?h`*rkX(7LTL=MV`7pq^$yIo=09xM&A92T*E{_j*NXp zq;5D6*hz@_Nj&8|1kO_oZYPYAPF3g@g6u;SMN$-1Z4}K^6y0SM17$RmL^O+OG~0)0 zj-+U=+Gw7sXuiv6e##g@i5Owi7|{K>~;xXf)hCN60n*Rj6TFYR*z@lOk}-` z)1i!W>`r9fN{CcXV%kbHQBN#*k%;M?$Yz&h5}d?Xko34aNo+j{1C;!{Adv}@XdawQ z14-Jn@XXAkp1+ zsl8i7Ym35Sy7-vG1Pjq=r!8q<)Nm^5FqM%qtwSP>-ZYKjGDWf+gMJnK_L(k+E&v8) zoH1lz$fvJEqBp0~x3{8pFQfL8h#3|Y>k!uIR^kTUnG*5npBeDy`Ll>|2yUISPKNNv z>#}I3v*@m}7^uE7Nq%K9`^xt5E6q0EvDa6g>92fOU->1!o+0oA%(6v4W{cNl&0A$j zOlQkpWz#2nEv+o z>YEi+?lZ|;lkd0#@Z6Wlx%PFr4p-ldrgNRB@?0eI9$n$~!1LUb^FH?6e~T|u4(LDC zQImvu*=t;hr$^T&fTp8RDD}+Ho+$L~D2xzdI(~Hnv3#-T1#tg-Ys!RnNM?O)yv$P! z^F;!4el0{5O^*HdR$=YnkBO0WQQ=$#<=>;CrlVp$5^o`y#TN5wlq|sIg(=I0CDR3; zFAE~5zQ3nT>PSwsH7(qjBxvU^9y2Q*w=XU^#GR-so}Dh9zbam&Dp{5+!CQsZPREyC zB@Kl{RfZJqP(`dcu~74uo|=`Oe=PlzTzXYkdNW;mcU20Qmy$0k6F8TANGd73EFqgJ zsVpd)Gr>QKi7tVct$$3LYstVbL_l{^C__KNenk`G5@MPsVt-1Z4Mk8FMs;3B(icWE znwOFFGEnRk41P!OqPWXRW?;-SNvzzd?A!>>lql|BUI9LfETbz4tT8k3tc)*RcIEFo+*OhXL3~j9OK9 zbV4v7PFTW#j^_l@0F;~ZYh4Sg-|kQcrlfq>Dfwhhs0af}uIoSmCLyDwy$u2L1WXVK z>(K@IA@SQ0=$w_Xq)#y46qtW+>J#(yr#q3>pQ4_BiVU5B6~k)FcIvQUHJcOY+)VD8 zAi|_VZ~%%CHdclP#4CU0uK2b?m8Y2+%#9fCh1u&il;J{B5|#bD#8H`GtuumUIGEfC zq;$wqbo~BS#DEo!2W6WxCY1|D_N9v-bQ8#wxDXI-Op{S8iz53gj#)R_5p`<#z zUvZG1HrMA5ZaMR2Dq*XTMeCnJ7>x(4Q%Z`#Bb}+QoP~$*=u-4!F38IH}SSr^1b?DCKN*+jC>#3If^b1hm2%)pbK=P>2*^}*ZJ)< z2MV;`nYMHNs`v2g!i@s6^Zc^p!6#n?4P>{S=(cjYcGtubJj?_iBJczk!RGoCorilDB~3@_Yf^@2fR!v#8`$Y=p~+DF?dnbj62+kanvbD-L;_= z>9>mrkdEA{hxL15+4Eyheu^a8<67D!UD=JIEJjfCM$*njvC69+^J*u`gDgzp$sU3k#jU2rkqY54qdi_)6^$*9;AI`Wx z7G|5(3-d)kCq23$YV9R9EFP0?9;@IQ8_*nEWBkpyq**(Y!y_>9aQ3%u*tk^IIMvn| zHstp%_C&Hbx5gvV!m!3Cc!f`8lCAfMQC>*WOk|Taa`aT7W(-S`q?y>G)enw*SdK-` z4|0N&RSgR+1vLNhXie0fdLKUdxFp4o#>O7FJ9!@7|n znh%kbO0xti9<4v3TG0eRKM!$T`$=vWF?JYRg&kVk(%J&?DuatlLQxGVW|pvPFM=!G z`Ss89n`!ggY4bN_tcJB6)-D~WtPU}y&UaxQEotath>v1nlJiJeo7A4;@Xnd=s?xb4 z_nAh3bCMbaC<_pre*h)-bvH@QMhN$OyMXpqURu0<+BH25u z-c>8l$#Ds$*su^f};(66#lp&-?*`Cq}orypf?-X z5j7w78$U% zQx&HpO83Ld_Ynnmk%gWSKO+#ebn)*WZW)zqFr;j;;cc>UZ*Hk?vPkT1N^a#BE~2{d zY0A*18~0}C_vY{R7U}kvW%pMf@2`9A&ow^PP3g8>2hUZE$+BJ>er zks}g115!F^G6&&us8RXS5l++?H^Hv*Lbz(vm^%HKVpF=#pr2mGxWU4hCTc?4F@pIZ z<S<|(^#alJ$O=o;@)Ls6*BSPvO%vu#<3HN-go!hE$93$?VWM;A>$~C`3`{Z zBJm>=uKIpmU5H27!7ZXb1bNRK*}L!D;a4d~*ZWuUH_P&W(r4+=VqaG%35PVPkAC4~SyT3J5|Jtif) zWwys{iFzw4f!m9>=#=`aYSFCP=}PJ@-t}LOslqI#j=ynJmb4K<1ob;Y8Du^andLpS z{P|2FoK88}a7#Z|J5AP~%4mD|*;MZ1_GF_S0-71c=Rf%f68h;hS16d(A3(A0!3nCnZE zc{0#>S!qMiba#8qUvauMR-)y7`mQ-c4e5j8j_gSL#cw^=@Hr*t#{AD=e{1*-{^!}U zINrNz3(yvX#dTvy*=XqbU`TY6w+_BB-Mo{3ey1`gZCv(o(!QiPpJ~sl0rEPsiSbIGF_zak?PtD5*KmmP##Xz=yysZ z;`AxIylNbunO%BjBdU(+Syi72YR;vfjtFtK-V|vF3bl^(@G5T~_Z?BWx>gCS)c0vg zGHbf_h$z~hJnTiDo|H?VTj~fa3hV%le6xd2$oYh|f6+Vh=)|*k6R&@*oz2j;>$a&|%9uuxQD9a|TKGDV}eNJpt9lw@nxlZ~*=Q&-}y6x+EN?Y@{ zjj^_{&&Fh%U;WeLUTTEz!?vEqc_yRmOwuAq?D4*l#cvlCzaf34`lAG~^Q3`}de@*` zHr4^szfQVW{hKZBwZfby?2Y+aW6Hkn9zKa9)>(So0rK{o#7Pe03Bt()?+MM3CTUZQ zGX||A>2VKhUaX5GuN>^eKm?U~q9zkb?1rw)9(OvX{hs8lm{DZpnXY99?YZJ}xtMns z4i_XB^KaQ>-wS?rB>1E0FPHuY9!@~~;Vd>U_Hr}rg81WuZ#t1zYQ+n5*HS+Qqd%S0 zzbCmlZqJMH;O>7waI5(HOUAAETn3Tn(JFiF-Ob*6;=9b8ro+Prx_8tJz#t2fjZjwt z^OP8kIv*}508_`8#s?p;G~?>?qqN9)h%m#mDzDmJs|8*(?}wDsx)s z%XP*1+=!vCI25^u5vrm$c=&@kt@OuE8nX3-u+Pj&f`kIWDt<&nb~$bH`~q4JQ<+Fo zSlTJ{^u&x$iO7ECE3-HcD?jeTqo`!*5Q;8WdtpIH<(#d;T`myuhJ=Vlo27Gj$XVmv zEHmAgoKC`{BOy;eA_iPeH9A5frGQf?Q%X*ks^GCo#4e0QidmgSPcSAvhmcJqr@POo zLM@$!mBX5)2PcY1D3^qY%e+8?yj)+Qq#nxig{9Yg#6`I}b*Kt<668_eFU5KME!bTm z%O(Ol5rqtt{qvL|AC!sq2sPBc7*UY@!slfYzKe02A7zGTCOTCMgEF5&RR1|#oAM<9 z0*uSBeipq+(cFF!*jStC^u{4|Z%S1}!Py54UIZ!Uw@Y1R(N$cokUq>uqD3%-OtBoK zTlC}woEKzz#_wiq9jS`+W%&YND}Z$m&Xb88ilob>|EjA1!T|u7n(asO=LRa=ReA(l zh6;%efg;HQzEB=-Tq}Ng;2Au`KN-vZj^Ce@k3mP=CYwSvA8x??))z9HNz=Og{gJ$W zM44xtsQ6lp4t<+}{rBJU5vPH?$^8D&o|!rL*lW{0HT`vDmt;JgqGdvDQiJIyUsqJ!A0^<0u6|6sC?JJEXW^ov%m1)M z#=3+hMUU>|u#E<0&f1f6z>S{WKQF@QaZnT8NsnmUEnPCjpjI>22SbsypiO|&een^b zy^WRsY4=;y)47BoB}|S?dH432K)2Xz8e`JH55IpsKChl=IPiD$Sd)5kH9pa}&5J3r z|Le)!`9u>c&Qa78WQ9gPiNxwC^(3sfIw4xY1v4OBH0^x|q#4K+I3D<3ri6b~2q1cp z4@WnKL;8l=`P>PEgD)y98#2XN#A+0nY@}Dr`&v785CP$D>#gZ7COhRYT@e1#HcaGG zT~hG@k`btS8#b}2ZXGf~sZ`K&u18ZnkH!T=M!cW%&D78}17HlbP=F%VkkGyi&J#WK zoV{{|8Nmn!iWqS2$5DV^O`pAPHr43vCH=>T{f+|EvmQ^mE8F|0oa2PTq|{9C*o~S2 zeMB&&F1aA9laE@eu1~M-hQx5vLs!{b0v$!wp)MA;EQ9dPEY2(OtssB2Ln;95fvm;G z_9C0Mf@sR+f>`jond`WdZYQziuCgM_QF^=AsmUn?cb!f%Q&X_oEAaq80aFkT`o$&! z5P5aT826gJ%22|534>4>Tj?wknN35#oqO}E2b!2z0fbfn`Iy%$0WF2XW$)<+a3mJW z(cPDT)E(m&*4`V%mC)bX+!szAO947B843uy0MK_h4r7_HAOL*mQpWdcc}Gwj79ti( zHD40=gm<}vQjt%0$(MwLkvPw)tqFAJ61~~7A%|7R7h-q(4(np>fyM_9hhPFTiWWkL zAbBCT#uM?aXjRqs_9JuXTJQgSCC%LAcK(oF5#y?{v)BAFe1I>zJfmn&hFhx8zS_n4 zhqQy^0_A)**~O1M_C4U>*N60Ood(D7gP}XASLjdDn_a68pG$dsCoZM=Rl0X%{mWyX zY4FhK!DH$03*Ge}rl)-m>D1B*2sR5iuR31OZ@MiQukCbPwGYd>l{}Eytz^A!nnK;V zHkQ)vW95E&btLPI%%DBy)wo)EPdELYJ?hx8=O%yBE4qSn*WGSw2l)lzreqK(tqN!gmh*@~K!YSq_h z?K5r7v}>LF)cPo-bvUW@TS4pcuU3nm*72#jay2NN6PI;<>yo#t(+Zh5*=-79fZT}9K-S}`R!C6 zI*7a5woN;_>{LE>ceDnnIBs|JUv_+fsJ2q5e&*^Nk?8bO?`$zq4Y%){_|O>~tXiAc znfASNwze~(yR&9e6_TW~ny<2qt@iz-`Sne@Cr$bnHz_L*(Wj}(99NEyH+U(~p2WU_B&d9T4$(Ifg<=*+uAxLS33-9E zd`W$g)oOjAQcoVErmeYph*IyNx#nt+CgQN?k5kX!VfRr|Z~Bd5#Wq)^526Asm=s%L z-%2ydt(UT`XC9`>eA(KQT!irI`*Iival(9O6{u98c~PS&V5&9uvadK6F<-|U#nAsH zGXMkbjoIbhCdvK9tADbnr%k$QurGYbqFrv4Z#O#lOC}@*8H|c@_l`oBcz_64F~qbK zA6T;)Sa%!P@Eh2S9oWhl*sdDbv3Y2zhPk^suzxym03O^j3^30OI20Z{Q5rmzerU;o zdFD2F;it1{7~m$3aPJ`?lPa(8(uvv(tw`;vH0-PDOO^u*%Ua_tc!Ylm3U{8-suJos zBh>ASLFl84=o5?VAo2J3`w%a6&o=u8x_Zy2G$k$-Ur1Fy*Q~xDdIOY*)>LhvxF7p< zO2e*h)2E@UsNr8(dI4G))VCQlc&W4)%74&%T`BeINk&Zi8kph|m`P(;L^Mr3G|}Dk zVg4hi*b%_L7n;*kRiVNAO`p%Qi}AM{+g<{fat!xtO%%mj@tHQf*;!=~Wi8R?5@NJ? z;^9ORpNDzEhk5bjWzO`c9Sj(X8~BuKAMB0t-x?^2NGZ`8%B9J}Wenwu4HSxL)L$EF z6iZ3*5(~FOsoInTS&^Ky$~qW$T5(dC!lS+dM!mpqgVo{7qhWBx*n;(#VKLH(lwF{| z%VaOZG%eFio7Qk`Ol;Wb%kppY)8FW545tG|9f+Y2L5CbsK`O2_rSd^@J$Z^%Ao ztQ{`%svYXkK=f>GT>JC*yuc%;IT`2T7-QvF$8QF1d&bPY{t|u&DL)w zVmC$faf&Hq>Z02;S=%&7##}~yhTLq1-QN6~dPb0UMkvi(yI_WR*hQLw5!(fB1cIeI+=dgtHsk?PY^XAZZ)ui+9J55oVr&))OQhkzk(%Z z5vO`lG^GM}d=ZaKkauN~0P`ueYvp!N$x~toXugDK970m#P4@2TvEYN#kuu8Mr#YdP`5a_5oME)Mkb#=BhXkOB-P8; zuT5$i9=G?;|H&NsQdU5W_hZ|ASt9%y%BT3zgIE~xEf$H&Q?c>ojNelpYg3=kOnETO zq{z&q*`|3_X8EdTALN?f#3|gq7P-SqJk`!Q)Bbjz_H~=}u{@cj9NS!syML;h2rJCr z(AA&LOO$=l&u|n&cfdOO(2q1x(m4ubh0A9E2ffVpRytfIq7Yk^2{wGZ_S$aE(D%7% z?sElK40GAFsG&8(o#zVIYlbOnW{qn+wIKFIU%T9O`vElk{B?)%_1Ej`Z_d{pF*lsZ zHk|igz{-4N7&hFDH{QP3cz6Ed!6fiLe&a*##>d}CY!{Zraj6x+*C zwyhYIt=JbYnHK$Q1F91Owi4sFl5)3_tG7}*wo=Ep($=@q&$lu#w=>DMv)JsT4>ilF z7QWCWpI`*5VtZq{gGSvcbMLUU+_zyAYXx_`(KY_81C-y{v=B48g5^&Th$mOP@fF4a z82tVpOnl#7$5reHLKgiz)%TqO6LX&s?nilH2?sr2efO-@)B73P zzOnk7MyFk&?q_U#@w@LL@{Qwn`7jN7F-rsDcF%pHc2=KsznSpDn{tZbr?Z~nBl~lQ zWdL})A+?y(Nw2B{A%|d;*Q>`_j(cQeSB(+7lM&+1*5bzT7$_`33W=xAP68_45EIZ; zMI3}6cuSTP>w*9vM0_PXB4j@z5<4PRJtBE@L~46P_Wp=G@Q5Peh%)bp>gN%4=Ml}s z5$(ni-Ng|-)-eP5F(dmilh`q{>M_fsV^-T^w)e;EfyW#P$DDb`TtAPwJCAu1a33ss zNM!hqCOaG*3XR`Cc*{r^=nq;v8NWLyjs5r{seHXyQKVou?G2lhc9IhdR!lR)Nd_ z==ZtX8aDPnLx+z*EI>U_0Q?m?#K5LebE0o>KRqY>uc1TkWhrvrM{J4_E@?Ok<^KpB zN(Ud9mxxAV!?5|i;CL^OjPFB-m3f2Sd+9$uz>rG!@08fkE=1?}V4iNa2I;2bI6EN( z?IkY`PO}#_=-E<=Ms?9tXg-Y$1wY*17)>a^gCbKTzNOOrWc_u5y1aSa`{@OLi$S0iiY;~&8T99CHfU=(KxnbtL9 z(HEw|vE)Z${Bp^k;zj;a0L{D2r9g%Nj^!Yh_?OGU9J%?+Aw1Qa%c1-o94leM<1bgj z#n$+I&`^q zimF~*4Hkcy|6W+)vA@k-;(mAaD!m2&m2G(oU1(9cE8k9G+L{vgUe#E<;)e9(i^9F? z6OJ98GB?lO!k+{4oNvn3wrd?qyU#Co6+obWlFR~N0q{Y_|3R|2={eL7| zCG@h@!&&|<*&4uZ{l?=T$yU6c*ra=sWxzG}XDO@lhqGk^iIjV)3Puqc39@M#Kek)) z^^5K2BuTk-N~~I`_EhglR{6aByJd<{%FIuvmB#0qKlwCEh4!}Ra7norn!F@b@U&|9 z+p+?PxgYn{l&^Fmm^IV2YAe=y6NO&Q_tjQz3}z~Z(rMRKZH?v|6h7{+`>``oX5E{v z{i}L!rp9$=zW>+Hg9W57F8#y$nxmDj815$n^|dD(L)n@c4;$*v?n6$m76uxAT^ua7 zhN9?o8tX4lHb)De3^q2r_uPk^NCoyyRyy9?v`=X6C(;l?IRv};Zg(F&60aTOhXY_1 zc_jN0Mc25@k1`m52C|_5h`nlgadNBU5bwJ1jAS!FLI8m=7!7`X9?O8`|{G&t3WQqe1cYP`Uo!s3u}104)KvH=L% zMp{w=B;$hpg=IMdDM*wgNhMvNmo|hMR=PpCI(r6BF|lpn0C9mEKe)hPnE513;sZ&! z8XNN=z-_dem<^#8*(@tG+TwVI25l%3Dl+(2-sk}@0A`@}pS)pc{(^a*h~`+#Xbr@t z)ZoD`Uv3K}<$Y|ED6pd9Pb=doOrgKh<$XWmcSt;5(un0{ZnU9vW$TX>b&T($B+lwj zmNs7><8;{^$Ui5?#Fuxo5!7&%mJ*2D*!Fqf~d(mG=*fSwtwK!om z{fXY}fH%PaX-?8 zq3}Xe&ROoHr+l-jLucC-txn4cLu5yQtaO!lKL0tLfP-rH9img(C38i+my^)-Ci~L5^yy&;L_r&;tlT zj39%5RM`DmwQNxi^gqqKD||x73z6RZx9i8Ed&Igcir@U-GVe4`w|Rp8?hL-hr)*Yv zdeI6oT$Vi~Ys1;v+4mJTS~AEty05U=$@ath&Jc38X|yqUUtv)mDgFBjKb;Ek)BO3y zsP^5-_Un&t?<=ejh4#Nu;s2)2aD8#O(wm{v)Oh=;P}FXjHB^uL+ILAvi{nR5iwdDY zsueb|BTz#w(QJ64#Q}fG561+9t(3UP+?K5@PZNpz1uWb6l>l^bCKKct%?TFWna8HF z_=FOAzeuib)^Y?_g;$^OYF9p)?B=0o@}Nqs2`0)*dCokhztVD=pZ&- zm=~*NPX1S1pRpD{e8Y&hkrL&9Kwvp67}5sJ21fd#V~tsn- zxcM<0&vr68go4v4t6x0drJX=Hp$~xs=)s2ot#YcjCZA{6Q7?(&;;>e!)$PX~+V_8= z)cI-;zp4_txqZdt82j2DNh!Mv^Tj5EG6CG~H;+opZ+E|ki*jIq|9KNV1eF0TK-E7x z%759hu*feW$`Ahc9Si?o&+N8N|G_s=r4A+|y12h~EG`cXLnykghVSJLyM{cRBj0|b z^8O|wxPHmFh?XpuqnoWzoTJ{3us_JLpVKgS!i5GJ*&XTrQ8X2K`^*#@&OpXfVY|{3 zp3jMCB4A|JKiB(+u~-s>minjdd+Ac^-FyL#)*?l1E8=qb(>sPkHic=XR}m>1=pZx! zDCxY`$HGinZ_-sF{kpe?Zf&wq?8TsVhKZWcj!NT8MRHE*#dSJ5*99Sdi-573R^J-e zq#+ggaavlCD}oX>WuH321!rKTJJgk}OU?2Qc_PRSJD7Y1$7*Vn|A-y~s6 zzOj7%i|mVvx7fZ)&!xJYhrOVDZMeAJ-;kkFc*a360Y48I9IM)7^QruvN2}ufJFQ^5 z0sTjc2zUuYpJF!6cu8mhP&K=cy&n z?s;^mk3r_R`{9Xq&LScyb05zaM?L8OOzyP*C3nW{cZzG)zweaPpKtG!A~Csl%i73Z z?Ur}374BB_iSF!H4ypVlcZ^@{{rFq%%)Z;%`?(mvyGq-TRZnt`8|JPv$ z_d)&X_^X44KkJ1DjW_2z2TcGL&mj^_?r_+Q&0cia0u|dmY=x=v9JP_iT@AKVJn?wl zL1V4;x|87*bWfTk!Qr@@Rmyyzhv(<6VDCTxPi1HCfP+w_=thylfEau4NuLx7Dmb9v zN>e#RPoRC$LFq^h`zN#2K^#CQQ2tM5Gst`PSn$3IIDWWp)>;7i?dUAJ}mFH2edSP3Z#a|jLPgmkN z`~4d#;inO+nJKPlie9B4%%FaL2Ee}p9qB>K&#LH!#U9dipZfj&*Ik+17C10nX}^vZ z&Y=4a;{PL{+fxRYtQjgo-y{2y5Irbfsz7#bw70g>HosRGGGolymq|(30mj3goz zVq3}Y%L$>7@O=19FupgQQRXwhGU%lCUSrW&QtmvH?+U^al?+lNw8nyQTI$XT81j<# zSriCfqNYSOHKSq9IH^Wm*3BzeNZt z>eeQY0deR58YI}@$Jj*V=~{A zwGkThJ!k`S_m;I&(*F|Zyy7w+=weA|-IeCZOReZ2elT0n`k-~Tyzdf|rm|dY#X_J< zba3}*fbU6|bH5^S{}ED!e$KT^Ri)gBHg~(0i>Bbve@LcLaPv zZOy)D0ka@z5M#hPL4Y+F;f;}07Uk!|>k~lm;Cq_@5}@*^2xM(sOtiK=fHPx&40IV3 zxU}k>S8eZ7(ZgBp?FA;u59zD`QG<7Ekz9c<%kF*uA6;CMryoVXQh;qJ0a$q|QX?gG z_@s{pOB}IAp5q1wrKj-5;F5r$UI6GB12GoGJ}lXkp&*qZ5B!lwKO`p^FGd3k{D(4& zP3=z$=Zi&}Y!DiHAA=v8i*A`S*NcP6k!Ao?L#)E)b;utSRjH9{O9^h1K;wH0ZFyD} z6XhC4nPy`L;@seWMJd+>L~$Uhhn^KbAI&7P1!!{wJ1Z7c#vh7M*qHLcNOHL;B?gBS zL=awkzN2VqEOz7n(!nbm8_o2VQWpqef=V= zz?FS49sLU$9+%roy=?J79Ifw$UcI@RuN1<$T)rC==q}mK_5A)`S8CO4)-D<6U{Gl* zW5!zN;?VZv|JKa>FQo4K-A}&cZ~F1xt}C&}9DYV!kPEcRksm80!d zz3}S|1yDZbMbTwcSYOq;{rUDA%%o(&NN0Qf2Q_jI0_t9H??kgBq!GU0Gnf|=(50z_ z$i3S04Wh?^^0%WqOg_WpHZ~PhXQSfhZwEwjm;zW|;l*e|DWNbgjQ5K!k?(YqqC&{- z)i5(#i-q8T;q;_c7bg{z-wPu8rx{nqpmqgcvc)|Ci3RRs45KbW<{JuR%s!O|!1>;O z^wl?lMsoaapbYS>+p`w@&cs$LgZ;xHCAI)zLO2@KgkN14B)S$U>gj$-3*rWTG>O(te8PY(xd4{D^{vL z-}BJjGP^mSn-mxd6)yUO65_xCC7vfp^heUaut!y}sQyHC6F6^Gs`J+KAJNm+Dg4%9 zwas}pYcbt-*o-bc`CCU04g4>%RtJE9c>b+HqHZfUw7vdktHVKh4D#MI|6CoGq}kM7 zl>1xOs#mgU#q-He|2@UaV3%9>fc!OJQTxI*%354tV5k0l=_#ANmKi}wuPTgPl=-wy`LPnMQY6QBQBA7J? z^4;$TEHG~C`M#;l<(4!>&2gSOH=C|p17?-ty0=y>CDs?ud4IjLsIGRMXfOWtbGoq6 zH;-UM_lLv*rJa#F`TBt!}uvHZCL-E!kgfqfE8|ItA~jfyA8N*?OchUPD}wYW(v z_h(jdP--vJH9}$(J35$G3CCJfV$UkfbTm~{*fK)DI3%TcNbT@gE4MLuM z{{}KD)iGJ+5-kM0vFMay%-6=v{)AI`G{#v+&SqK-`I5CgeZ- z*+$rw{rNxqnWWNLFdq5eM5ZJ}#9C1N?a%Uhw6$)=4%Y_r?upF&_`AMecaZrEg8uPWo+F z62;J3@6L>D_}gU0Z{eb|NZTH|!_~gn#V(^BwlYQh#ML2fDrQ(_M~=sErR%BfF5pj* zZ1xI8Pk(gkMJWKgWgDbh-g1ujV9+0J^lbe+SfkaQZHKr;L81(BL4Dmv0pb9g+K@~& zj34f5-<7@SccH`#XSYr*Z}TG#$kreNsbwi+(s0#;(c_0S`{A&nZQkcYE!ePNnN`?} zT(%a~U4o)_8-o&FP_HCenLFD7auC!ij4Fk+dtMX{)m7ml6gOQE?u9S=GSZt&(FtmM z=(bV0yLYGaQbC1?z=r zH(r_X>6c|G6j#T;=ws)knb>*VVbii)_Ol@ds^0bA=g%HF9JN!}79Dlayx%?QWC-Lr zzE`pL{){89==d*xcHGO~$#c>tJmGNCFTPQ9G9Z1idol>e;yoQwB7c24tj1n^I-(`E zC){zO#CtYoI7sXyVPac+Hg55r_CU@mkoSDjCgJt@q?ql`z4Mu;dEDpIP7`~g z^{$n#FXpXg$Z$pHJSNf(;Zp;#-y6PvKPn_O2XrzYkBB<5 z-|H+idjHqIi%<=}@Uhc)&O;{nxW1^Ms$*wV;Aw~b=j3xdT5*>f*?+v;WY8B(TfDfQ6U~)eT7)qDQ3!6I5W+jl#{A)N$ZM^V5syPq0rqXqb@0|n!Nq`W7 zCe+Xk1`N%iv*{(Y1XQFrks?KO5V4B}f=H7tgNhVIhawsf5D+myD1sCbtjqynbd;{> zSWvk;>YVG$nR)I#=RR|ud;W&+-QTy~^;>(bv?@&tA)v~{uo9SJ8^uf&APxixo_wg- zUP9+kp>@u2C&GQ9IV#$L6it@#80?GA&C4w@a4n4Sr1J$w$>uX#`0|j*S(8vp@l$u^ zDkor5{Xopm?&GIa7(LAqq3(G)L8XSV@-k;dNHV1*(cuwbcd1W9|E(OiYfZb-CL7Ya zxssVBV?}f9<@+iKTNT~t*@?2C)g$K)+@0*b zstT|en&Eu?F)m)|j)xU;V_>q`1)rf~WY>ZcXPwRheYchN!%;TUMZptp3AFkoAFDaf zGEoArdD1~XDLC6jw@7_*A_Gc)EM=F+>BJnd{(nGjCjNqj5Bj*6QTNLO#`0?7MY**6-(q?9Q?Xuq-(Cfr93aUGm4X##qsBsl)Y7kP9 z(d`3ylP`L8ZOsO58V<}<1GJoj(KXZq{x#iZY7Y&%6sP@bZ@nW_z36dX8Z~US#wxz5 zwnCmZ7{aXSt8H7_bj+y3_muzat=~x&As3U|T$=V$)jlH$xIFYcS{ zu6f*<^SLEOvmRk31c3Pm)?z>(=}CvZOzdI(2VG zZx0-NL)Ha?88?oKyv^nN@Kjk;6m%#&fvF`xXz) zgCq&4nKDSWF)S`2*9${PC9YN9j99f7$m&r{8*jzr=RZ^H)nl!q^V7k6>0@eI%_`~z z$7gMC>TNfNT2F&9<7n!ohO=(Dob`7k4a>qZLGY+=lmpGx6Lc-j%i7sPJ*+?hr9gg^ zGcCXes0evq(71@hZxqG1qM>0z$~muQm-`mCy7g^PX8j92)KtSql63ud+GNuKQdWp4 zGKnLm+YTX8F6Yb|xEbvTHsPGFBeo*1`^I#%9FS>?Jd-5%@Qgg!Vt^Cmi~xtB z6zzBS7-ZwF{2dUWs*s&bMtEtu=y;;|!P?MM0B0uQxSK(vt{P9I-%XIVUo#zyBU{za zcnVHh<-3wCIt3G5;>u}HYl1)I>$ib>4R`Jgd6l$i5c0L&@c@G1rLgU{(~SP;mk)RT z#ADU;4>~ zv$xQ4GeVY^qvcs(n~ZU*ho(v7=P4U>3AcYc)=^CBPvl=6v z;d3=zYBkyoFt8j23!OBW^;O&f_Spi)@^A~}F(ob8M;4OR+FShKs2 zhol}&%Id-GdHbSOCYsl}byF2bU-CD|Y(2c|DS;b5kIZ}dRmFc~h6!t;yp1!*JAXC9 zZe%H%6@ICSvOVug{#+Baz2F&B2-CSOxem2uhMz7#xvU>t&chP<)w7pl!!Q&*dEtSV z5Q-{COEBsqH(p%dR}o+)s{`+PSxv`aGt8|v9ERzB(Yi1cHJE^5I#19F!*qwFz12bO z$CMc#r}xx6zIJ@g)@!qo~GwGghJY79VNz_Bm36Qj!tgz+;KCG zL5pe05)^_krBzYJ(NR)l6gz%Rnt6$%c3tEm#vt_x@f@H=EJ@KzblQ`J$Rp#5LlJ&c zH_oCC)Ms|9mK&D1RhYcGodM7VgGbalgY}c;^s_qYZuuT{B(|4CNUnp z(v7X3s$5Ev>D5Z5M0Y8ckS3g(N=K`a;*)z%c^fb|dhTn}ev0ceLtP)TLu1tW+!oeb zHRjjGtSfjK=makP_WJs|vTPMkp^8cTwXzKD5fXSC^Eo}_{YEz@(K}+j5Z`WTkMJP; z#0nNZ##-~|`_;yh)-pyDi0Bq zWia2N1%JdHC=PPC!M3T+$IWQS0bbWqrynw2?{dggx8>L#kHRjCZ~tDE zkw#e6ZKVCQ{3fF&KWW*;KmNH0dp=A4~OYc8C5o>7ny~fd>5@ zPK*Dj2II74wHfnII1MxH+y5D-Ne}og!0VbTuS0InX!Ql9qXpHK2rT8r4diuS{T>zW z%@>+jW5VWpo=>t|`2@3Gwyles0^N&b8ZPZe4V(jt)0($YOP`=|K|I9uYe<%1314t2>H?Nr9xy5ee0IGin69rdlzI=UDN!sl$^pfnwL zZ&AI9V_lh*zaVpa&_^^3txt$SahhD!a+V#ONeZoW>AvT~X2)YkTlE5+Bi1+7Z%bW% zUoIoV=#js;$t}MdzcesA*{z~&s^XZRi$>vt^Hl_NJnKgG*0DmKPnmD1JARom&RGCN zLp|dr`jy@qJH$H0Rz$1DjZ4u3kL%rUIXt@~vmshSznsTJVYL)$kcU4S`S@D#P|=+# zCwR{}T+*ECC3d!SXzfy1-ED^y zow^a1rm8DH#xK#X3}u^LZ1~wGWm|nl-Xu(d9ZUzBUk+8yHoZP{psHml@!_TG=@X~E zYefFA^j*yp{ZqWUDMFg=RVlv;y4}}Wa2=eIBZI6zzf6S_8TZ?i9P8|joG&RkM!Hr| z#FvzuR?q0KDLDnXPbRLoWWY%w!PWVma6~wfDXfr9!n9NC1>b8aiqo}4!nD&F4LI#| z>(gd~y$gF^Cav2Ay;tU4t}VaEDB%b+IPJ9Ng)4003i4qS_urM0``yDXRiu1vw_t`P zv8I`#+NIIHw|&fKsWzz3VC3MUJU^o!Dm?A2P!dn9{ zC4kWp9?u80lB5|L4-($w>YmJeVMpDY4+H@qg#%=nUm$UinhF#V`3q0;y{(=MBNEbF z2<7MU3?lbIvgJvGX}ONCE~jd%M>cA#RK_Lq@dm*QkaX!NGf^&B$q1*4#yv_uNkq}P z7(4xO0Hi);rYh^&jk^~*R=se>XsTPQlaQYL4!|I$yj3!CI3BBW?I$rRtBUm8nRck) zd4~*SZpgHg4GkkOwD-{UY*znZ`Iw=?grw6z+n2)yLC5$1Ts&0x>j zL6+=S&d@qwE1>XI$Yr4jrU6m}e`7jaBq~a_DR|0L=}5)s!MKzObfqG!Ed5upRN6C@ zJu2)@MEygN=;sv~CRCpWNf@g76a^5{fPW=6_t;TNp^9C}zTdoOHdk*`e9LfF4h(+| z>&?%)jA)3&0U)VNtQc~sGXAis^T66C5C;@TQ1(ik1n{i){&U>CKnTDnZ!svY3j9Se zMt96@DKfAV7^_A@FJw9VqA=Zuv0IHEzUJI7M&n{Zw^pCZ<1f#IBm4daMh%Y3=I^;N z?JSC(K|1ke_|}Q{p|I=+F4@DXHiwE&016~+9v-WRtQfv2StkGrBMETG1sgh?9WO_Z z%SP)T8XiQ5uPCK=QX6BQJ7~>y3o!UYrP&Of^b60^HTH&i<(Ng}=w^r9t$=5`U_J`p=NK4M=|PY-qoV8W@iwEnthk4P_y6s0gk!- zGeO4x-J17L1YjE%w_fSZ<9S`4ICoTj{@!UhIa)!K%(e$DZzCkUutbn(3;{UKnWNet z0H-@9^+{oM&j9 zPH=jl3tB1`I@?jlZniLW(#2;GjmDX%%@I<}KD~9k1h+}X?*_jkRdF_Vwls=PG z@i;LrS5&@r+xq6}sLA~YA8VCq6dUY?tar06j$M~}{kR4{EZ~6p`>N#7a8R1dnNoLx zD11ORv-n`!V#8w4{%WN#`{Jjz9M|K``!?yUECj4sG-a{OM^Ra3-}y`@GA`cXQjbzm zidn1M=O#CY*6omkwhg-K)~Xa062H}zAm*cwBNJp_%{$EUmTz1%;;f+N@hiJFR;&eld3ySyL{Agbydlt zHyls9yTZ4>9*(E!lnf;<4HQo#GPXAkU{ba>ORxoy?8aTQ(mVj<>d6LTG*@r G%>D}}h+`}O literal 0 HcmV?d00001 diff --git a/v0.16.1/assets/figures/poincareanim3.gif b/v0.16.1/assets/figures/poincareanim3.gif new file mode 100644 index 0000000000000000000000000000000000000000..4306eb63c10c85aa8fef8576fccc340f882e6d0c GIT binary patch literal 362847 zcmXWhc|25K{6Fw(7G{{uQXw(+UG^=@ShJ;360%1jGKE6am>CR_u~bM!WM9To32Ce$ zG?t2xu_TE;W64sOU*GTd_k5f`&VT1V&OPtPJ@<9aNn2}u17BAVjcXeO{EtU}01f~G zfuK+*_v1f2JUqO-ynK9oNF)+n@Q0tDU+CG+k$;N+h>D6Heg0QmTwJQ`ue7wZoSdAz zyu89cNu3H6e^pdej{j5rM_XH4zwWQ0fq_x|Ut?oqT;pFeGc)tXT`MaqTU%TEe_s7L zb?Ouzk3W)J3IUS z(E9z4`wt&J%=_o_e*Qn7_wvX0pFDZ;bYj1-u<-fw=Ot77r6nb$rKM%l`~TO<%gZY& zDk>{0tH;-CX7*}l_UUwb9c#a#q2cA+!KX#NUUWxYyDtu^I$&QVLs)`d~@~u{QN@1sf7r~g*AdYi$sq_lFwp3X|cC$adGi` zqW|~OjPIXEzW?k0K3GZ#T1vaRluue>_AdRe9~sww{P?k)eRFwv`RBu!pEwo=M_29qy{Qv&@kNxr)`+u#ql&$R^tTSrX*Vi|?Uuz-xKYtIl#|O73N4B@Occ#a77QXK6?Ci3}cXxOH%uoJVnEJCg^Ji)9&(Fm_J3D{= z{Q3Le^53;zfB$v%5B7fj*xTCJ+uPgUVDE2l?*IL>zrTO5yK}I&ckmDAe@Jrp9Ic$s zTA1OjG}Y9>T>r{Jau)*C1VDhw|J26+lnDUi035iO4ZWb93=>rH=%p8SCSj!Q@@?v# zb>9`%3ZCk%D|(lXwMY@OtuOA&QaD@T(O3Wc{X_MO{rR>HC4-Oj!6>zmyqUMXm?8Z_m9pRxjXKJU}ndMG@s*NqWRkyAe33E z=fLtIIU-obj)rY-2LQecA|sK}P+~?icac+*A%X3a?NTQdxzpqm(8Yb64B_p?Vhb{l zZ;h@A#`EyqKC)R?CbH4j3pp3BzJk9n{IEjG=9)2HF(m$;eC1vmKTW)-1O0OGO{+8j z0Z76!>qfgCKLzdsfd$r28NT{}C5P@(XAqXr1>NEz&KZSCgQ+~V{jT4xZ&25+H1@}X zCgMdllRTrrCdDaSa7#Z7AK+nDa7+35cDfD_$h>e!N`;Ms2Rq14IsFmVi02Z*tT~$b z(&#vdV!jy$s}@LPfJBAk9WUDO*AY?R$G#n4IDt(uh9CQl;t#dLQH+V%1%-&~NJvqt z_7|$Op&0=05ajG%^g0TroR`2~j)pVzjEsC35VM>Hys2<-Z($N=sdwHqu2}sU)H2q> zBL%6#GCTB@>*4&pem9=70t&C?A~9XmUH%!z!Qf(=o~Y;?RrZNKUMxnGO@xPfbA_jB{$l}$(L4dp4~woyHR3c~UyNRGxj|1wjw!UC+(N&odX2l!4)wrf12!3SS0oLpSj-fn7H?OvC%v|Izn3wg|iLx5JNw`bzDuF%d=El)D(6vTt5 zksIGz!rlh{hcK9M4-XAB69(rW#*5&ML#{__7UJ7FyJgn6FrnSw+e<} z&eZ0Lj7ibNCz1Xq6X-B)8xY(k-~l4RdhYN&zD6g7V?ZzczV2~=4KY8NQILl7*|Vga zB_rqz+`RJ4F5)B6L_Yx|2;h$PYEnPSEF2SeC6X4h@{9a^gqJ5AhhZH?Nd4L~%&aH5 zBi|p}h%o@~CH@HE(Zqy+eo@7LGlZ}*{{t^g(2nv&TwZFij4n&$zzT4jfo)TZbN|Im z2vVUib*gw>5|Mk42XtsD8+99lkt{C!Q*s#-t<3;l?VjA5E3lL^tTTosJKQ-a;^G_b zPWf>634irAdPT?Q5~#fp6+opyg|QcT`R7cj)Hc;WsC(G#BKFpXLO}shMGgQ&csd}! zRI=JhMX;F^R*aj=9&5=aZdPCuCXq5AFk^U+I}-$M3c`LNBQQ_Z;4ct-dtM1t?@icxjF z6=_#V#JjoWEN!0p_oqrm@OcB@Z~}Ay!D}gTgTQhk8gMYa&xUg$$%}eFvT5vMw!{}4 z1JY}L`qlyXDay#kKk*xb8E{t(cwQ_!``W?i;9@>RL*5*QiBD|Y$o@}TP(SXWQ{dHz z43XIj&`a)IeAz7cC(+>*m>y+g#r?s{&@gK3mqK&R!k7rt#bzgKADLPAHkCi$cvypjZNHb$BmS3r6I1gH$ zm*9oeUYY(GH#Tv;TIyW6zTMBwKtMwzcDB;%&3#wS@Td6JkN7yxp{*~!(e=r;Ldj1<+4+-QU8#DSq9)ppm?_Y8 z`f!RW&}{i|PR{bEKJFW!i6KLa$7~>L_R?V@j->n-4~CIqk=1vL!i0)dk!BE(4bc0a zXv*u3h)JiKQ=M9`9;6}aM^Btf2hK! zfEB;vngCx{&yLnpWbKOH#P%MepG1zN!^K#)?VV^iIgi<=&Om3oUn=+B1{&q>6SE1e ziyMS^r-OE!j_Ja9LT=K+oL4NF_kTr6wz3v)yJ96#zpP}OF*AunkkMNM!DyyzTyN)z zMolx}oxf+_8v#=3*TQn%;)>Fq1VTc? z`ofcy0Kpci9&sCW*G^=ca1k|hGFGjjc0b8GYp@rSGP!mxbiX2LtPR|?9IQVz-Tzsd$A!a^;*xK7 z@tTQQTmn^v--HjNKPPE7#ydJ*Jah&Oteur8v;rymcpj%|q&yT8bd3iS;z1h3Drx^% z7vd+UJBvxTRkH5DZbIY1p!{&)ov$30erNxk=9>)Sgq|O^48zXQgS3;tED{k+ZrDb5 zN*RuliI^hdmsimpb!1Ro{9%PV;6k(xMuLaIB}PAv#PNWAN!t%e>hfZC)VSOHx});^ zA72r!tphT2T<|vvWEg#(CW&Mxg4a;iI4<)-@D~C%k_H^RE)swP#dmPw={{nY&-Gd! ziQ)7niL#Q23e-z}C_@@oN&9KQl~SXb1WN*)h zuQS9ZGPu5HzzUu7WsOAPnR3yYe_i=1h?#uxVDSQQ?<*UnzD#YmEZyiVeNJwc;p;4; zi7b=dESyNTxk0w2Tefv{woPuf-Ro?JiEPK+Y`n<*GY0pa-R`?Y-*?Tu@BaF}Tt*nT zBKqhSZHwXUXZrwEj=q#j+s9a+6!C={px$FLmRNYyE-Fp_0sTJh4ngJ|^zIgPorid|Y$Q1(LuT8kU) zO%SaNp8wL8*6EhrZIE~EM-ItN;4cQfLO{*Zk)H|3QTAgd3o*w@M)c7T&4ecm!jmri zlRoT|Apkk!hMb;2&Js|o1oR#e^FD~y9{r%eHovAk{hckXFPi@^12s!SjHSu`H06F^uF<5|j2Ot`myhTL#J$3ja z0&hKmud4ttq>gOGp;qbW7rVJBA_YPE1z@)VLp91m2f;1QU;(CZO2Z;$Op0V|Jf1ZA(v{ zEItSL+uk*hScaR!*z2YQ67MxYM8OsL&$ zuH8?m(i^S;@8*{*SGRYU-fcuL5RmVfyk}BszG4tUe1geDZYUn$VnLvPA00KT{-nhF z5X(16L;k>2sB_gFa1`o>MC zMrb@27Z!H5vR*)Y{QM@W^H&Jg!>Er0zK0CnK3o%j#_J%P z7Yf7Z70m17|28wUN>m}5N@(qU)Y|{3HHO|g^tY9H^v%eLH)9vx44il)(U?_ZACjgl z_?L<7=cw~OBO<2p=tG4qqwiV-X3;G-_}MgM7ZG0duRH)cZyf@R;ri3^c5m|S!QZ!l z7z1R)fOs&tV;TE@fxhQ&{_PH@e+sM;kWK3FdY{)w56sf7h-E(h4GaKfwh0fTf2bpO z?f5?8n|SIFRuS28bcW&UH)pmOigoC(M8q?7-aa~Vhruu65OQ=6bIb#fxQ3pjAs!Js zC)qEQ^0QT^veZ55=zN0P1mtcE-$y12JKT9@t5Zv|V-(Bx5J1@Oq3u(%PYq<9Mx51D z5%^6*HWA=WG-TLMes?hsj}XDoy`Cljt{jqmd4SO@(ye$6eHHQUdWb+I;_OXMs$l2} z91e6??Y=u6+y1Mr=crk4Ol+@0MsIWftDIT15~9yivCkm4=Y(>vR6N=_7T(Q5ZdD58 zs~FwQ7YrEaQ1j@|jun64z`u`0brayttp4Nt?}fQg53ny(G~Vkwy}up%UO%Y+(%pVB ze)LBMZ>c)+r>J08EWaBDP{;Pm7Y^vP4`i$i=)nh3Dua?@sG(TZOBWcD zlN{1D8xr(|IpQJCK5#MH{tx-@TkGBD-Kh7sf8%XEU=Lf|NK~_b%(=dB9WIY`|MC>-;|6s`Rg(v#F;^rUbuj93$ zL9rUcXfE&(<1q^iKfnfRDX3mBzYMNarwBSugeejY5Wa!%Ya_bJLzwyz=r!~x9p1=7 zYM&TIBhN}>fGY)0pX~A9!~nfDQ0jl?yD4=LwDzNTq@8*`sk{{5JT{7RKB; zo)~}*bv^}lB?|ShK}a^Bfsw78j<#c?HHx_^*thvH;0a}n5YC;0=YISdm>$92giO|- znsj=GarMk{_v~99z$_H-6|fLpl>*U39zhQO2MY{fl_qRxEO>noW8m}UNLqcwWh9!7 z`h(#bCJG(Lf@j!Bvw4N2VQwCl0>=mB%|?E}L4N3ZXX;^eM$mCgUjPq&Y&Nr%Hsg$( zPF@v%?*rl^f;M7iMNA%x)yy6rnR(hUPOW>tM@LpO;2)Vx`MSpPILsOX^_Dp5<@8na z+E+fOFU!Y(vQsxDo^wYK18nMm2ngR(7|^0AV#9R|Hw<`cPMIzl?fdYY!ztf0KWX8$ zFdFso&~0%eJa`cgHo{}P#TPFgpaawv!Td-IIVTyfBUfV4Ogj7}1{LPTe~kS}z-+YD zcU~iYo_CGs#O=?w_tEEYU_*|&g~ivX2E66kw;8mL-4_hpa~f%T3#xH{T_p8A;P;ch)!Tl`01KxEt^h+_0ZR_66;dvwFVsQgZjF{({=EN)x%E1 za(9OZq%nErP`Mb<^z# z@9i6RwxcArKNRprNuZfHcrykOZMsA8-bpk?ee&T=db^W4vqK3(X0UcLO?R)=@)oJ_ zC*z=2H0a}&jB{Z-&aQ%jSYrz2r=!)MI+H(VikCfjguIqKUw##gZAOpc;N95K_TN8q zX1}XztQfg1x5k4{wS#YhR61tRUB@x+p6+SYeyRH)2)6s1Q^41BJfQjX*LJTXZEv#} zoc}~Wu%#6+$b)_K3?#BJ!A_*sB4bw;_+HFK*>H&G#fof*5_&tHLKUWlueb{rq#m?g8&Z z)j*N6iw+Osw3%JGXG?I8jW1iPMAe+D3^z#=2$AGE-J5ap@e_yL%^&vV=c<(&qt9J& zd~)H90ED;JwJZeu*6UETOQ`b;&GMJBFyQL@s_<3am6*>z^nFKh29u?qgWTKCOauq` zgZlitMdBs%T`o>aMb0z>TJiC8jo`-qLx(OWp7^KW$Aei56g~xCqP>z&`0Li zga7Pcc0qJv9}chLU*gN*;#>yt`t|3~%7xx`9_hVO@t8J1n?0ga*v-_>T-uIzq_a8r$3x0;H1ulh@MNSJ(6=cXG6lZ>3t0c|3%=8 z!28m?h_Qkw;;dypsVp_SNLee=#-982STGQBAaa>_N1XbfM5t8!XqN!Tw>?42!Jw|- z-5;mU1hIy@A9A37+^~ag?zcjnD5BpQseGUe7$oor zyNsAAd?6iqw&hE%L8@Pyi%IyP!UvirK0_TYY3~?G3IW5iQ}W<7fF>oIWFoc zN88)r&;I`VP4E0mXlCAsEqWVy;&S$-)WlwPr{M9ZwMo(RJ()I(n}OGdzkKRCnzoRb zw-Ic792qfUD;l?jLZjGEF1W)(BM1N9@N^%y%9_5B7OW>OIm#z^IqSWFpYab?*0CoI zb6KYauCMrZdcL|{z$KfX`D{Bn#57s-8NGeEF`Snca`jPT|IQLOOHjxL1HRE+;k`AS^pgPoc< zB{3ZoJxB=lgM?yldJiK_HZck?fi*d6DVYc}i5S^^(F?|k&= z_YQOb{n<^=J{Y8Z)10W``O%ws24IRKr))#_J7A?Z73~o9!12kM z+#W^Ntl)J+yQc@U-wAusk0Mx^vj3@+nYTs@1?E4yjp+V9l{eQ!1zmpj$~Q^jdXPZs zCFf`!9Xr#!VP03!=Y_5@O9Z=$M_JFDg$NfF%{(ida<+;k-qD~YTLL4W(l!Yv-kdre zW|8g$+?P>3R#BbuCD*T4DhrGBbc_do9I^SWyQZI@Wk>p0)mE#z&xESA@qX$}KBwn@ zD9!CdKd;$UO10axf@7vH-+=MA5|grYzvs|+R(Upn8FlIm&&LA2Q@MW_+>ABa@2`n3UwXn~XBE9O z8!rl0|K`0dSUi(SoJSYw4BnAGM+6Y#lF&A!wyRTmqC(Ci#MfT`+G~g5Jk*W^+uE}` zbe=nyrqqvTxK(){VFaZGyG3SsRLA<~J`5G3)CnXnFOEu%@FcYB)ej!^>~@;?hxK>p zYuu{-%2|h%W%#&=W@)SS{%^FS)lRn!nmE>-p*ZJeoxf_MXX$iS$~1xBt&E&$|LA3z zzb}lmbTrQ?W_r8r@Jmp(-3i$A12uHgz|G`-UXXesZf3`KGDj;N85gLpY&jTG6Yjaa z@}i7T2qRv?=(rHP?!nyk1{nz@=>0RL3>}dhLD~fI(1&F^76XVsR)8>0;QUOYM14+A z`;(!4uKXeah=e`qW;zI20Rm7j+ADcZuzPogkB33{MD?4^Rw8^7I zwYx;Dx%*Af_=88-wQ)+^b5H-hw7lS7E_|(#XVW+?mVYJYYeqC3=z!3k<1FGNv-7AU zP1E0p3yZbPf4PG3LF}rHwjo<4LF@*YhhEc?a>wH?vS>~bw~;>Vy(enpPVe3~4iy4g zVI!r9xOtO_9!0~-!?ep3UZ}n0)LprBctPn_m9e%$!d<4^X7OYn&z~Ng zq|dJo(sg@@Skj-@j=u`wYRk`;(6jWU>iW$F+Mcr9kyJ2kDlkLNIfMGow?Q&otrvCPMi1S*z0rj0)-p1U8F~11^Z9wGl;hi& zPg%FQ)yu4Y286}9VmpKz-o^cjO#kbK;h1l>@Z4r6yiN7O`0czqd9c{cqzsMD3BDIj zT+4ckh`+xG%;OKGA+GPQ2vYujVVX?nFvzC43W)C~?+DX1P+PBN_Ww(|^S7ZLezj}n zVEf&jgAESi+|mq(^U73mmm845?Kg0rRbW7z8PEaKveCrthC~}52E3TT8}jyC9Ro3j z+t%UYD>CBwYI)ycsF5{m2TBI79zeU-FChB^^;Gh6+xU zvXh!lz*;tVTU(IcE!-|No)~*kF;=|D7#ArJO!6_8&+d?0h?g%W^G0!pusRxx;GS&# zV+(rF^;iD0AT^ujJD84YtT~6(ln{hBe;Um#7zGGX69sZR4O=_!^je(QJ}pP zH@FKgP@`F@k&|Mj{UnqP>CP2H?p!Vyj;y^$ziNLp3P_mAc`^PB9_u5QxI_e8Q)X+I$U~G?q?L(-#kb766C~4tOmBYFHZD8_vKw>8er9eEBO4n$W zEOmz(1w!r-NI*`!YnQ-u=7}_hRb?+pb_eQr3xc25_R4Q|z|l!Iq;pexO=V=Ark+xw zjEMqCr=X{|ucu<12#k{}V-ijY8x9DZBw-WV3}J+V#2eaH0Y)jz4)y2C7LK_|GB)+e z8CDhLC(Cgl&QUt0k_7e1Np!Sq%)#^Em)@mY*c1`t1$%p6U+HxyOa$=6;tLklWj4bE zX{(|JLN?spRbyJeJCUtZy<}FJ!*i6)m6PAw0juuLOwL_EmQu9! zF!10z$N+Ogqux{ zBpO(Y)*Mm%p?88=v4k%Nl2EXCb96sW9TNAkcUPIS@8NnRvy}9aD!BvD zmXc5Of@(J(Q)Ly2X+rVSDep5AqT{rp>k~ZB@d?9-DmEjDv!B0f;+HktPMWz@H>p?} zyJA})2S$AI#CXH939`-S2KMLDz|TcX6O~OW*P2GyW7Ke;gcjOZn(LR^K=;yd#o%$W zC9%rU$Kd~|4mZVMwT;q!aEE=AF)DyMxH=^D@ zHh5&HL_mZE~d8 zJa5uqb)cC(+G>{PK}zl97tfmOO8`T;)QUb?|#HL;dLz^pSB(= z>i;dW8k}&Udpwm1C5TNw`ptDT(CJ^|BEQB%5T=*v@Wu~vannJSOts4dyvHDwkTU&f z+TC;VtE?{tAObqhUZ#FuE0zWo)MxZns8^{vF_F|b8s(a?P3Ch^dj$Z&=3)Pa$3IW> zF7tfKRJ*~VdoST1fyl=L8a*s4u!G6I}dN~*JxJ#gCh8cf6fL<{Z2XmumZ&~?_ zHqY1!%#q@czdpoD1QHTD=8vdOJfMH}WrB*gr7ie_0Gu=^;K3H4B$e}bU^4B)?R_z2$S{EO4BL)5bhC8fed zZf1N{_$7n>L_gZ%2#{n*13w&C%JE1xEm-GwbxoAOrRP*7Tqnn=JTj-Q?G~TQscyn!7tq@dP8D2Noz- z_U4|3*#nw>(uJnvze#0@wDN<;Z-WvIp7>^ZB`Z8WbJID%yZN$D|95{Ub&Z-7SQ$#% z<`9X_4G{d3=mvSp)MhzYYt8EiEe5AUsD1@syMHfd0X#4o@rn4AAf+q8hF2V&=+!kT zSUf+4#uI)CUU$Ka#0VK2YOdpJ85#8h`zOHWZoJbD@<) z3ni6>_DCDO)8c<$X~Y?rG;&u+n0eGTtNVtz4nB)Fo^$#2qw>wRy? zO1W*h=jznmwoj7@%oA@ec_nKB@zACwEk^Qxe5U_(ny}CQ_v1m+JC#;uyC&>lMn7@w?Ir578$t~>p@|-$6xsy((^$`t5VSL>ycZCo zA;fxtyqpeYN{3RhIiapY-f~^~vr-cN3Z>2estfE6F&-2(esp^=i5OCD18k^KHFH*T zmO71NQ#Isa9IfvbhMN|Ly{W3l7b5LfqGepf(uJVll?p7^ngaESa-hN7RDR-y$hK&q z?!T8DT8@SAm63df6O~*6Tbgq_YKm?pn5=2D7;RlV4z0GB<`5jUQOC-0I) z2q4Y{%JD#xC<+4_uNld@c4K8=y0|cLC85?-?`Fbyuwz(Fd&$c*3FSaN#h}xeQ&*jK znl~~|Q?CF$sdsoS0Mh!o^Y`B>KlrZr5RHN1i8(h{zgO>&88;GYc|RG&Yq)|ktoWYZ ztZGdoNwI<&4sRtW+{`-(i-AECI0-6cT}A2?sa_I4j2QJa=FUy(tv#^L4b4K+q1QD@ z_6(my#?82=AMT8kfpKC50d!Oy^7=fcBE6ZwEXs}w1KwBiY0ZB7h7^@kjoxM>AbBLGJM)KvYy?=A^$5jzY7bMk;4 z60@bpbpJJXNY+iE(TPOB5vB|@Onm>0QwP`Y@7+;YL8|Ya`?WLqFQ{Tp-Oc+cwG~4V zw%_4OI;Xy0VYw?WM|}`$tC$oxd>J$Uj0dkjm875G_un%0H;*;#51s2z8Hnn};TBK{ zWMexhyhk)cmIwtVuE+-dTY+m*J*lF{Kuec3++L(fom3Nhl`7MpEj5fh`(r(z^X40$ zkt$o}6Wk+1PwSAVmArS4&67k|0yQ3~J+nBaWTikwH(T?<}yr^{P7 z{%pR|T%o`1z53&7%_@l3#@b0yPN9vix+v@fN1C9J7ef4kDen&2cAjUO9Y z(*2o&Ol|%YY9v(qt?-uCWQ2f^wPV60@!Hk=ao@Tt&ySgSoocARl9O|>bIRd_Y~CR! zkh1gP^&1nT$X64fd-NCAGU-|A`Gc{=tF87a_(zq3Asx3L37dXU%Aaks-)`nuIEv4& zZyb4C`Br#ZjRK@m{7x#|J9n#mMnvH3^mOcPS|UwzR7`*D zHea;#T?-t;$L1p7NM#Zw#24~q@9arEGlM_d`AFto1M?aye{wD~-}3>Twm1r*olKJN z%fVAk4fQMl$AX0qMjP2BeiknI>WPtkA1~we>xH&1+G#6A421DjXLKiXlA@!=B|@s! z&(Jgt&qKI93Mkfqyyb*&7Gf8Jb6c^dGONEa!9eKxkNdo_1RKoDkG&V$T%nUq>62U+*pcU@!{r*1}XEF zXN?lUhNm>fpB1Z`PY68}YmiF(JKLo2;Kb~cJ?gW2%@azKw6;CbBmX6BIJ(wSx5b-E zTlW7bk7&PR{H-qKmY}kecmKyt^x>L`*h*5jqughg+fFR_q42GG z*}p%cZx%dF8pUuSd}DkVHcf`s)zaB6r3vrv%?TS!t)W*xOgM@=dQ`DWN{y4Hc_$eS zYMWL=HexNMmZB3z;U8}DynaI8lzy)}b;UdTFM741&$Z_kFOL8xR{gC)^`dFg?Gm3l zq)XR-aS(nl^NMSHZ2r5keQOfoK(AO_nV-SiTtO1H!}{E>;M0}1+wR3j&`WJD4v*;nsaZv2m?Bq{K{7Mj`~St zln>^_oKrf7by1wd4~LA;9<>I{gnh3gk6c{ ziSSk5EPNl86rl9)T0UX{nBPg#MfqUTNzTO_Y>*9ngd54miCgW0g#DDxUP&z~(S4)n z816nA7F#6xWGB&)tTa|A5LxyCZ{?I#G4@>ZMY+L?M8$likL91n#GF+tbfm6*tiFD~ z@(VNge5cZZqzPMRH?u0e&LtW zi`(w2#d{Iycq$oNw_143cLeQ$zjwUUGe5iz;yKj#;CMp>_g(s5TAN|9cu{ZS&D_Z< zHZNScQ7O!;z>M$P!F=;__bS@zUyM4It~wKk^7RCJDhqL?CAJ^G&??FM(X2R!GkEn> z{Wab}5!bf$XSI1NSF+F$9Eub1Y%J+Z2K>5M*IQ0NtyOkBUyE3d0o)52QLYZ**?@L< zP4Fng&d>5`L3+@$Nh-k4`=avSd!CDgU5cH$@8=AWRCB4#kPt{e6+!3|R}-e*lJz@n zYoPqmCt=Jz#8(RJsx;TzRo2|$-<+`Pb`ixqUQgss$bPN#FG4>dbUk3@(uCA#pjBRj z=4FD0341nn%9g zDQCykPk!k}S~I%ymw3w~gC~v=C0VEZZ<#KPOe^$CtQW{U-n*s4r8mIX@C$wHKt3dN z3HD~@9Xl!iV)vQys35hWhpCeR^CE|>)?QY#`O^0!XMqF;m2`cm%;>m^1h2jfF+QP5 zOm3QKS#Vt7`s&9$$!Vb5AiF-Ck|W7`dEM^A>Uww~Q5t|^W7>lnkoaP0X?q^8QHi-U zhlq)pXSZ!(AevHDR-RXhOS-8*`#f35Q+ASR8Gqko%$eXmrAasfUvC&hbF-(maxdR#SSMruz# zQH7ARQ8-glF5$!gD=UESAT5vO0|JnvR|dST7tDYN05ama>TAz=@lcfo>PYU|C_J?p z&}9OERmUu9Y_Znr9f*Zw-vtS`m8V{;C!UR+iZY#`dzLWALD(frQ(UKCQ`eRbHzFnh z;oi-y1~CZafbgwdD9|Z%u%#~ci5)`n!0K!FxcF-(*3H3p?s=DBhl5aXmw>LMt?MkG zpJabv;TyuNIo?7l=aCARZ_pZqt3Qv+JpqXt6{%oJmrD-OeLI>8&7-(w-&n%?NxS8i z!Z8EFS1pa19jdSb>jFvdf%isLBr)B4*h>gWIm^Q~0EPiEYV6QhC^%N1Yi=}W&9=~_ zo3nf=vWwlVmS2ihPsvvd$SYatQ_O!4TS^-ulv6BqeL9Ytbg6vlZrzIq_rleJS!%r9 z=re`nGCy-fkqsTJ41i^&iX>1j3tShl_1zMC?a*aQfex|?lQiR8q$3W|P3bbx2FovS z^7TZ$ISX@+LO8&|<7|kJeh5f=p^)`P+DO3P&B#+{53gBo#ebuFJCwn_Q*?$RVTvOw z&|S|$F23!Owq;uU8;RE%Yx0F=@^5FElA*%tu(`T$?8Z^^dZ?+sg>|OP>aiKylv8%i zmU{jj+Fdf%gyQBXe>(+Plgn4a#`}b6Ns? zwe7CJk{p6k$XzvS?at~e&hK-j`o zZrIhtF-Xl)KcA#JHhaCz{|#3_$fkvEAW2zePLyAMyz25&qr7>eg0){X?YUCwc zm(p&A+$Nc8G)iBlETyC>I5b)5(?O~cvKDMEalC)yo2BnQ3Y&qP!00a*gIEeFOM$!s zkeeiuCR;w<6hIn(K0@vGM}7wAL-Qa>Cj$U zOdI(g?eBERHskO<_{m`iHb*G28b)Mv<{Dbqi^Cr1QYgAGyTBl;5}86jQlTU5aV8IT zm*31|85g*Wvjp=jxD-6=&0$&;iU)tM3Oc8b1Mp?m`bth!4#m0_c{SEKH>{MpKjNl> zYe<<&`xd6fIANla-}v`M^&`eIow5$WL>VQE1+!zAAJ$D3moRh25rJCc3eQLEw2cML zLVn_+ewqr$qc+KOahmSqN=4V~W~uBG?Pt}OK(Z_5>cX6{=1*4)r_bUhD%-?`%!Yrq z9b7S1bvA;6mGB@Xh(#Ny>J7@m%2>$ySfcf}!**Q3C*z#$9%px_I3Fbv?e8mJjpOP~ zTsguVbG;vO{@6LEwK4r{vNEwl+mhVZqvB$9f8bM_c^aX^g1a%`-9J{=g*{YFsw{W$~ST%ROE5ysV`T(rZs6c zn`AvENx^|!UgGin|`Sj@5Bw?){IKUdvxj+Z9`A_?T;!Jz4oAmkXyD%7EAU zzc+5GZSL3bBwR9MSR{eSdN#H8>Xm0~D)D1rnWkUbO|n(ET3B$H>Ts8dKUpP&q$M0C zDs|kV3dBueMCXGyM$Gj>uF`Xkqo36V>>WL!4_0XG(8>Nq=>N~$6~uq7T~y|zu}Y>w zYb{6gWVK^&j*H}PwJz2&NKUBp*T~{U_bwwCD1T}$E)hJjY_1<=Dd5r#m9XJ1?b_<@ z%zfOUja73Z9CxB1r5kamE^Z@-PK8Eu9Wl-_-`fD_T}j|*#+gmBK225KAH1szMSJ(S z9*~ei?FJ95j6BFHL~|`5NT8+I%w;ucK+41)tnSevbiNMnQHP&OlY|f<+C4|!cktZm zOmfUhwCfW%;U`!+oE{CHm;)WMPZ0aBYZ~7vkRRYRWueRJ5Z~4a5U@uG_9BY9LVl4Y zy+Kl)brq@Xa2rk8BVdUOmLkelay-3q+mhZ@VMnDkUv_j!{iJLwS)Rat7T*XnuhMjC zyneg&`h^g6hm}ssY>dEYAat&z7de zo!ZO}S*E!Tq5681s+gs?n;}+49i5>5ibvzFWu#`8afpRxNQZ(9 zSr1DmMy>Kf0FkN0%3l`x+GGWxOxG6BPp&Gl? z=|oSxxVZ2ly1G+Gs8i8_LsIkt8wjWQyyy0nur#Jv=wLc8HJEE=N4gC}p0c@d6aP}h z{bc~V)6m~StG7cYutPQ0TyN}p+%Uu_3aq`LiF7p_Hp>@@HP zYhx^wJwS4e<{Azbx)ksUnaJ8xUyZ9Q^a)LB^bT2nl1l21ZW%b`scZO^O|EV|H;<+> z!UM)Mi})j8)ez2>Y(7X;h^*z@`R`eca~k7Jfi`YpGZOzerq9c^u}dM`;q-&~Ght~^dslObz4bn5t%^=O@j|BtD=42vRc@G{}lF}^QNJ!U`l1fU7fOIa13JAD#cP-r^B_JvxxTLh8NQ;0-C?F^(BDgQl^SuA~ zHlJqZn3-c{?(4pO=S>_)xpO%dj#7+|l5@Vi@P8x;4kF3@eDeK*Basr43JUE5rSN9L zx1bo?=(O*LdyHDjEdvVC1G07l*W{z5&;w#4{X)_Gyz-H}cKv+#e!+jxB zNbxmr^SFk{>{(+Pn4j3iE8ou>4;E?MbW+!pu^W($)>LfQR8IcIr!7zDeQ1{(Tvr@y zajdDfciD%msoW0ftc~hS(v**mlJky|tLl~~kRG*X{Z)znt4g1KZT$K3_ruZB*K0m~ zHrl$I9PpEnrSL^xj(A_u0IuA$_bA}F+vuIX`|H7;`DiZ)&xekcOur4Cq#K{CeMN5$`e51f;f~6jThE-I%KXEg`9~^L?!@^tmBqZC z#nK*XL*n97mF1Tzi|{^3N6*UJixt*B@U+V6w#uRi2)v{6;d=kfqZs-@VEsz(I;ZM} zK<~y?)z5OhpVj_RbPzw^RQ+Pv`{hpf<{eV+mY?djW$)%g)t$KTooD!+yxv_))!ou? z%AG#q%ieFVRrlWX?!8srpYPrOq%%OqQjWn=+GsfX3KgZ+ z(I=gse}&5UNjhRAHC)D(2pXKSnmQW^tE&bWld!nQzrH=$i+}yw?6vYV5gddU3iQA0 z{`mCz>mMjBHg^E*j%A~KZGrPt4-&=#r@xXE ze>2TBm@p%c;B`lr_v<3|LZ!hPcMbBc$^?Y!(o~H^!s&Dx$+O&U5~Ni0R}^S#`ycDr zyT9iea5Jl=k9bF^aOgT3f$D$tmv)`xVfpkB5QrjcwXBFeKdv}h{t57_eY3AO&}b+ zn`nL%J5;itTu4|_i^;++qmL0zD)1kCtbZN{up5&1L(VD#zXI`~&MHlmB8;UbBBK74)VPp{Fr7idi%nYKYTx;F!^j|@Pyd>*p?E0hX@sl(wcFqY@DW|}Fwx6Dj(bS-Y(j>$JT4YROz zx+{}A=Y0QmuB96(p$~B{-hq6{wl*wx(H{N-kMPMp1eWfrg$+l;jpJR*XndTUBFUUu zTrm&VbFSEge=h#L7`{guvb@6$!`-`$zo^cukNg?->(fI>jbug0_Y{IOEn~|)$3#{R zCa18sKL8MF!pZVWj#cl`=Ebc-|0(P3;^2eD?a~Npo1O9m@ui*0j2kw) z)%m_lyS3%1Hea7SXD$vjYTLcmQSs%yXEQf!_n$BNF7LlwPqjVh z+-+Vy=sudV{oeEEVEOxN5Nc%$)4?K03yh)dj)q>tpn%eZ*Bbk<(9?5IDja46Y$Nu4 zcx&{D;0HVq73(~(?7Fq&K zj(=bH_Pf&y%isSt*F2oB9Pz7K{&Z`oG@S0G%8ErRJ_Z0<$)Neoll=mJcdg=yQDp5D zXIA0~i;~7fW{Ze)rLHnr?+7DKa|U&NuSI*6sg-dntjA&<>oT-T;8)+L*Zu-G?5|v+ zAnFUW{?u!~^tM?3$72lskH>HgYxVyk5QW-<0NTOFho3pGNjd!1>h1a5kd~(W`uxj3 z1z9>cy`Y6T40Y|rg2J9?%9qU7hF0rRo=TFyS3>z4LzzosR3NI5bghshn7cvU(8ToZK3pa(>!#Zk-U>HT*F zl@kcs@ndTmVPH`#n2HKG?AK+4;9G~;9#P^cpm+d0AV(2W0{qv_NRcvm2GC!+7UZZA z^uRs&Di1UfOee}e!cF2K16?+EX~2L+*tXibN;()x0T98}oN+6@cYU8YkM8 zk!EfHT5~hYGCX*zaxyv|m@#sO0?~E`v^)0FC5Qb~2F_=?Ap>F$JIR6pfP0Rsq;*4; zRs6(&m=w;1oBt(E$%F!oW3)U&-4nY}Xl#66j;nE!R*1J;COc<8_Y8)dw}sJ6%9usZ z!pR29DyR(yMjXUQ)58>(fX290G;}E)!NjNm&7gDwD457e=WwFFOc{!sYY+-d!>TDO zP}{+Aa7GN*$(jIUARY0DrA%fv9~JhsAsgtSOMoz~QRs$H7m=2TlIGStWB@*r8oq-a zMrXiuv?^$yZi}Ap8FRB{kC3DmdVgQ=gi}ppK(L6aUqR?-5}J!#+fqo)oRxyc6K9}p(~h#{p5#qWMAQ=B~ZZ0 zo8 z>HD9^oouJ6?(h%pftkVvEnn%I0vG_Vi|ZmhBI)W2wM~BP@pd1USehMfwSpJCA0Oy1 zMr<-PIVpM@Flk1mkFHUKS(x1+Aq9p>HwIgCD)#(#wx2#m%w48l_QCe7wlUMrHJz0x zW)&}dqwjOmdLw6bHH!J^02BHAss^1K-Ii0_zc^p;k^2@WvW77X0veNuO04tsq^bmw z9hp>F9CiZajDb-w;R!a{wCzEj7?``05t7yD%;})_55s%8c8#2JBtV0}^zoCwTKX-u zWl4&E8lq+{^v}})pqYrjw!V1>2kICob}>wNYik^}7WW!V@C&19{G@M9;QN7(gnyN$ z;~%LsrI^xT)Zr9%%@#eO~g{g^*pMXi|8Z)0&rpI=M?J z6kSe{P$o&XAdcI;j#A8{rzGNOQ|qk5-WTqBgjXv{HbI<}0G(mm)e;qK!7&%=J9HfC zi14@cGL3-CcX0nHKP;!aaFe+?$N?o_gU5c~iPVCsCELF*ar^3~gai_*pNkd=uI&gn z>vfSFPJ(rkoI!>*Gs&R#$GPROXpftoVMFaTf5(+gU&E_$`(7X5pSgT18SYg~#xsUt4%KNAUOycSX)|?L?2)r5+cQqUrh>XuGRNUftJ2Jq>ec1lBfKRcm-#~Bx zl%N!|L1+C{OUM34TIsts@$|?J4*p|tP}xq@=ComO8Pvl_YSZwwLa(0Gz06s=^?r3I zh#G^xw#)xeiFExfd5PaJ{^RPhS#q#X9q4bLN$PHMH}}&6Z4FWEV^R;yG4?926BP|mRyDe=fAEl$wo2+XZA?@6_P0Mc;aWIX>06ZLwHCna$2gfAy~-}+ zgwUIpxjd?-OG?AG08D0|&LG6_IqOK5x6>D#Pf6k5w1>{tf3E)KlbH`>M8igGd6a1m zDQRayNr$0nZ+xP*!ya$z)<$zYl0#p#U_o?>52YV~*BK@8>ioEy4BRxMzW^CDgboWb zTnA@LGOg1%iXL8DBJ;@4yGJ^V;F6Ez3ySo(3t%u{%F6JDoRF^>uKa+4+O{YSlho}2 z7BN{_X@6PS_k#V}U;%01YME5uJnK!S7&Ac{EJC5bHAaj-id#2Q?QYbKhhzi@I9D2g zm%($uVEMWzH9BtEplAjHr~QuTv57LXV=M$8oA)gC)-Y{1g#Ei^G+jL7{hh#vrzlG% z8*5Sr=FAv!;(r0xKA1lkn(GwmX%9<}~fccKYHFaq(aAdsifEsz) z?+#GC{}g7m9{5+!QkE&ug4Qn-Q3De8;>vh;`dHMzaam_PBI6OQZLWV=adM0cje~-ONKG0xD5K@G!3*X+E;D?teKuf zrlZQzzdwvfo=K-`P2G2A|Nra_yeO|@+MD>aF+!rxn+%RWzAU87EJY!vr!TTppU^BE zWmU~&Y5YGtMk39nkdd_ujCNN|Wnq zeZ~EQEmd8PdwwpCIWHg~`*|7iiCmuje?<;3BFD%&?_ok-qyiz@nh+aIh|eb^b`p{o z38{Yw>CE|=3i;XA`MJUQg#7%1&itaq{E|QUWy}Q?3I$cx1vSA1b@>JLodu1H1pbJ`(KM=jcOY}{VA)m70x9rm0w*d%RMWbTda`as`sqt+UhEHD?tA( zqyA`2H3?8QN&Hs@!B7y(D5r5$t61t|JZgZM^LGpNMhn#kfNJPc@<1aqG066G%JQ6j`YHDVh{K;z&5v_WoPuRVho$~2;%A4KBP{(NM#miLuG&0}eX~#6>hiR(K zX=-|sS5Ck@^*WAf5>HV(-GWlOJQ9k`vDHA-~iK zs6Jv*ItCT%iRk|~)2>eh4P8UWJnBfG;JsQ#rHFx$^*#64eg38M$>%en(t={`R@81w zTRZk?lktE2kUjL1`Q0b-O2vn3RMTZI30R7$!S!;vyS|2iq61QW4FnQF z6TET@9+gHFW_u#r%oA$J6PZrY)b9bxLK2?*B|x=`L;XXK+8Cg#m!4GWqwUau7@ot% z27O^n{lS4EZyGs;rj}dIc2WdIV}Q!*eUS38M(0*|MSIwbd7 zgT(;k24dN|lhvJeBi)qEJO=Oi9p9UDqSn{`gUYl4RO@(@AQzkr2iEeTLxwctJSq4SN);v1{mIk*&B`>^bD^js5;+{I^1W4-1bc|{miAw1**Tfy6c`s^fjy2lq; z$2h7E?7}pLnw6bCev(GJ1!RqRPtqGno@`1rYEGXV*B$*}Z?eb&o|{^0gR`L$juu%R zA)pp0t#<)IaUZBR))t8#GSHyBxFDf6AnE<>WBu&jsq=8kC8+OwKXG=ezMF<&zQf zy2yzpJCS^KFf?f{0|Z-z-VFnsP8#6aMu_##a;aovwd7O{v9t)TsAFWCcL=4YQYY zg|x#}N3YYs;+^$ncgQQ(~=dq3s}rKJnvyUiRqbD;7+=~RuEkV?yU z$Pox+438!KO1N5(Myk#rO(Z}4ooe!Dj`@;4`L&w94Ff?~iSY89qwcC_Mb>8&A!m>F zJFl?b_;iRIOede5rmk1Z>1_U+Gx}E};Y${0o}t>)5BNE^t6%BUXd{WR1`_c+YWG}C zZ}X=r;nbMQr;utGyOQ2{&IW>j9LN?+&R6}etbNZ~Wxv3YqbBj>Z(68<_3z8lATrX0 z$p7UrRHKD1Kn{a2My;wN3>P$9uFL{g-t$b5H?La7#jUDsPO^HA{_1Nru zX_szSLP4K_d<*xDV(pZE^Z1z^jdX)z)fg5F&;H!22{&Z)r8kVKtSXyDU`U&u7!4}> zlY(D7Hr1XVdt+GT+$?I`zZA@#9oFERA6jG%@G;)ed=|QYma}AuwH-`hSG!?gS?)AK z_tQpOzcXMkeAPLnEBCvj<7DA|VOMXP6VEwXK9rBx(T~lV7Sdg%y_YEr4L;}GnW~|z zd|#9MQ#c==pNR&kN(DT&*L}sD-uDVyv}Cr)wC`#f9~g5 zR~Om;g`NowU4LEt@Tul`y3(^uKDNx&hBWR!NG%EV_ydX?@&&)%H>i*Fd&J0PA_?)Rl&C4&-m|Waavv{3f)=81H!o z!a(ekbBe)d-?JauBO40*bW-;f-*>Bk7l1cZ>%7-)4!K|j7f{TUtP0I$ca$}mFZ*0~!T=05xB|8~) zwDPHpl|vlEEh|vG_KOAQJPTPX5LUO&+O;-^(I!^@)Z)3NQB+HrwMSM1yMxw|Wc_XF zz2{iP9gH58OqEUEZP4bV$H$lr91oQeeSdqak4Tb5xu4Iyh7#9fQM3Ac42CaN1sM8= z3+g(?BzqgSj%sqkMgGpW`jRz|5)+d)wpol56W%n$(0LPjx zw{ZhZh`avEVui8ack8OdyY#w$EIJn#J>zFu`v>Eo6%MZ-g|f_){BSD?o}OCPeKC5^ zcB8#RR_~cdYNze&WQ}jU-}7?XZF;+%46j}A75LMmml7`*%0nbTiFaT9{k5Ps`I%9u z#7XC9`05P%ocV_gt_Le(v)6^2nB5e^!hSA1F1>h|`Hxz8z59WiFN#c~EJqi*ec7ix zC=g;BwDjCJp2M)}p`qJRv0u1QfK_?S&T!rJgH%9qfe`qaNM45j&WHSTW=hL$>pgHk z*K6XC?VV~dlPLWnp7J798s&-Sc|@)^8G8AA=$v0Aaf9gB^eXOAIk6o^21KxFF)?L@ z+wss%VLzR}lkI(Xl4?06f8ek4P^O|fIaMYaMI~Qv<-x$owPW@C zQ*fQ+Y>6#!ZAEC(Xs|N_myih03y+*{?lEH6H$xV}KCz}%YwO@qz1-l;M5Ra8kDE;> z&AD-L(jG1~`u%Ah&KoRwf%;eYGWYq(|nmQ!!QS?qSgFspBt zEiZS5Sittx$Es7Qw?+80X33MY8IE&BXtX#)b)O|w&=qRa-cTS9?xeAxWSQQnm5j48 zy%p}yEe0Ku>8;cQd1HVo-X|J4!KQrbvw1E3sDxMkG8v)+Pzr3H6q8dLQgHBzagL`3 z;E#{>maJ1G7t}n6NV;`8qof?84!>lJ?N@cGuWNfo=?0<$jBVtI>b@U3u;N41Lg*q*w2|z}lS#Dye%kF@AiwdBV zLI!3EPAJkKDK&toGNQ(%GCIg#_55i{6L6LhDKYzi%l^v^m!A7KBxIa9C(+u?FsrHB z!))&JpPUkE%cIfR``*7LaueMvp)rr%c8=w^MoN7Z0HvQ zK#9=b`+LYQ{G|KNzhCpONguCbxIqr!*O7Ep*l1yMbqAQ-LLarxAcjNPkwi`CztW52 z6is%den=R&=N`!vd2~ku?bOGi^^*DhS`)Nwv$<)gJeqJ+E!L)}5R=VyYbp z;W&6U!h+3n1h7z9ox4JPZXs(7xXxI$+#kOV|;s}*#9`;{oa zC0kc;?GFn#7(WW4!PVTLtC|rzSzVmvUhC|zC$BA~ahvwBRv(P??|FZEIA3+Q z;Ya@=Ju?oSkZL8oXYDdbvb@&8M^+rB+a$RiM{1b z&kk4Vqt)Le4&J=qVTX>Nf)h=60OX+(S-#l$d|vor?aQFAd1hZ9k1Xe`Xi5ns~n;qk5xTTlpp_d=kmuQa3oUblL# z{&SMZU~TZY23KH}R6A3*u4ZBfWspP6T_&Yu9)U^<*R8{K4G>~KlaGdNVzHs| zIQPDFmQf#iEuJC)N|yG(_qxTQNN4YOS9xM#pzf_~A#IgO!~2f?aDquBHlfg#_OH{l)8-fRXLuX@`F zu_hzh^`hx73==F606g6woLB#f<8X47PK-O;Bwpxs=m^0)KHNC=)|x@-gush-{Xqg; zc`d4fIC5W8_vuQP4-h*xsP|V>AG8K{DvQzKHZ*ypPwuTZ9WvU*_9hw^OVSSMQY1)anc5Z|Z;0mo4!wEx%&-R}`?FE@xV>+6uu*4$SdC>Lt4n#X0QC=< z{KL!aK#Wnfi(fX^k&e)qNMek@!m}$g^4zgkmUmkR0 zV3Nv6geXCd^7-`>wuC!)JeH=kfgbNlh(+^FZB3B>wVU!Czj<*@iZWrcVg&rmdct2( zCLe&SN<<47jqP})cPC$0VvcE_n8GwoRbxz*4NYk7%NA_htVKgfyx1t_k4BXvQGZ)a zm7ZNDFyBRn(ma@s4tqp#=iW>llbICz+mpu3>F8vOHL(0UH5T>+>;k|$={J-ZLY;MU&nvCcA6F74wZfEKV((z_z(r6TVIO$w&)k!Z7B+j-oQ?FU2< zI!3?%VPF;c>ph~$2itr?Ez%O9G;Q1ZW!X?{nI$IO$3gec-ur>)w{kk-%-r>37OW{H z=5^UDx)^Ss;`+l@Y#;2eH+DV4$6CL8I`ci_%?L|fDT!w( z3AhDlvIY4lgXwDmT(|}NlO3s#-qnPlE{Aq`UWX#xY zaHsPrWrg~!I&XP0|7Yv-Lyr0PwS2vpfdgZS@MIbUkcN!}MnH$fuym~za(=`_E_LXNqlh?Tylt(+=l!6&PFk)L zLH6C=*3VDzKsqG6)wHSuhNgP2a6YTF2e)bAyBx0{K9VeQF9 zOy%!c&Qd2h1JMc)?@Gy*+s{C3$QKL5aHVJahzyrAz8S-jegU)~=I|CYn< zGuHyfNJPhBVC#1K%ra^XW`!h?z7UT5Ff>_fQKDbI{Is{%CrY2j7w-d8Q!;tIcnry@QA3DX-l-M7Sw$WF1aq#ds5YB0K8qBB|=z z>T45)qXnZVtpGG88h!3JDKZ*@!!0%(UisY(y`uUUfd}yZLs5sU^Zw~&hwOf@d>4Y&Z$Mm^!tc=e-(lOo9kzczhM(fEoJI(o26J9QZKu(er!j6p!PlYQ z?x&>qywilz-`4IA6W^RZ-iF;6f%y=BCqI1nNDv{bDgDC~k(nlTUHZsS(=Waw_Ex+* zj`8^6UcjF@yH&=o3pm(qBE1Z$SpQMG?&s%`K!|STe>pbevrh%yaq)46MA!T>nEw8! zLvdFP(%V&?^-sQ3_W`ogz`&Fd8JlO%%dg;DpUPZ1Z1VS>Ry{!62K@3nmS0`0mLqrG z9PY7Oc+ZIc{JaJqpYtPsfPCo|e-9CJE>6zs0EpLxbgOyZd-6x)wQuF5?>YfygQ;wR zd)%E(rjSFjPgPFzK9Wm4Z!8V{G!^{89d02oM-f zD=LUCl!^K;k1_42VzLhV_xJkDh9-zXI$&=E%?^rU<-9d02-rxb30oqWVw*qf=1RG} z<2~J994b(JIF+n`&Q&eZh@(9orCHbXOs@OG^R<;z-2Fn_>Dt(I{rgmmc7Zn&ojreu zwOd#8;(gKiXYLfM6P>?&j2f`(@A#hl;xdiX1#i}Mx7dh;YhQP=uv)mK-OTRNgTk=8(obe7{tfp8KeF3~ zJ@Ll93*7cU{v0C(FA4pp@#k`xH{P0w^M~j6AKKqLaiB##2IpK^3;sR1g)z{Eu0{FF z(-77IJSSty&Cd7+3qoMG2gX!^5VG<+5bpVvYj2bnmLmne(sSQ@eb}lWv+6Hj6kE2h z%bEBtOr9kLQk+GuL|lw3O&q$&O5@k7A^U7FIVt$b{m8;%Gi{f--7$|;MW!$v9#8IO ztXvUvw>n`~CSgNu9?0U%RUTrpC1`mpt`UNzbkT(HU$eD$m^Bh9eW&eFSB1nH0Z8vL zliC-FLiJCpX+3xDO}CqF)C-I$<~A^ozME|Gn;En4vr~jpQ_AiYm^|%!XI}c!J4DOd z?_)GLO~2?v!mVf28PfV{-iXoc&#U{hc8#Y-guyO;J)jenR?xAn9=9f zzO1>S%mu&hcOR{>Zqt{bT8ft8Mh+R?`yLN2p@W>;D=n1_((P~gNQjamh9SiVE5^gp zBG$%bvhxkJeeqn#loo#JWU1%WE>Yt#be6%-rYJwGTq}`JL*9P}i7LwJN0!%9jP?sB zl@CxXwi!h+4cpy!o0a%7|K9ux)y}MWVb@#__!Oy6vOZd{W8D|mYU9QPff#?zn*jpp_i>Tol=*OK)^`!WY(&(@p9^0Rr}B_qUp|#_q_S2cUh+ts!kLQRPg06i zco0SwuW?(^N&|#9!CX>xn6Z&oa6h%=k^IoLw%^zs?eq-D`Wrq`OOcpO3dxXjZgK^1 z6bjdR*VUVar}NQS&@f4zx;0(8JeF_dG+mQlD&j-K zr>k%<)kXfHLJOr6zvML(ZX(LJJw+)>->gEqXH2G*7Vcq!Tq|`50dHE>GYEhpk(_b$OdJi_?Cx*PU*<*F&>jkD7$kHPC?kspiYi zoqE1Xp6O_BfUWyXP|)W|Ryc1Z!|xV?!{bdk2YDICVLn7p2R>S-an5Jt`N+dRm3W|W zUtlE3_tyP3l-)G9U&(0m16G4{6RYX&*D1nYa`Pstd*%58&b5JVrYLKAO$m&mOT)1U zI$XZLujWDkCy<~A`hL{rmGa$isgL|@mx0i9DSFjv{sK{2 z&mJh8-nLKrCi8{CM{6p1Z@6e7)UB;8mSu5i7KV{fEx}s{^k%alM_156?U76u=F+7u znJdGhO9H7iV=iqblpE7sb1!;jn(w7}tYQ?8%7gRqN0I!q%G&BgvCKyG`R7}>#f?hX?fPV@{AxOFYDSjtu3$#+C1s^m)E zT)MVxx*9B!D;9x=Lhom>&#hm1XzVkl_A;QM>jT$OI+?^?!)NWngt6^^T~p+^FVC== zHI`DXk&y=@kt-2YUFHZLUNkt9e}^B(G|)P;$|pH)H4D*;6Vz4a+^%}~Qm_Oj`Ih?1 z)#b+beH)Jm7vgxYYYOULgN;#lF3ta3+#kzU7IE+na+1*yZs~McCS~e+ zwVEJnV*SjozWqlZkV+}^PD_kIUQL8=M8<~QjpAtn8=T~qPg zTfzhSyF7a z8+ly&@1I2vum+JFTq$uJI-As5aJB}2e7}9)aHlx!bdok+?9R_VMs{ocg%(XJG0eFO zo6GLvzahp@i;pr6;IoWUZ?-bS=t&g^aD{>i#B&0Yi6r$g`UL5!0Gc8rY{;eTvQsL4 zJ4;zEV@lWrWu!h8;~Et;DM`*;L)yv;byik-nj(5QMM0gq;>n(n1;UY^Ip$G(tqCH6-?myF}-t2t;rhQHm*A z#T-zFZeSQI06}gp#^_IW5UHSoV(0RVJ|;xKAPc6C^PGlV7|L3NrKK;s@{hU7P?O&- z%GL48dwDX{EM8$2K+#9j;)noxP-J*R6p0ldXIMRjF1GC1f?AM$N0vSf$RvtDy=J#Z;-fMo>+F6i+L; z;`=xjcr@*KbqX|jLp60CR9z3>R7usmy!_WjK1&>fb!)2hLwMaWM7cu~u;8FPb+kc$ z6?S%0ZqV6@5BGu1D~w3k^IK8st`7WRDR zXW(1>)k2v5Tf$!?D5E4rAr_fmEKB%osJ~#2HEdo~+xC7jhC#%XHG~P(l3E(P@qBg% ze0OSGa@dIS2)ryC-jEjRfaG^X5*?|xuF@`wWtU4!PDuWWWmwNJWGk=cbz~RTk~NN8 zWG6v=R2B%lAE4++0Nt;^IB1B}@+jF-c){-}TQjY$DebJ=ZpiOt_}ZkHrj}{|=vgWL+CCM{kikTz243kcb3wK%odM zUY4Y%Qd<9q)2g~0yE(vzaGYnZy6_EWN1|@QY5(tWeFmHU>tUEt%=BBpmj(5F2 zHUnUbiidefIt|u|Q|1V3Df}TKflryuo|@3h9BqP}yvH$6u!%@(3V}8^5Acs{=dQka z8Y_H%#FWqEW5j(ZC&44H9U_hcJE?!85PsY4sa-@JEjBImRF*XOB37^Dth_2yU*%F{ zFdTSt+bNa9ZC~<6cL1~*iI;2Xmq^{wnDxqA`Iffl5&23$kY2Mq;)(y9$NrzOzFz}E zR_j>|2?PHSgRW5d^ZwHvLTa6Mg{4N{ptidIbYazWXs6|+9q!9FBW6%UR~+_F9ujXTbGFQr8z0npO>Y=5~t zI^^0)-B0yT4wIt0Y)iWtW3x!&wLQ_d4`Sw=5c4|wU)X%|UbzXP2Zr>^Cmy(~^m$A$ zLe+}E&asVpD?T4(JikM|PLIScH7U8vM7*7+h|U!HE2(%@QELT>l~2}Ka`G_<+}(DK z5v>+aLk`Y%3K>9oL>hMued>rD#(S*?8qv)F5H&Qpq9!l?7!doDAtq@Pfl}VlY>X0L zTj)m~EQzlj?KW#1iYq&SQ56M;!f_~X;P(lVO|*|QaCQtfNe%^AoS{lP8jb%N;$Xs( zXPhT2(C=enA2+TaRzQk$#hn_lz%(l-UlxO7MhMGQlT*kQ`iNF>s4}l+W3G6$wop2j znKY+$!GEw}8rSXP`<_XIqtWOoE`n+V^yh}V-<}A+d=&4#*g4CcmMOmou(x`2l%V@= zXh-2Rl!65paW5EpR8tE2OQwp|7o8H1mR{)p>9kO|&Q%9YgTGS@ zzp&^?eWOz3BkBCqoV|I!@=j={0$uI!$y9H#?39=*OKJb6rXR*^L1n|m6CWrq(~1D#10@i>7_)Hq)<}Q zg>4#p5bjn<`G;bana_k^tvBK!;?X1x8SJ5mTeNHEA`it6sk9}*mU8;vpSp-d^7F_A zj=Zbad4#`1)x04hMg20<_tsxX$lI2!A4sb`o%H~Ao+>^L)d+P!xgt}!{1Yw!3?8DZ_x>(hG?Tp zl#uA6i)c}zBx*({QHBtmAv%c?Lb>$%tc{PM2#{t0_#ueJC0 z+~@H*s;{q#@eHZUOLg;Zg>Q%+-F%*_)BX5{j)UQNy{1Flt?piZD(kzIP`NFzfNX^D zyv|Ukg{;pZ9bbb~g^PK?!HAVvp1O2J^LsTBU*Rfh^`{FacfCD#Bz52SkdGg%Bukq< zcact7k{;?&)a~Y*QI#z_329(e(h;zF|4XebLSRW?%*DuFo>SZM7u$roax6sr0ijF0 zX;HH4r=xJ=W2Kyt{W|_f>I$iImXIXtQW7ySsD;}xcU*mV0-Rqr0(s5TAnNQv(%DR! z%(7mNY_+-)otiMC4@|Shkj3tyj^A5-X_caGqUvVHQVwoAllm~(eLB=+%w$#>nHd)z zt=ahGr!=d~hg6y$Hl{I;S7m|%ryJPZ>{axi`h0lWde$n=R1dIHO6EM*$*%kR0edsM zV>`z}tJQLv}kxzJ|AL$>SX-Ud7SvRVzL5i%v;<1DXJ1zGp z%~=jet*2+S;oUQr_v*?9?2bW~g@9k` z&3A{o5`ucff;-4%p&p_0=5BwICK@qg-BMm%f*44mGI4V-F7wxk{qIv>V>Kav_3Kao zIu_vO$+X+&|A;Z1i7ra*f)HqPl zZj(`nXt7qG^$E$^nwp@yjHo-L(Sknd%Vvhd(o+f&Wt6w{)h(4Z3=nyvO|ymKn)}=9 z(M(l<^r?>0vu^PR;rxyf8Ph5ANq$``xg-Ad2gR zZYAGtry*784v25B{FDc*yi~gRddvODh@tR{J3a90aMjN=!Gq_Q4@X-+?M2)qdPQ5U zyuX8*=9l^&?bQ%$YaeMSyGICYsp4CMypYq4!D+d_`|2+>h!RZi?j^OGLeGTj=!mQ5 z^;56zUZojlN#FO5v9t(Vfc@m-#dig^{FXlVTcQuZqR)a#lIlwh1onCxs=Xw#lQa}q z)%Y-K9&bKcnSrmKUR5$uZSHf(_enV_i}Y-a6~$e(k>eIrDe)hsf8bno5q{g7vC0B70{t zr;7AST8^EFnoi8#fAO4HRf!J8;x^H{u*-vMpZ9lMOnqDjp7srV2v>{wyZ!lM={oM{ zDG}>Ylb-3?HH~;g_z|dFcWQ%Id_*wZ4JA6IPBvilGYIC87H!ah_JvaO@tpt6SB;_K z(oBuT+4a7l6%P$+tl`p3;!xqqOdm;%vjgswC{8` zpVH?a9WxCZC`u)UFCkWp<%aIyJ@Mm5hu7~F-*&V9Se{H+HF#?}Z#5C+VpQjT7-_)< z|F!d_%GIUis_FgXg*dN$>l=Ya9*Zr9C2igi!L*MRA%8D|Uq0iW4tusLk;mk}S7tvw zCKNR!Bi`4W#j8~`-z@3)Rq;2UR7eZ|CrTkDt2)0Md7EQZYNG84W8$L=G0(NWYk4rE zb#qc4S3aH=QX6fOb9%_Guy4?8v<4jt&gZxeXpf6%)ban6A>dP$0xDIxF4*4rCZo{%nB*uBO1J6@% zogYw7xUo!IK~0!XXBydvDO2X=(TCe_hLjbOKQp;a~A|HCK z<6Q2u=;k!sli|_8Zur$3d4G(KB zwC>JLHST)_AsMVXNu`^o?SS$ z>(6#gOoDPI5V4&N{-s z>;wMm_eZ%NC5F)qhCFiXubnEWV}@UB^2GMNzCfPaxELN#u7^A5!a3Lg#X zYUX2lVAjktWto!6$KpLlEimR8=@OIkxWc7`(OfojE##l8skii>|t+p$9FIQ`FmT&^Guj%zUuSnkml9WB!)-z@^x)uJZ{H3(Jgn<5QA{1{r}@X?g8T{Uch3RW zUu^%ap7DfDl{ZX19VAPbW%%s}D>Rvmy)etp7baujksUza4egm1sJxYk%q9GFDMs?e zTHH?&o**N?eq+55?qY!L$rFpeKLh8 zS{RTcKt6;ECm|Q88EDgwpPtoH-0@EGuM%f_jOb@+t4+8Wy~_IdfrI=(m}aQE5cfaX ztccjM1`;91huR8DYcr;jeER>{NF)$f5^*?9C5aU7rA|pF;-=&d2*{m;?2^`CNn=w| z1F^k=hM9Ma-=(Cz^<5XX8~m)I&i%Tfe*K1brj8YNII87jT`Y`g*cjYJ*Cn+fo;-L* zol}*5(6>aCeK1yu;Z!ClV=#Dxq(qTPozc^*x4qmE;5 zrENc;iIXPPgu)cIU{nNOG)@LlRHmipim9wVn@pH6<*_WjtL z&gXLUyNxJFxJAxsDSJRT^=nz9ScPsV6$ZpWv=hR{zP&SJB_*e^1qq-WQS2BjEKeH^ z@%M9QHM26C&B6&6ajGUuv)D7E$cD1MT~`-yTVt5bn+h1Im0u81;j^5bknrcsRD4{a zz%reY(CAbgwdZnwX!hIAR6};u{-b^di=TAGqF{a2WKRroCAU7FL8_lktD6Tp4tzVtf7mh zf+0%|!5~(GEr=?kgGA;qj5^1bL@a|?8F(1M#cD@(H=~Qb@i0m}#|{+a;X`H^LBe1Q zl2+(rr-$ERlBfYtD6nAsuaPNm@AAXRwQeqUas4~)g>U^+NJV8bk{<4*JfAe{fewnR z=%=^zlYZ{EYS6}ssjjiSG3(`I8%S1pNGsmbG|0>s`*$M-6(WL1p23N#Ng?su4<~;z z2FuoN2SwS&4_TDZX9U
  • Ln?mNonZ1WzQ9sDoK%7`4(*A3joey2cSCBbh~lhk}4C zPJj;2km+f<+6}u^*a!Br}wlxtjQyU;%4WoNXKvh4cy8Qn0`_V zL%ITc#-*(m|MamnB-jM(L?`#CM=bopHlA_oT3>>Ltj?!`$`~Ju74UO!RoU&^_f>Kp zetQ?&-SFTzjD=|#KJJ#O#Lkv3_HmVY!%2p%5P97TyQJ+BLHhb7<1L7|fwD3%6g3*A zzL0ahr0iw|ts=kMzw6ntakt_};`IFrcKvxfEDt7Z0w?Nw&mcDz4qzTa_tGxjkn|LA+%en!;iDQu zuJC4TrX#L`-sAD7@76GcOSke^?d2kYou45|4MG}5$$G-L%Wfn6i{8Z^r|n9+Kvo*+tL*z1=a@~t^yM}Tf zryq{RGIG-Zc!bbTO3*kG1OoQ3T=96&;xZM)oBEpp-+ZTk6%pbP^_T86df#47w&=^1#LG(MUc<@&Zxe zQ=mq1U0Ae!3AZ(t#rD4#6n=5|cD-9yB0vcjPzi_r2ZK7iYWY??ole||M;|wOj6WY2 z7;_)2d%I8wcDi*coLZxo<3SKA8F*Uz^*JR72t)`R+xA!}?s)wV2G!xdcV4&DPB03~ zur$Lq#uYP({Re~E>t$0W-_W^e#AHfENI;8V=;`kMko1Fuc>y8@#ZC)4yn6EF72AI? zs2^Sb7lR_5t~ovqi+FPY0eb)ZJ~R|1Vo)D!Ha>)P_y4%&6Wn_>OJYL8YJfA+Vxr5) zF!`4|nJh%ggBo-Y0lY{8r~gjRxs?3}gK9SB>H<@x;x(UN^Yi^*4C>dssvWKd0~O2( zW9AekBD!E^#xQ*y0;(2E$(C!^1tIe~j8s&-;X5v`Za@#BJ_GK7<0KrvQ70*Z1&dw) zcv|QyP6hFM*s=z3%rkml9s|dF;6o%86(d>&wZTcZ63d&XU6ic-|1hY(_x}fjdQ2a{ zqmtlv;#~Afg3j!I(#W1B5^&J+<|MdwK=|raN-~`*;w+T8Q=GY9 z0A>{tWpRFV5Woz7HVTHDy*H>5{W=$|%D}{BuFOWwjir|RyIqN|Y&^G*&$B2IB*WdQ zxSOg0#z0HHq}cYPD;D13D^K@tMO9<}RTSLYR`l-!L>MVLzdJy0giU3ZVYXCB-jw@9y zHprp(!1eUtWa69dun4f?SEA@SruI^|t{bJJ z>#b!8U;r|)Sab*AIvH30Rrigie;37@zc*JTE5$M7Ww{^>g5qI&z-E5FfQ)`DCWhH6 za!dZKvn*dPpoey~1GVZ0@p`%#R4xA=25@#wDdQqUn#TcI_H)(J?7s(}{u;OaMB6F= z7P0CmoZ45REa{1b7Z3cniRgLat(D ztN|>4>^?WoSf6Ug5{lc_4Fxg7Xps}k=BCO)Asq}{d;nI)RtJbcAzK%h!$@=olzzN1 zCylN}ok?-JCwb?S5|(~bVFr>yr7ZDJxxE2MFxTxb1(qzDB|>gR0FiBeMUzZh6{VX@ zYW&fjfdwkNY^5Hj6JSfG;jDc1SM52HkqbncTy&O$jv|=ZQPlFPb2EE~S~%hZoKC0$ zq&k3^EjY<)O{(0~xMEDXMc5ra0O<^fvu!(E0p)5pyOM8O7pJB^{w1Moto{~}h#DgjQ8nyp zL?TMUyym(f8k2vkFrmom(1L>-NnPE`(JhedaX(wpQBV0`qjL%p% z;uQ;-B~aTk>~P=Rf)5o&WNnWjN#@k`#MVssDKuR&;0qh74CLV|qXIF2#)w>k`N*wh z$=m^5B6Hb<3YjUO^0R-WwHOy3wf8H%)4gnBhCYw~4hlpokg0w9g6h?0l$Y^)hC77u z)~Ce-#ch$>%0FF(MK{oe zWJxzVLNgSNb+p@#{fzvM-A!G*&`iOdfo09wj{L%NttnIWQV@~n=cYA7qs5LrR#@+3 z`T2@dQTQ(=z&7c#$!2>)u@tR`h>zL)7`wkysqXq|@TJ*osDJ$?y|AJ%g)GE~UOFC} z`~Xx_azWPdY40m3Wtkin(PIm;$fa>bV0B^)n&L&rzdWKJwuPx>=>BLDFs^z5hvGWe zncMH?k}K%iFF-qie+IdW(_1)1vgbWcYL_uYM##&-*79rlFL06`XqEb;GvMaNnJ^Y;m}KS%TT;*&vmNM9Q?=W)#%y6X-r~=(Vr%w2T?TzZEfIK|)kN zS&3TI*ixW)TN=zO5-rHSQL46Jyk6MH4mI05^)!LbV>*Go9;I0y7Q!9_h zEC5XsQ>$oy?$GP2gZBddoP9O^n$3P{TEawrO%+ZKaQfbial`m3 zNt?4H&Oqu1o#NO_!xsQ>SL$ZHyu{xfLO1jD2N%N8tnpQHQu_&oT$`E^;hb3vh$Ap& zP#g>d{rKH`Jk)=2Zd?w6Vr@a%XH?9Gp|>RfMVi~b*RgadeT#jJ)LoSLi z4=MwQI2uIPK_`l4>gST3Q~|$yfAd)Sez~Ugt$_$7cx2#HYEIk#uu-%VL^K+mK;z7Z zSLp8#7d2B5*LEdz$Vh^20vHuC?FV2CSP-xi!`jc?j39JGd%$Bj`=jV3B?AQ>Yiug$ zpGN?wNa`k(>7g7aR-TAQ`AI|>6P`siQ%5^VMo*tn1(w}8Q4x>yjfLQ1^WMk$O;b;S z+48@I_ejQFzo{G2gz`U+hM;2h3aO+GIG*%@XeR*QF>1Y;h;Z%L{SRU(@Q5|Zpy_Tg z9#ydDB-$o}#T3nr#KyB7QEFm9r~(KvN{Pe){3)!$QKBXw5{WJiVXdHUo`lIV&{S-~ zoVMf!9>O%nwAW+iPL00JZRULvB{CySg^f>@iu`k3m;nzx9uqJ_|HqGNz8SM&ilgwt zHD7yvCLr_3HYwCO@!PY6*`|bSEngxY6+i=0(dOGfPh>|WE!HIsZpF~v29WqWL_A8l z;U4?8O(f%skFZyG!W#9(KvKE3weV~TTPKb(K=J?4Q5g1d*@SE5iOkLZ{DVo|W@#pZ ztaqQLS(IB2d`K&miLqvS{eLm2UuEu2WG<7bulvT+-2eO+gZjf@E}K3?e9odZ;I`>2 z1L>iE(y?S2eoPs@x1UgUg2RX^)PFIkpPeWo8AZf`r|q@4OFGZzwwI?K%Z)0}@Lm$c@R2ii%8UC@y1ck|;!x%j#Mb1Phk3EWhy9vMZ>pOTai(E04(j1pkm?703hH}9RIW~r9;iM=9$P>|InP~DVPKtT}(ThWj0{=M+ z&etHBmXQmbz_bAp5{BsI1U_)0O0i^MfV|28HF1aP%BupLTv1VxEAYA0f4h_!R8|v6 zQ+F%Vgc-3}gPa&cG!aoLR8=VvhQcC-TaYU?lt-A`o1IjL29(RFicvJG(CaNYnGzdT zaWkuQXRg@eqL|dR!skxe!&~?xuj&ar;)54?3YP3GfEXdtDmco+8ma?}v~?lWC;>oJ zaaPq~5MwpSJwV-DD4XplZ(Ob(|F9mCRr}brfc>(xdai<3ygDJ1YPW_+Fi})-l4XvO zw=5y1myo+CB&TfU5r%RWKz0!MDo%KSvkW~+SCvY=08sry`!?qv}h1?|1v z^mDKOh*V7-WGP5l;y`!tq|p)4)Vkf@_sMmS`F3KMHZqU_k*vYe-Lfn z%lh?ZlzL=+S$0cBYfII9%e%{#vZ1^h`PO>N*2dkIqkz_y*4Bz4s%;`jg`p@QIzdD^ zY7Ds#e0b}Y|8f4~Xi)2=7v(gL2yBtnACj%%KYnR#`%ck{7k+b_Al#xA^dVBJzW9== zbiQq;wOw1db?>r$FT3?{sC_&LIWR^ZV~O~NqCD|x9hUzD?0vi(Lzaz^r`u9Ycv0@t zbs!X4e^jEdv@L2cKY(lB8C=pH26nO>eXt}NLk7rxT*K>^&G9I3IX^)BDtrRXti?K`5T zS|s8|n2$slsW`B|qP{pFxTH7^{+$=qt3n-XK>p&8)B_L4;lc--@yfw{td#|!I)fj^ zsdl}Py=d|bEX4$dQh#sIgyb_q=yS8VF*Vk`Yj9xiR=QCRib-UUm7IfU9TAz990SDk z;d|PvYfH9dpHRI6?%DsmM*FvinGv)TxlIPShD@XzQ;M8rx$XJWv=s`i|@;0OUD%#DW18A1gTAS|3P%C70qw^Nwham%)G^@VY=FsfPHWCsqJ`(Wy`HyC6~n$Gqu zb0o{{?-a&xCOl*Y%vpK4MEv!;XAQc9LRjKDV3T8W&VT2wEqrxX9P?P1b=5^Rx6Kn( zqjS#LVYbhGA>G-JzeSIHU|skQA?PAt3R9DRIVL&bmDsd*Aq)MvAHvwuBSKL1`-_cj z2%`Q(G}nkx#7}QojZlE(5*22AV#g}0)@tE>+xPj$G&^I6RMf%|deK;plo1Wxvic73 z7?@pH^!l?%O8tXnvHsKxS;a}@#1P+s<@|)MkdS4+tmWPK0=V@&(|-{oA_=xUM)enk zWbRpZ7hDn<{kr#eg@1Y3GoXNilDuwgUX9{QSk|J-J3Llzjn8gPxxL`G0rEN}av#gg zw!C)ax?m`}K5%3Hacejj_ay2A~Y64CE7Kc1v z+Mvk7|3gDS7!rTNEST{SW>B@_FSKuc z>cFkOS1N9>E~^-s>%ZD9v)*|1?)&pWss&pLJb*l@*<&G=u?oTc(4*s``yF{ZP9FRI zgPTOGX&y(lXgz|nK8UiL-*`8@WxZc1n!b-kq~j2~`0YmIhS9tJ7d}5t^L~;kO}b}N z_5$Ri02Nqy1}e4(wmmEeKXfr)qTuLp$=s;6Mqc8#0mz)1#U?YyhLXrO+w&!-W~ym4 zc^zR42@9X2qdK_ju`DPy_&(?0QuOr^fE>u%=J{0OrMHpT{!31IjlqV-L@6a@yz zL;bVK6r#)x0YrcD=bt_n`#~M!0&#O<2|Emjr$iHm;bmKp+ zpqC_g?6O4+)knB2|M{zugJaE>qR)6$u2@H}R>?wRqLc^}WF7zzy-w|I-=%CV1`4p4v>K|NGC6;Py!Ws6@B*9)Ve1MBvXSxwcV>7PsWH<28gIc7&A2;cEy1++f45h8N^ z?mH1Imh!%e0=i9?sm^iyzIl;UgW2g$D&b!(1A0$Mx=alb4W=iPiD~8(3=P*Ysmwh45vMs zl513!VsU`G*%SP6EE6G*~eVyq@qf3k3=gbn{9>vn{ zy>3^YPg-G5Zii}3tZ*&e8|VyoEW66Z6^!JzM?0$Iz%trXW(vj+u&cbm1DdBZ@tSsA*= z0L*o`NaJahBYTk9(2Wuv_6~wAaTqRFVbfBb+T}|v6xE~t+Lsduz{lP2WgNLtoET-f z*DsA;Mj%H=Uz6P8l2f^+>lOVfqwTmKp=uj@tHqId6t^IIV|$bzjAN_Ak;qdDR0XRh zCkF+T* zmBlmFLe1dKaj7}^jPUy<$FF+%J?BOV8NCs|f zo8j=O^jU4LC)UTr;<$nD1V?gXsg`Dp{q+h7B+E-rNc?l`9>2o#X2_ z65~i=wPP~fGTrOp-%z>WZfno{7w_izLEifK_4LOzdSXPk)%q;ORBk`YGkCpK;?LA{ z`#VET>Ap(zMzl{$buNb$?FX&wB}n#m&?HR5jaKcedeaw|-Pt=Yze|`nJdX<8uf8K~ z6{K0yND&=(OLH7S)1}v$`7Oh^`r5MkJDE42yc=)%gjVf#q)Qt^ZqF-NcF{f^qzOJ} zZTp&~$v~Ugb!^!$C_vDvMSjUpdi_u+%pry71c5u-;uH9Yb1LFTLcWCu>7JSQ9q+Nv zhFs#*Oy8syL(dM!q?4aoIu4&n3K`|5}paZNzY4G2DnX`@-nLSQUGpYWuZ> zJi{+a#7bS4mk=kid#vnLrHstMCiK!UHRN4uIxe$J8PA{?zP{n>#?>)hq zjKkmhS>%YZpO_YZObMC^XE+kz+O5A*5|3{DBC-sjH(+>0>X6pdlxTlvW~<$@igvt( z-Q~{J3!=~~U)QI!-wMWyI#oUkbR^w)y8w%?z45It!`Qc+;o-hxAM`8IF^noRJ6J%e8nN!TT*oXLUCb7+_Hst z3`;s9-#*Qo=Ro_-%Qp}7?bl1n=3!yj#TZ%SQ4g!pHkc7T(2^YI?_i$H_gt2bVt&Q! zk=4Sq+QoFYXpL(mH`}@p7?Of(d~T_@@TE_>Ac)_mIp~4el>w>n5~ysEsMcx-l(kK~ zn`o$HJrra3c#z_q&?RYQbc*l2akl(@T9$@2IRDw_>d=7R_K?7ySjPTNk8{I@2-@%e z#47oc9I~Vcm&K1CweAMRPy`YL#v|?f)p_{LdkxrwQ@rsVQfM(@nB}U!uxFIo_2ezUH7S zRzSQ{R9EX`&Us!YgUM0+0-?#{Y zwWoe}vh7y9tdL0WRAtxpHte=QtubAX$r{v*wTiE(*Q!=S@;iojcS{|DWbkqRC=wjG z`ZGx!5voz6xM2^~5QtZrdRcy-hmPaf$ALLgTiN)B=r9sY*h5<~Un4DlI)Dnm1{8(y zWcCNe_XkyJ-GHV%hLade$vm#dNW`nAXQ+bq)L<+cSvX>EXT*SObfzSNy$s}21|qQA zlD(+cj^B$RiG{j%kd_nQ!x7=oBW+x2g$yFaV=Ph_ax<)mTGSTHG(e|`NE7kGvU=Un zj_-=Rk`aHCYQh=QjmN5>uqrc@X#$_$d`$eg1VFXJD8Nu^9IQ0*GX)qz%NVJGk9f-( zsa+FOLpM~*GgK!v^j=-Zb1c#aGt}ri^nqu{{G7C@XsAU*M;Hz;)(o{34Lz(OZHEqb zC=3a}u}mo4`krVz+2LNt;XYO!Uo=U7>hPd%%x$ljmQ==40rIplUCcu7%V!pzPPSP!>%1p1iy~PtiSU z1E}7ZO%p`req4mnKoqN}%PaL>^X_g`QV|c;J_=Ce%&>C?1YZC`)P}Ew4MTZQL;$Fc zMLDBB&L#uS$#9N_RW$m)mywyc#rWBJfK(<|3cDLAaqve`>G zI584Bi-OzXWSy}p7#Qn}7RUf%PYv8yzb7{G1w0#Lf*T;1Rgp2hB~ya~h*$+FIF=T; zmw6t=d#;S2{rbT2E2lA;Q_{l)DA&SRdFV46rLetsK%N7RxMw>Ak=K~s&Z<>fYjDZX@;EnCa-jMEUCM*#oP=QjE-Civ{+j0 zMi}S%8c0;q&u(Jr)f@{Mt;{tZ2%3jb>PceW7;5K1&B~40oB@lb_1P`w7~Lj$IbSJ~ z<2kEU)2ywWc;k3_)_Fz9_s>xgx6ltdL%2;C?{v5I*c2f{ok_|Z?nnQfFZioS4;oVTb57a;yq_iaQDZ35iY}QBk>7->i_YPlcuvSY}4RaO^BumDQ$M z6bcJk(BoVz7WiA<(j-mkiHiC#Zj$-z0mD7(`Y@}3Q`0TRvE0)K8oMyVF_m$vjuk9X z5n4E;|IvD*Z@R7f&YN#6hV$AAMPBD+o2!do)1q8$$*)FijQkoO{(VI_wRALE=y*8) z?0R&9@Q>7GN!I6EqyDC(c8M)*Cqw~r`Xo8%=*vNH)?9lctz%KjJHa&%|oQ4 zLG&v{nW@|!@3fgM>E1MaG($}o;m4^ROBm({oJ3m2Y!wAFWNfCPn_KO*Oo&<%7oBu8 z`j0|K%J>xtS#i>C5s6-|S&6KzU6udWL!9JiFPOcyB=d0w3p1`Qb-{FH>-X1fXRxF` zRV!kB4oadQ9CU5C_Uu%%qU{If)s^D?IwBY5?1Y_Gs--nqNg0&$?6U`BScBKOHRD5Z zB%_rNElF2le9PgH_STd$7N1E)5F2+*5?pb@=v0<_!E0!Ld+qjK&j$}V_G0d9+bfnh z_2OZ=xH1QsR*SYz3Yu$*4A=k+n8$hLwo>2OdVZIoot;d)Wrm!;z7^)i`W9-7G;u8z zhyet!LI0c*t(Ma+UO;&ISZmLycxd3C`_A=NhA+Ua!$jN=d#Q?ewH=qzMH z|Adi5R*CzD4C1TZ8cu)ATxu(^efvRZ+-dK+mC1VAfl}r+(iUyb9{n(DfVBDR_I*94 z)OI^Y-G^xh>vyvEQBgO>Mo03 zmbQD`=TevG%BQgtQ{q^#!SMt|GEgzt!t2PV!^M&sM>L@P;Jaz)$Xoaa?)vKYLtp*l zz4gvx1FyeJnzc2vE4iL4utl@|&II8s5Z!AXmuP1^5c+5^H0~Gj@!dSv`cS8l15y*L z3(&VQ^SMS~#e$Go5*O4F>7TKi3WQT)BR)~veHM1RJ+&L$zI2EA(SfktH$F$S$d5(b zyXWYr(|gfQP1Qd|#g4!~kJx{naR2=E@8GxU&(pkWbK9SnEu`j*KNq&eE}TB@CWSw?D)U#@R^c*5rGM7qO1y;;D3b!@7kX4uc(g6SLV!!c=afA*L0B{5J6cw$3`9aa8Bn+K>i*6Q7SJ9y0mH z&)^c{@C%V4^(F;rBi1EeYR zGuZdN58O>RXlx{W#ag`1&Zfth5|)cj%#^S@{0 z-;W}H><+X4xe7u04Mc`7JT-BQb1@*rQk|m++x`W61wS2z&%A|3VJ5cIx%^hI8L#1~ zdGoxqzHW4I6j8?~(-$;B$M=9i^WoDF+0YCNN>K;^<9}81#?x>#|8t zYwpI0`jg3a04#^6THk*K@l%WQomD+T5)l*x&q~pkwLnzVO66r-DZPk4nPk}n*Ehc# zNl&oGm%aFCNvdekd1n) ze@XBr#JCC=j~hSbD9Wz98-%;*+Y1W@mHjY~3>olDV4Yj4)AHuw{`c%==-hJ;4hC!} zK1%wbN2(23Xj%CdRj7JtXlMV$o6_Sw*mi1-(`!%P&8I#l*!|-l7rrq8R(XFjwf;fD zvCqNKoS{h%&aTM+Vo--%J+b5jGF^CdFXldqMCjGl(W=%9P7X@7o5wt#Q{ftU^(A_| z!x`WyI80BF|9t@x33g5XKhUgoc zKM^)dvf^z)xJ|8A0|;omUfC~^2Wgn7E)CkH$WM`XU}vrCBBHi2_bbWA1kUrz2oYh= zO;Z2(iGOcI4XIKh-VM++Ca|=>-ILpPYI%eN)fPUj2Au29L#&&Id%$!@o?uleqv#Oa9h`Imj@&PVDu{+5ya+w{QhZbv^-_>BCS0iE zWc-a#-?8t&X5lD%gU!28%5d6J;$8y<%O|Ip6Bs)qa%#Bgw**y$ofQLX}oFUUE! zZelI!f#S42Qi>AdG(lVNz4L`&S;322LgmF-fjgYZIW0n!Z(A;QN+UVJ!fzYqvdV!H zZq!SfNi{cgO|%&Rj<^u7HqBAqnRXEE7Xe1mH`+|%_q2@*4nD`hP z3CE+mDJi_rodokG`SJA1XH4$PgZI6l@L+vmOF@C@K~AoW6y-^S_hLT#DOD1>M+ZHA zMn2m*o(}uYDSB?!QUZCdS+u?bHs!6H=zr)p%v5APe1t(pf&=SiKo3jPxX9?#9S&#Oth`-;Nik z>0Em!yhgKLn0;yRxuvv6E>iYLZOEp5NNVOo31M|us$!n~{z3H{w~yNvT6aS>CZCQ- z%+jCUk6)hi6q6kQquwJOIF;^xJz06FKy$GBTs?u_$vwU8l2F0VlQn@+nfUzaxK!EG zDxTQ;L=x8_LCP`-3Osg$@6|tTi!`GY3M0M+9b9WzBtyHwm-E%lV0C?t4s;vaO91t~ z7B4ak-3fdM0bYW_0ufQP>e?i6_GFBJiW*fB*U$D69IGrKDB!q^!7x%&=Q&BP03`B> z8C_vjIIF*2P`3^+jOU6=?bGG5DtBxfY@;R!*J-0_&qyN3jE-|~(4VC1Nz{#uNZ7uP z{~9a+1V2!Hc+)qQG2yosC{rQ!_Yp66Ysg5&rVhf^v~*#?ETD%pG7Ep7$Te~Plzl7 zuj>w%UckNkK!L(t8scF(mZyu%`S4N1oS;E+-EjulHVlnT?u`~bDhS}&!tm@2GQW5g z-%-D+JxHeTio1xTr$$4`tm3vpI0e5%E+6alCx+u1o=8L69t^OfbD#V)WaImy(?v4E z0$Ni+8N#ni;$;*wV@pg8xD2ff^tiGU!~^-^*uU_A`$x@RD-g?geVsc)rE(CgwI83E zHxaVJsDnUF7H-`2CXKJZUf0i1xwbxMLb6_;DZj95L?kzYujp&kZ)`TP+mi?lJ7h>9 z%k=o?b3TtA*S*YsA!+8_H5zCTH8wfyq+d%}bnIB3b;*01O*O&BY?aBmp~~8lJT+A6 z4gLG#eN*M2p^X`CR>X~I1?rXgA<)fgM2F@3g2NNAjp({_9iyb;bfqZA$mC zfz^`J`upE3yjZ|cQdyOcs=U=LbjOMoMW$^H#Vd~`DUi{0oB(L6gR$zBRo@idr$yw7 z4M;&X>JY;CVXGnx$+J*H$-_eEwT-2zh$+aXV6XazyLrj)rA3jcAsbE z9^S>Fu&kUH5u_U570o*JwKthYdbd9del>LK$4A8FD%}-&#g=UNizhlJafqCU6K*OD ztwxJSGJ(bSDpzE=+^h-cYQ+7-u_Xjo4V^<=ORh^ET5;CnZOy18TdO0Xd(%bD64W=(xxE2PW zbEKjN;iXLS+%N7>9Bv=V-ks{2S5c)wC)!n8pAjb*9poqG2?lV>wdYt2pW1xzi0@A| zQ$3~3FU5|pZq4ijeo0fol}L&|RgHbWcKd4UBWOoz>Q|pWed_ufLVH-IFvL>1NkQ>{ zh`Q^jCjb9`{3~FXo!D%G#smDu(U$q9+f!N9UZh-hqr~0eW zx98h$@zgzUVPrV(cZ%b7$%wqAowoK|s0ex+EJ=)3TP$FBL`Jqd0$&1NI|VYyv2^*Z z-9i%nHH|xz;zZDd)c7t-vzO}ZEW z!F)l*VwPYr&adc4JW^u3QZIR=Ro#TEd1Op@(FW=O36S=2rwmq8$gD)ZxLDj3)`DJt zJ~eJA>Z0V^0pj7RbD0tAX8!C)$OLNBZji7K7xAK_n#z-)8WtY>0gusNH`H5QwG^T{q|C35AQPRo>Sd-G zr4Aqhjb1);AH|ETYTlTghiV$@KH5;ib|^jSfkeb0E*I6fUl~bgaxL0)9jIg<-A%-1xTuo~m5xKuHToY~(s?)~Pg_S$W(@?w|3(*k zIKO$y2J^>7XI5R8N8=&2U||Ll_^zafo9eRL6>xR@3L4~M)aTs%gh&xuss-cJLbbz~ zHGL{InbcqH9!#h31jafg&H3J6grJm&UlxBs#g zP0&_KtK5eZ8FEr2tH2`o zB0UPOu6zN{icmD4<)jAS36VPJIpd-RyBw73=Smc=Jfhl4?fBbMI>Fcno^;F8_ocdI zMl~P(PQ?{>aq6iv9Fd|JA?k0^@92$j-s_kR=D{eBYR1T|rW|>)o_VgTW7PU^#223F z{<<7Qq6HoMi|kiN_lq7B3?-ilo>G>-%;9y%RcKXe3A8TbQ(i~8Zk2U!Gpv1+(bjw6 zDAayOD0SQmtOSu+?MSPJ6|$BU`kO>aL9U&ub3(5Fo7%S9?38itxShgY{Gg)PZdvO9 zFM_qdBUV0cygT4Le#QwY%cFyW1cmrycOd7#9|jU>>S32)6z|c%C)MZV1_DF?KxV*VhbUzhXlc4?X<2l6 zS+ssbbme!|%BAS)nJ5aQxyn?%wp_)9?BGHET$A%(9Z2}9Q@vqQy}{FgG85a969Yp4 ze3m2}4@xuDy?RLpgo>-)DfqeJDAI^A)U5PxKw;QC0W^J`-(5wuibaJ%i@4Ld z-Rc{+0~?0|MxX%DucR*k_`OjLG8L`xt0Dpz98xHL*702cz-2m1BsUT~mm8^1xYH$D zO0Km3$!tXRiq=!mio8(+WMf`!N(K;zS1OHHujU>b$pB|1PlIQOy((dgfirT6YvwOL5Px^d*`>&Clb==ODyRp%w({ zUo;L1ytd#U7Fowu<3X9|^+g7bo+#x z;QUiYN--&4(wa8u9Dj3{n=L4Heta?lV}q!N$^W=RRi^c(wm*bbRUIs#&>8G?#11Kf`vWv%`YrQIZsonf?)kj>aVOYW3i-B zWjibYC}CeHhJ5G!s4A2vSn6q)>MBmu;f~lsT`|!6Q+5#5pTleYb_fa5h^l2LW1|RX zZ@mbGxTtB>k7K;_)zpHQPAT{LT=t<*%P)}jBe;V<5QQXbl0wC;gKkJ*)j>{Y)@^ThtrRiPF8&M#ww(%Y}s6O__-!lU&< zehf(nIvroD`XVKdm!3J&@7sSr9YQJ&>fvO&`qR*>9j#RSs^6r|C{FZN!D8=0@@yx1 zs1M55Kj<=p*rI%GrDZR5XjBxy0t}u0`S-2t-y2SOnW=qA#$BHwuVFU{&iNh1x+Ffq z^PXkiL|FzbAfv@}^MgUnu@&#WoaFpQ$7u7mz9My>EzlYh~g>;t&UgB z*mJc%ak#k)Kg3fzJ!=?|;b09>zA5d0fn#i~$$X?GoTMoW^EI_OHZ7F%9{i%1hZ9SZ z%lUa<&%UAG|GMcVIN_53WRLuPb zZX&TQrb5~sBw_TS^sM0l_)lJcs(chks`V(G=iwbSp-BO{4`LX#5WHw>fXzNZp61(w z@}P%W_@_*=zCHV)Pi2%11A7d<>UMR?#AymUfbZS2$E9xJq?^vKu)P3H`pb$w6NS|m zdr$AKc~Ge<@pbYubYhhK9&kyAmmmH@N6ROH!~%kC1sb2;C3)QK-Bdj`6k(B18Ei~> zeE4>L#1SGbgPl$La|JDL_3IVCSL#Y~14+(q@WzI^rGy3uN@)_olD2dLxBptSoHC!> zzWeZ_Cb3f{uLEtQrDEHZ5nPu|(P#%GQ+(ecRNIjIOHy2z;{nEX@~4*EEJ%P4tmq&g z_UB{G<=;a8zqV;$(WDO913dlbuwwbYI^<1Jdl@rT-jjP;imByYcM~;b zpJyX*A0QnM^8VSkmUhJSK8xTA@f!S4`RkM>9WNT!QBF}1`s+iG@{b6Eo*R~0!dRSi z>xXNs?+W*uC{y{h^EyQ(ls|4LCGI;rWjGx-v#MBvMJGw2@}WLj{a(e79-rn1Xy<_? zS_9O-i{H?AoNl<&{Ml652ru&fgZv&|t?N`KBh1nDjHE+jHv92E^sEB4zTNCv{y5R= zEU(d0IZv?T?$K+*!dG8jw>7eDhLBwmYNDPvY4^aM!hbOG^G4y+*V0`|>YYMYU{WZa zO6ol8n#cgxKfJ|T_gcIQ7=K?Qs^^bf-pXU9U1!xOE$JkXphBl2d*SGQedk^NF0LEj zF>xi|e#@|*PSm)EWo!@&on==$`1?9!_Fi%!E({(XDIVSK)&8O=(zQV=lQD(C!KK9^Q+bf zVqoB3x0Zi=ec?(ftec5vGpWwAe|$#1`YWKd1m0hPS@>;X!5ytARHZu2jVLuNc+vQR zYfMXy9gNO$>`)d64t7p?sJyj*){BRzMRiI#;{=Vg6wR8GsxQ=4E=XQfC-sGF8{WQ_u=nHl?{}#Zr*8&;OVe$@($S zT(W}8i!iBllB^pK{q3p^OCa^sl!2~Sr=-?B&lNK~+T$pG48Qr9ao4m^_8upsvzYL@ zQ1{OAIW%ZfA_TPVCmeGnKl%Mj^SHAeNGj_tH2hfoAJ9~7SpMuzNv|}zGt+LZ!%rA> z*P-R%;k>U`fah3i=r<}rOJmUl{z7jcC*-YNbHvl|nB<+SJaRN1tj2C%#r#&kJ}<2E zp^S7#W16{Jp1u5ipBWnPA4cb6S+5R}b}5<404Mo7}> zP4yC4*yP=XZM1kG%AxkLk-nh%hNFbb^u}0YigCz;M-8h*G&)T!+@AvOX!wETjM=A~ zCamzL9|19|t}uLomYz~Sy7`;xZJocB*}l_<2nisZ?n~RG^@LX^&A#0iab!kEt<=zV zXIz0_j(O4xw`$sNoTY$L^hew|DLa-m0E8wM;tK2!dZNy}dUL(f()lwC)dyqpdlh8N z0dW0Rq#(`PA*uQW_Yz}6wpV+7yyeWLafKn(iaJb266s{w-W^301}7a1&IL?%=r24w znjPQreDi?hP3Hby0y?-pwjhJ7Pp~l+5w>IoMX|YG7UP4vrEx~8TFtt7K353SbA3B* zj~xGTjY$I|iiLMQQ3c!^FTC@FbeN3wWbfzRKjJnwzb<~UJLVjJU$5(TLh^n&L$pY6 zQTQe7IiuPCDMop(%W{Jg-c`+|LiEf^L#Ge7SUnSpqUrS!VPBJPm-WZw`LkWT7;|rI zrCVtwb{oHr_$RwjV4E#{2 z?b+2%XbHRrx(3i^ddBr=#Eib~{h$u7+dlW~Z1VFTtiCSijM$Pvv-9g)XYQTu^Prx#(xU^WsmreJ=;g-&zXbYi{JG}a5 z##1}4wp))tUiyZ-(sEqISx`B@q_}kzt|*RG0cB)$|A#?k8{HAh$Q};ak}hH~_A<%H znR>q^TbFI@=bw=)c`JsJ35&bK*Tu=G&?nz{wM*Nj0fvqeS#~C628X(Nw;2Q#hvPGz zFm)B|8hxSV56+0NE6allRcH*PMUr8$$dl_C7;^6dDv3=31+WW9Wo;UeK<}`*k)UhO zL&GXU1ecxC%7>YOgD0^RP;(Fkc|h9p>i4feq3X=bhh*Z-S91=TVqK2`i_DH=lz8%M z4HC|7;%N_!v%LQGn@M(-#Y}v3(ArMQ2#O$slDN_JE^H?Ren%fW?D)GB5CLvQcV_2(P-AEyA8cqb~<=?(fNWbg4R= z=UgwS-wnL=!+0#vA&$8nB=-bBpCn&F(3r+PD}Rk+0APnT)5K4N2ebZl@t%l0ceAKo za7N3Ll7P7CF#{loRJZgs)CREk;YuP}HT$lEX&K}__~AW+K%Ds9t2P8%2{YoD_X zUF|}<*F0Px06F`#K3(@e31b4xu& zE-Bptn2A9_mfTnulzJVf|B6TYL;CCXAG<76`?5;%(Bi_QttOYTFTNeQE*xQt)E$G( zMt$8Qvp2~yO=E0cJ z7&^NCiA~0_*5L`6SH_86R@AGLFC2HF`r%I2hB@QJ+xH`=uY4ks3Ye{J+1u>-pHyq= zt#LVxW5=_9U-iOEr-)Vqb@s)cj;!tMm{D)}LKhqb0ma(%y8%$&_QU_%6c~B{aMXtT zSm3iJ*S3B)Zu%l0rv95E3KSEGRet`un8rgU04+Jd^G?g%xP#nAXOYLAgM9xgX|v@& z7vA1@S%HI4`+44$EC@`#m-m(9&uOm)XHa@--Uh$?-+uFgpcgfHo1zc@4!Up#XMf4t zl5PAu99R&Xzn}N*#-G1mA~{2fX!5tU<ro;ZLy zd%$XB#?Sl%wahpQo!$Np@q%x3E*$`bGrY&t@f%%aH^5&%Y!9C1DO)kyA!|1?hNH}RcUwW2V}>Spf{;>b-P*G)pnpp|kjXOjW5>ou^QW^mSU_`9{#*@S8BEpVpNw zVUrRzcwLRQCl|l%k(6u=fgm34+F!#^=xa+d+issmDeW46Q6DC~={=7@AN%Qxp_^j2 z#}$O`y^_!)qNvDjwZv3W0VyCtTMg;lwKJeT>=}e+xhJpfYhQ-2(@5*bU*ASc3>$3> z7mmNrzVk`F6q*0MzuKurnwd6i{rhWWEPI^uTHC+q|=UOzgN5xu96sCSH78Qdoj*CM{t;eIwPF?t- zDz?`X#d1J>@gSmSNdmUws8|tfmG)en0#!B)BqI|drjcbI<*NI667ec&Ru zo>rfxvNdfz`fqyD-`TojP!`6wmBnn{e-jTvg4i^Cn}x8PAy643FzC1wY{{=Jcgxz- z`oSGSfS-_6W>gu(!#+;nk$Eq2l2Hp-`$Ct2>;2J@+|C~Fw#}BN3hl>djDE-JbdRkid(Cu3 zPbS%~DP(3FBpOvV@h?0cyD?fDL@72^p;f5+CoLmcnpi8Pk8U#hYTV%}+WKBsFSa#g z!oh;HRCgzW#A`FXx%@+RW~sUP1ha<<)|dL07fyd;NkMCnzZf8GtZ>?8@O}-oY1}ln zL$3PhB{NO6WC_9PLsRW-VaKr>L@WrtbnnBvWa)Z`js)rD5JbjO)lI%fhudOWvPVBg z_+>MzQei%O)i?P}&?6gKtZExZT7!I50P$n}F6q?K!>zlmOg)UbTr*SQS{xVO+bqPx z)kb~k5IKulzuH7b;}&%XzJ0z&O4{58k$M* zdJm%Sg~m#Bpmp#eN1}II_0gs?gNc~ctnR2mUb1I!dszCjmzF(>ab8VMF`F6ox135a z*+aJj-{lJ3Dg(H?=t`D>Sj!d2WGbO1KI>ia_r?Ui6ZK6Wh-PqQFc&gs9+F<%R{%3q zRgnMe+8zn$m=HTU_PBBFtm;k~p3zBWg>bqCcTK8dJKNx6nF^)%_4deu!G-!AUYGf> z^JY^o=t@hDCEfC#^b%J@d#hg`&ry0-nyB0(Yc^nrBZ65=oV#T;`&w}c9_f+AuZ=Sk zl=7G$%u6UsjszlkK~gQ(hF%YU2yIH7)KJClS#HVmfyw$u{mKE++x{^mx0pW^dK$`5B_p3dPV9wIM=8_*23 zS!89-WI>75Ou-q!Lop&4NjNOxeo5@HfQ7!+T;i$hyV}iuDL-=)NfPciYFCe3AdVaH z;J!t@mA5FXDBJWbtBvp=pN?GU*>L0@zB(_9-2Cw!&DCcqO+S>YAGp*Td8*?-PKxL$ zy|;s9j_ig`-|-8++IjuaEN_v^s4mC%cdo0Lk8=VUEmD7Is~hkC!L4~#fBxSxC|2mx zH&3$AuyLAuv##`wzr8O_tlymB)f{|~ecVxL@WQSb) zyKDg2Slw_@qx44`HcU$gZ?3NT2~c%YHw#m_*h@oAEnfmzqqaWY3%IuP=!i>2l{z{4 z#0_=LHg5*qgCrrbaK69%U%N3^)trKo&rC->8e6`?Pa>n?2)+!&io?S)HdVAMK9MvVER`LI}yq+a5-4 zJX}z94kkaRmSbM_Ce#nO+jVEB;%UCBhP!2T)Dy<3Se&_dE zAD`+Sg=6x$vD@?+-sYI_&*+QTAI&dS2=msz{xdp*!QA;@YacCy)*xz{WUBT*7uW+T zE2=Ov`L7~EN*K#m_lvfY0|NeKO`rImzHm}W(?dwEJ|J=HzIj_m18~F4%@`N=>5iYcXmfHI_ZtSGKRqHNz7WDu%ko(8u0oU6)5>8S-vh&a>pZ8 zuAed}G2eRQns#kR<9y095eR_XnhUDn>X#($RwNE0v~0D#}R14Z|JIx_*uF$s_J#@{tBmq zUb*37rhTe!>L?wuLciPM6uWTZPXg#x*pT@Oq+eP=IQTj4D}CUxfTxRVicg`-;{N4b zKx<#h6lt~Vn!51%@Pp}c{xjxwni&+;o*?ahuh^mB(~Rh+RS%w4X+Oo=AQwid$_2%e z9?}7zbRaZUgF51qu0K)t0jdJ~YaHY6j*I?ES36BBT!FNVl(dzUy+C@E{i0zu10TA-9~vlog^dagyh0@H`ata+;*Mb(G0zlx&5unL@M$FHW=!sGMadT#DP9 zz{PGbRf6zm>ayz+RHD}u=#T(Ky=b#pJTos8hz0s8#NG^!(q~3^#K1$EVtvukPxNA~ z`&?}+@OD`^k=bbUX|z8>Bzch{CkcpHJ)li81JGfay53RANk9aFh)HDFr8Q9b#XJ#uNsQuUT;P__KC{sYEXDBqt~9i ztPOl^OM6iZ*GD5LLd7U65(Xx*vk&8FX0fNeapYsLVFIJ7`hAEb%{v?U%RjWt1VHbs zZ+{%^paNBW8dcfp-7ZF-@95;`zp+zUsk@%Z&K1dI<}}&FF!^*cVF~h=fsteyNpHy# zT)D9?%&@$tf#JU%|85Gov_(z;U{%tZ))J6-0G(KGn#&r^G!i~@;4fyC>S>|mT=b05 z%k-K)@~;Hd`5&J+IuMWqplD|nplGxy9b=hjq$Cm%Vmtg}+h|SzNdMz=gSqEM{m+Lc zp2tZia?v6@JQdh)LAd%cOajjYUCMJ^?Fa?--91l`%!i#3XuM`+FDp zhd{YSCYkgt(}9I4OghUoCNVi)7&eo^A)7;fn3c(xUBTiY>4lslQf2grDfeba2C4j6 zg>}6QuDY31<;C*mmIDEQO?%F~#tYeS5Tb(*DhqRrprEnaguQ*4CG{t>i7s!BF?)F0 ztoIi3Slw^%Rtkb-nWtioIZlHSB;Y=c@(J;Jw$f_svf@ke>5a&OV)xvPasBUC2tWY* z-N*1BA9dnO^A~QZ{nAIC6R9vdx$E)a58aHvsZ*EN!XGPI0|!)QOqm z&i)v1ZNAvID`UeepHqY1Fd>rD0C}NKU8sYMK~a20qV+~W!R7ilrl3FokkwA*5kEGU zK$+!9QlP9yUoq5yN~v!xadHS;swOp*Y&!)uQNYw_mHv69F!B5-KET6*3^ zat+pqt+GB+tTA|VdPX}KO4UGotiM@f2(A^}@Pin-)gQ9fjj@W@vo)r(fyQWrkmR%^ zHh%gAy=(0>^=7ZW7|8sdSNh_K1XWNrql$I(>vi1fJO3)(Y~Z@kK$_)pk!Vq19;6Nd zd=c<&Q4{3&?*k8#veOynZr|YXxWO~Gp$7?jZbmgoXb50y3{r0NPK1`JH-_dmK5A)v z%tq-@j~k#$ zSEqyHgU~krP(m8;0Q>+TvyKmNAi%|p{LVr19W%0NXGFu}mZseQc%jDc@SIV^S7J+t za%-1;Yl{!n2cOn~me!$#s}FT&S_|3LtITR^^IP~^WNYIBqGI*!yieOIsikF%K(%K7 zY3uQ)hPUu^?5DkjPlIffD*>O5=>_jeA&->>L&5|>NXYy%hLE}D{Q>$>6t%pP0Mx6P zO%^O6ks`Q8)1!dwYC<$h6j{}md3L;qBxG@q38@f-Dh7qJ#@h?&u9p;7gWH?Mn1~8v zG>xk;sbd-n5wWZNA^9dMD0eBwfR#x_fcc4hji%ekGm*h@kzSszF)7h03naR=lGB`~ z1ZfrNDk*s`DqWd07f|NKYHC0&d81WEZLw-!^KAkdm0lt%NUpoXqMNCXW>npGBAZEh zkN>u>%n_&u#oI$~4zH>$px&nQJTIAe!*~z?BLq}IKXk*Sdy%A@y+EJ5>y?Zb>M%Qx zo{p2=rYjn;2=Sg!Y&TS#l2ck>)XU)BD;n8LUq@55`mX0p7jDP$3jlo4#F*vqqFkMt zhm9#Pk3RvXRkGM8+1|xXOLGOOl(_T@Nzwq#0Lql~@6Ktpb78*{=s!B}w+x9TiD;A= z(e41K8jX;*YJqySL(HK9J$ZCVqfo?ix?vbySxx~N%ph(^Z0d>FjEL5p5$&7=)mSS8 z=nO6w65331kZBmy8RW zb}qrb6z#qFIy1T=B~`k}M0bPs0!zKrl(1Dl7Qa3wNaDs4%wUNLbkuOE7dc1)4)OO{ z<1O{$jSs0}dg&)?$sd}@NQJv{B(k22!U$$?;+u)X%1VCtfC^sw4cZ?7s?u5W z$Am|WW0TK)8D%c$en_;BP|+!0u&6Bwqv2y~$5ZsQ2m>(gVtC7It@OK!?}C2Ts3C zq-;v-uD(CDE;SS29$+3dLth6kNt-}<(RDG;YKqo+Urf4n&`c36?x{HNwpH1|vsKwA zA0*QepU{ui_EuixdL|1*htvNVh2=W;anjD@uFbx)n0XuS`^=bjAb@(mvb0NP!Odbp zAstaaO66ueZ!b#NpL_q7rMq)@yeSQqx#TcF`oTZc*0F%1YDT$@C(jqE5MGBbd5+I3 z)X`KD22`p7R`U7RhUtBiC`XCCLS3^f>kG9OGr!OKa=3>W21+-0XEndiy&Fd~1yJ2v zT6uL*Q$D<0?7QZ;zO2%YAQ0{v(`NN#mYA<*SJ~~i!>u8oSk}`h zxo?ym(yvn$*ua*B3BwlW!wWgU)uhsSaKXFx6)a!fonajYMgJ-;bZw%ZJPB zNy|UXed$h+E2o#=AEbZJtz)_ffU8z-?%ZAy`&kBjxn%3ccpyQg8%{rT$$}u6>#Xg_ zc>VOh{K@=f5aP5~Q80af3{ga?B}md9Nk~H2oXM|A9?cmb*NBuv!Uo{pJm~2f!^$#i z>MDf$mkfzcjzlMc1SH(0RdHh30nKLv;HljQlC*oC7GD-k_U|R2_i8CA3U)Tcn39MT zw+v23Qas*IPnXxKIndBMstGtd9k|vwHd_4t?*IMoNFAEysrxs0u^H@7+V9fpqqKpe zsp>!CE4_?$h#a#`^x<)?>M0bB^Ub52Lj8Of^yeAZ-}~Z;0{m_>QU6Pj`c|^KlwwMoY;k6p~)Slw~({jj|B|g(44+XWvWR4Inu8o_x53`xoU0m^D*L zl1S@;0t3D9LEAFy_1CL5I|qR_YWR^3!|k7Qb?>RJvDNBL>=|0aRswjR5t0Z}!Eq!=4`ELszh*z~4Q3 z1A58QBek}9mRF>lE=Q511c1k>MGX(=pvd&|5abOWuh(0%E8TBI_`{&2h zi&p)LT6G6-L*8%Cx%CU{4!zXA2_NO}ROftb>Hpr#V!gU^9yFUlb>sF*zD)RO^loc# z`}ED=(?3W4ZA<#|Rh;3iUOMJesL%Q3>2B%al?6lVorS_2)*f`}Px>5IGXF(8N^^Ga zlq6mfedT~ngdac{g5P+8y2^~8TBdFvp7xz*Ofnuf7EH$6N2v3n~}BA=lQvh26KvJkcMKk+MuJ# z5E;~n!1E4LU~05z>zDIKU=3K67Q@UaiUvNeAtcrn+ZL!vTfh&X8{m1&%(ITLnPuP; zIE?-v45v58(3qe**)P#0-4(XoIEOmftEgbk8!NbxJ9QHEVg|*`ks^PNPO@}@t{@+i zE^atI<$?P!9kx~*Ut7ZX{&YRO!&BiBesnL|h?lpQ9%i?JyBD&N$om$mzj$bFPBG8- z7!%KJ8UcSkkj@>GbeQbwi+B-k{)*vNSmA>xfsCd2O>WUm`q`y%v%-IRYJ|u(ry#S~ zJW^LD2TymW%W^r_6P4A_XW52Qk{M}t-QkM&vtR9@t8$1fTRT)pY?$u^eo4hl(koEY z9W-u*!;}n;vJBixDOXqnXv0?&yF=x+z#Lh<*EMEk1W!t^HpOXb6Cc{25(Df<7H?|6 zcNGQCyo-jtD)jzEeW9$vGd8Yr1o!ltr)pA{l0udfr|-k6+urF2n_<~4b86z7;il@o z<~|++YLSyNx8%vV{xE+?wVz#o9wL&arilb7%)WC2xCZ4?smASkDo1X{ z-Mrg9_xl6mdwuR+0Y@QipIH<@@6?tyNL`=3zCl9tDp&M~KE+JttNV+Oe$v6pwgHDP zB>{_^Dz@!6*XIcU{nISS(P>|?(umAzg)nZ!UWCkNVt`AR6eSj5e*jbvq^ndyf5F?`St$o!TNI7}1OP)V?P3~jA@oDX|qn zsuEvwR7C==az4$jliDVup}CTfge@xy1-w z1%NDwDv0AE#YYu}Y>*q<63(6Mu{t5ejBTDe^7CVK13u95sf?QM?u zdy7g{(9;;er*v#7%6@L>C;tChdYTBR|Bc4u;x~K1E9CMN$U2zY^M%E4IuDzt+Wa3h zE-dZG$nzKh_k%xc(zj&cnVBSEkN*5y`f$+6GkOt8qJega1@4@}wbWJg1k+&TP$Z%8P#4`7k2+%~C*nlMFp73IOH)7VUid zd(bqPgGwrioM8i4h9u@Ev-7|G+Kay-4~>!C`y{sVYmiwOFwxG4Fz5UFhT2@(Md;Vc zz$%vFVl@&$H6DXw<~&UJ|5|z^YypxIIK?;s?gNcMh(c70Mo@2j_ht1@p38c*9%u44 z{9DduXYGj3y!Zdm(cOrO9g;RW05D)kB`5$o?q}HkzX%Bz5OrLnELAZTod^JO>tWJ} z*7h7YI)Zzy4>D<7IG&LbYCX#(w(3Q*CA;$JN6QPy|Q^EfM= z2dYo)ihW0^zgDat09M}BRR3)ciwGb$v85Q)r;^#ma#yHP!Crr9SNEii-Q9gn zeEbH;qM;&5+-1p=*H>@rOYv7HK+fQ*2S70tlI^_pbH9e?YYJD-=&^(LrL%MtChPdS z$hd;~mV#!RUaWaQOkD+Gs1`?pCUpS#;9^;k)j2P&FTV68MtRR_2IHM9i)J#cplWd@!HQF64m^AOv;N)51gYNpfSIEZm8~Q8u49|aOV(W#k4uMn}@cu zb*1URl9b|bYH^rzu*T&a#hqD5kSAyR1fAM*PE(QM#+&WqeTZl}P6iF_pXps#p=bu) z=6Pxj)%I?vtMbsBVzZ4zX`@bO6>XvOSFVdpkFjK-1TwpW&&hPHL{FXeG3}xvUayTr zviH$&`xh<_qBe`#01%BAt7zbPg@urAonr33O-2`MjEyPC zQOZ4g8JB>Lo2Sd&b&ZghmdlDP7BRpkrT7D)4}$4(N;PxO$xyZ+zM}yda4GE-+=9fW`I1F6 z8$<=NR)rMNIb=C_4c>p#*XBuKjf(l4OZ#pQVR)6Si%Y4ei~9yi;M z*eEso$kwKUOrtVNgcw!|#oR=<@n{TfUr8!hY!7CTCjitR^@{8$7P+8tH=u7ciM#K> zNP2zn{kSnnMRK5<_{mSN2dr@= zrK8C^^AfFW$-cc$+JLa+E*jCeawUSuD0fV59@Cp_82xx|%)nyON2Ivz8SOTn7zUyk zbusv@q%mF#k;aM|a`QyJi8+0*vt0TG^!`iqz?XrFm?$L^VA@qid~{mfH13=tbpv-* zLqT>y#1UexN68LLQK~|kK}lwGPjnQ{btyKf4MbuFa?)rn+L2aYcHbu{*#cc9&HMUd zJp$UluwN7CFv-pyefY*~a5mOMA^Kcn1lU~^dC)iSo=blpHU`q!{V2R5qwrVNC5&_pj3t_u7GY_5vvm+R^|Tq~y)NSz|2@pOsG% zFTQ{Nw>st*IU@E7(Q6KU0*Gm5VE+oVeEK9&!|JBVZK^0N*)4-aiyv{F5>siTMB}W4 zw|xng(N>Au3AV4S;??0VYb%VAv36DQ<{#o4h{;U~3BOM*7ok&;w$zTBR+d)Q39BtJ zT~yCKr|t5myppHvtKtKYVm|zoKvann+}eaObpbgYX#833{)FF03Wx14KSM1&+aeR5Bs+lL4=igW$Atai3O(CRoF7em*TTk}%m0ov{`f_0z{l>A~K0@M_G) zl3bn1S{Npl0hSATg+Yv#vM*@OEG+rWdmD^mZz_;8RV78klfu-iDC1`iJ++wQY{g~S zh1EeEbroi)zMssU$!*Cg{8p(Sl4TifF~*iBe+R=AV$979Xu8M${U<;He(j}Xogh@1 zLG;uxE(|)!+kD&8;;rHgj?C!Q)G(^uc-ndHQy(6*jUBJM`R+&g!FFOhCPtON0v2!1 zEwYeNUzFaKbbq)*p50d5XBIxM^^v!~ZF6DxY#}4z>MK-}RlZbwU~89!RvN<;&9L;f z^MkXU-?L&$jmr7i>X{)`0*xE{dy?{?gi+Syq$F7sWdg}+YC`DwrMk-PQPVE>in zZJD$DbbmUCocha^_SMpg7_-{(GNB3@$6_S;B9YN$qKU#euC2p!p%jZ3u_fcLTk2K^ z^AXfu)!#yi!WbroMh4anF0?qw9q7uIh{R7ZBFzk+K6i=IZR0f24GW|}1&TGPO3E>p zmND0Uj$w7Ltfz4l+!1y@n$9h}UpeYkT-JR4iUq1VlBtq+VoSC&X-SxyWmlG)ih-74l68R?+a(sF*<5$gP;y-WpqvwBStX>Cgerh5&)}wGncvwEr z`C@On0T6e)%vbh^R?!jatxs`M2T_;ZIl<>!IY%KbKHrv0R@j8@(r?M|Y}L$r0Cmy~ z<@7?alehr6W9wRP1)k5?h3PJKW= zo(cx@+1Zk-QWt0i^Y6$ zzr5`g;p-LRciW$w5K4?Tfl`RI>F3H-a=m*%e6d!V|WB zsN0p7SyG>aq0GRe(H(t1XYGTiN88){W4q7Ucgck;S30~H4k>()e`)u-Yi6 z01%8hqe~3i?ZNn3phGho$V`awnT@jGqlvRdRC~CS5-xX*s!-of6KVsXt4uinW$@#9qNum=p%Hj9h zo}a5-2joT-RlBO?%_DnX=zhq>%$IJ*`smdaiaCZ%jUPJ3IXT}09ssurR0Z`}q@h?w zXdU4rM_?a>7~$~Ue}}l$eZD*vgQMX7Imegq1!(F(1_gMhF_2?1>>dY$K>^U3o${z8 zSr5nL{O^RJ0K|UEaD?v9UomC}SG5PRvRJT#U2+4v0Hqmrt9A9_jo{Ja(ScgJvr9fX zQQl%lh970hRF$!A$mr`PREEyR-%_sc>-m!yve&e{Da=uZ)1!W0YmWe?8XSca`|*^{ z1Yh83G<}--87;TB#J+ePuMRTmmw(Vh#3Te4>)7u-s5)6!O;r4R4^qSf+AT5k@DA;d z{Q8C$v~pc3q;O9uW!o|7vGcX9(BP@iaqsoRWOlPhfS8+E`(Ic<6mcL8!2o6=76QLN zdx^1#g~dgx$$vhqayW7FK6zC-5s*fil-#TO^Q7w_R`4F3a}6xcD`r~nWLDvUrNM7i zugV%CL_(mam}*X+v_VtqOl?Bv(+G3{Z$`6Eti5wIvPQq5$Ny5F zo2mgMq+{cf>7(1bW$J!M>EYxpu{aV+i2NbDXE2S;-QOqis>rB^$*wDdx|xSDjSr8Y z9FPAd)Fu5z&G(9f~IHti|K3Nbxo*9ct2N%EWEcHSG;p{1E&sU)K!*gdxHFsaw+ zEhb4yJ0;pNHlWWiK~JFBy<{gnh?aPgm1iV-U#JKd5Qf@_j-xPvmj88l#P?l)u;|k} zaYGK)vyYw>x1G~LTsX!?hA4-J+uJhJco_C2U^e3X5F6Vs{{%)6Ci%eO{K=zl`j78W zQCJhAEf^qu4vbNYU@>RNb{3EXCH(6m#E3|MM{S@wwK$%q8TSEX5~+-Je}*S$!Z=-@ z@avmI#BI4Z#X4b)rOF+f?wZcC-6t}S(S>JJ9Q@f7qyh8Rma0F6+>`*+wknJQAfs4? zZIv={{cWd}{;juVE` z=)Eke2F9~KzP4@*dgTqb*Q~ltUEgwlU}3hJMmWLvyR`{M1h)HBSn8`$9ipH*T_x) z+tqiaV-MD4QM-38RnCrgXWrf0zr1mN+6K*jc8{cbd4534&00nxiL^N23?xV_6^?vS zrw>thI4g7z^{u_WouWe_v?#JLq<8?g2bVI$Z!=r|Kd$cjE6O)~@c7KYFvCzocXvv+ z(%q$$(jg@vDIqby(4B&G3P_izLwBQeBMkylA~4Hmzk7Di*}q`Ud48DlJokOQ-j|#& zm{vAT6vE(D1mI+{9R`7;3&J@ilh)G|0loFiiFS^E@RQ_V5-iC|RQ@a}k9nbOsXEJ^ z$GnibL}^Mtj{<9kT#G>*+mE=^$GniNsgOpNT~72b@nk6HM7C>~i6-A317);?-FV65 z|Bm)pLw>cFTfdvsdyMvwAVRo6xZx;!?d%d7g?EHvuU}Vdz2j7{h_I_PW2!HXVS+i?EqCpnf~PQ_ za2bb9PypAG1CaE7{tmeA>BYq9wbYUe_X`PuMCA=H6#F)Se|H#qe-NnL;47_hymt|T z@g7>{xV6w+|2P>y_gEbrQ&HoF!lklvKP7$Rf~W`>l3Cz3jFY?42pc`2-#)99{d`d+ ze`lDgCOGKrL^TYf)VfgO`5kfgLoy0O-Q~+|+~ZxxRUF}rElytgw3FG2kDO|G&htgs zk1brb@goCLX8XHjFGr&{2R=qTe@gi_phj&Q_Jg>Ay~b+tZauk||L)5-U)oR0^O$kC zH|h}m*j!2_w*%iC@TNEF8iToop}&rNPJX(feSRS@){HLAF2{+^Hj00aaW>^LQ(dTO zyqQw@6<+pj7=7kabhj|=YayU99@T#4p%l`|{Yq)NTrfGAhc+mBZFz@0`L>cERFZgr zZGB2+?fy-;V)sH!lAwPL8`)_{m;A&yT8I4n1{K#m6pQMj>Tx-_GD@WR3~h4=dW zIb1&hLAwj0;gRG5R+CqHc)EK`E@mDZ@aP@PnP^34vS{o6TdUZkzmxBi4~yV$D;k-o z1VXE#=@za8@G8_?ow-AcD5C8n;XH*goqr1me-pxf1tq%3Vlv}z4GIWm)HABGEImE_ z85hu2&+N{#{ZrYxFE(9|CMQINzW!=J(_SM99LL1SSec|yg-16$*eiT$)ulpJADG(o z5wp+(2d%BoC;T~fTh+~fBzhk|$!eJlo0Ldhj|q|HwnW5HRWGI@kC{=wRH|~~N61qZ zM_&`7NHFH`eGWT{X{EQcRMh_q#=8ctF3myy=+|%?A~#ypJVMZ6X7r!hWbhOT6U$sE zw%^TG>XY0h!*7-8A@Zp#T7>w#FO9~HN)7VXC5!J$S`(~8KveOcpxhpFTH5y@ETIbU zGseHsW=RttHiS9F%`&Ey84c;FgE%#9xMs4ao64Tlq-njan#nsi6t~#t)D2gkiGFUF zE)ay&O|6>E6J-Lxv-C6|hB59K5t};kC^m}Mq+v0!b*4%`WWO$I)NwUE**#J< z8M~dYDf!`h{5ZOrd-gLtkOAOQ;5=kOXe(>?0eJJMP5|>ra^r z!!0cqwCq0rBu(Ou$Wp%M(Lc=zjkaePpnu?pIId+ZH;N+K3t8h>1J^P4i`ckUER~Mi zu3rvpW{Cgd-S%fyC9vDp3a7-Q3Sw`2p)N1Tb??|GYV2SJy1o>K@Y#e}K?yGDifPdO z{DWN8x|n=-@?wOFQ1J=@f(LD`Zmet|M!&4hzv0$yU#0<$^U!v@x5j}kZ}$ipZ>?F# zG3kFyBL3Y*M*{BH0AWZD`9L^;Wztx5SW6WLloWwD^>cqF3gxR3*am8}^mIHGOl2n8 zl=loLFHedPyK)c16Gs7s%{}Gr1Teuo8~PTJ&auAIRu1Z?LLy5%8%WKpGkw^&$9P&w zBh_xysSS0tW#8WO-5Q18Y$Xwf_=35iQlg3d{Y$rXguCX-i;r`sO>iaY`a4rkvKxlc z$0T)bxid3Y6kV2aSqM4K>iXp(Z(U?zbv&}cOP7Qy%+-fqO^bBLlo7xWM|)E;g5#W# z89&NBL@Gb>b~*Owx*v=8zgr4DHWKdcgSm=klfQ&3y91v%N?*=*cg1*ef9b#3iRsuK zaKn~=LO1^Swop4lij9eaU;DiMrbT;Ff4M~>rcvAeHPHPNi}^d8e0t13$#~D*ndYAV z1z=JDza?{*jIOg?ZPx*|tYHP{`rmoEXHm z6foi@)E|1{)tW~WXlr99MPZH$$w-@ynDKoZ#17%BWCU0^JE6y2 zybVd>2)jhi#qz$Z>Yk^EUinS$3~flN+pvy+Vt-6Gk#UT@8!A2Ry*tA==o)UvXd{LBPXTDFI6 zP=4K&{uA!n*k63}yRatMX9)>ocnxO& zc@{1K3R|XngyXt7HN!3QA_-goR3xkSj|FLo9$~|cL3XrVeB4|cwmP)`p zjL#2)X0e~x$+S3hPPk$bPn79;azkFRXmP!8QF>lk5B$s)gV#k~D2>r0(E47B+%Kq` z@(u*)FC>+x;9^2>rQmS~=YhyFSUtf~vOQ}?3Jk-KHLI1Xy;zx&P?)eBr}C;0-q!DV zD7Pn6!u6sC+H2ERE-z^~^?Z5-7%OOD5UL1!1CJGx6Wg&u-uBVZjbPW4hSm{EkO z_o;a}Pep;a7n9K)kp5yuSee#Oi;>xLi(qQw8IhI@R{VM=Q{|}@_vGep53u>5k^V{{lG2L-lO^NxCBxMb%JLgk)fmDzjKbnm3$#TSy`(%hC|rI< zd5#_?WtL}T(}MPl;-+-ZJ#qE(jQErviv$WnA@bas7&xv=Ql7u=EHz{hVaDAhibMwH zL|f*tmoL><6_;5(d3D8w!#Q%pgmN(q%NR|_&^yP7aP&R>p+K3ZN$IfS&bfCgd2sBD z7I`+3a4`leC6Zs)^(@?83JwW5h8cS1MQj7eVzG16%O?B&CIyknZq{{qQS(_(JT{In zdwI>Ctz>&F!3A!RLqBwv`IY%1g~Nk+4=>NI$o%>YZIS{LrnIHJb^j|((~s_syB&2O z0N%S!!ff&(4wLIWqHqk3TzMe`#?b;BHPvGf1lGmN1}cMTgG&UoHz5*xqk5&mDPxkF z;hxjo!s75yrXsm*3_iGm6xWU!Uxl1-MUeU?=sX<(+V(T5SUT#liwWakzqe$<0CF6S=oU2O*br5?nkHy)+%tSB!*Cv&Fdo_PkaMGVKf`(9J#L~GcK%9Qj7qt-ZCdPEg%ywr90X?i#Umvg?dXFe;7E!!)-OEaF$&o9C%U>oN?>yaQi zV9o6oFz=B#Rd^NC|I8eNRT#t7DJxIV#P-*Al9iLS)yt1WDvyb~#LI9=^B#e^ZkDDn zLE9e5$=8!83_?&3w|Sl!)_#dKp;pc2NBb&ctxv5-RZG$v&yo~GNP0Lm!+3;yL`xK| z2*+L#DRjPc2+OEQTBU7q+f8mj?`c}GWE0s_#*uzv{#P-8@zDoaZLQBW*9!X@6s4ND*d-v1C_K+}U)$aE#VZ3``YY)e3tMc5)ZdUQ`_rst$pB~A(imQ;C0It0+DK-3T zq*?ad{bdKd@(xqS3et7x9tlK`D57>R#%-ph=fkvOPliP`Q+8mm#xJ*#MQg34TkQj7 zyD>7$!*?Tx{pv?VV@Lhk$LBl8rms%$3Hk(0ezz3tv~YM}KH=9JRrLd)p!;&Y09s48 zeu~GP!JMgiKzuK@t6?mrB$R`C;>82}f~*&G0lK8agjUGi1mobtf!9owWF>$I2@*yQ zr35m4P;M5v#IS1hn}1Zj|N1|-j=s5d4hX0fususE zC_tH6Pnj=3RbEf^S%A8=p8C50%|JcPgaGYaJ?)wR-EKYIK;f$_6sSN}=yk+XLx9DN z0E14iAcbH*krosBOt7hs!C8qJ;ax? zxaV?yA*@n3B=&;xSq-248|40{j0NvDfYQ9?W(g@M)SG1Wix zs$UP)RK;sDD{AQ|X^|^xXkghf2y2on>MUI-Q!7#r%F12H$LS(exFhvc2te#222U>Q z9y^q>%>dj>+lxvuwSl*}F>)osYDwN8O@yfi!CT#4Q?nRUoTAx_0dLy@y%&mR7-^5( zU4^>$RdK>1=9S!Nv)W}dU|z(>w!T?We-eIWl1lj)=rR>kG0{*oZi*|lMq}DS;%p6C ztR13^Wxz2NP?1wq3GU*kGT2l)%Ker77%wM z10PWxZ2=(L0RQbW!3h$=jKh(oPE)ja-=?;>cXTW77M!b>btxaa@Fs4Kp z4uIAWB?MJ!UiC{66E#Y}O4VsgRcKEeXltNpH`c-Iy2Ek$*PxWG z^^kxk6d$GFsSk)Km*cG}|TY zMfq}u?O_hdCxK6^sez2s_lJU~U7a31t9^qMu9IItx21WS?G3;3RGv7mjC3~R~6 z(rM*1hM1HZe0p9pwsd2am#(K%IB`53#O*Wwu%`ij4rsnmciD7EV@%U8PNeO&hCc1HA zR8T7=Rb_1RU|!Sq$utp@=eZ{568pO8;F#C&RIVIOc$%r3KT-C(C5bEGLNvdnPcb}aUNsD z@vtNs)%Tl!lV+I+Dg3h5$6;ztGIHIg(Ohag=h&$F&r3m*ty)}R{JUw_Y@$$2MI3xC zk&enoPT==1{wPy5bm!iR_BC#s9Oc?xqsm`Dg;CZfikdn7`(=>UdXu)=iHbjW^L1Rf z%=YzG9{p9*Mj?UW%~;|4RRW1ITP6(=Ewn3Kx*)f4d#@sYNq?+@@b}NgF zlHJ5}(^cd|Ys(|q<_lRR6;-KxCNW{}5TI~4ih)BH&Y_+h14Ty4W)#W;Z2_>6q%bh< zbfjQTJ>DXJ6xG~dzi7u^yTy4zh zwt);$S0>szq-CKDA{^PX7xEqy<-Y7OeNZh|pEXIx<*}j6RP7TAiypHmQeY%4D3yJz z|0O)o7BJjhlmp;aAWThJY&SYO|O)AJ055ui9zY(jfw2gGHWSndI?gF>b=BfeP~MJy9XNYCP;Do&qXBGu&+ z)E<^1SXVmq|4dh5PGgnJ8&!dja=6u2Fam@e106${Xxch3SKF)nC3DPgCahU^Y$JE2 zr&Z=%DRIu?^~@9eT^PCrNC zYffWa>LRHOZwkC?3yiRZ+1T~luF5%5OACLI_?X<)4>n2R)VRbpRDD4+9r=Fw=h8E6 zSJBLcS?oHs=lWD?X|tt-@<&~bGdruy$}=)!NR>q~|H#Z;*A>fyP^}MfQLHNmxleu(arTu2)j#Cu%qQLAR4Xm_osRS#(S=z3<2Un*>hHxG+0oKR!{l zsMjvrykqv??pfIbDo!FaJ6VIQX=Q(B-LSJn8{mWc3{>H7G-Ttj;J>|;+YdLUA-F}O7QwyWu z`J%K$!JX*y28%CrLrq9B7(w^E>teyc<( zcGE}ecYfXJvtCd;!mT}Y-qB{>mCOCIec#t@rEp1;+QD~VDJ8*-Mjn872gxshu>QSv`z#X4Jvl@vr0)%{kY?fG~eDF6KA7 zt1_{VBWbn)LCnE_aBACsci{&%7-5ifFr1!^5eHaIyjqO>e2dq4~W*50$A6 zy_a>hc)C)4<@R*?E{gQ){9AgT^Y?Zx$rm=%#qKx9F-N$8g4MwBG5zSVRJ|sn-oRAfDqkC9EAbKD_z)Wt{^wT<3@Ix@|CKwudO@7p z96&%3#<3A1JV47zVO0?YKbqv4Lp@fd0>d1_Ns`5Yg6~8q^a4V|1=V5(hFYti` zLrK^(mi`LR_xd+3AH+nqo84&~Nwqm_rRJ@deBj-g*yFkcW_t|Od;YYJgsK(pQDMS% z^HRb$a1Xx#Lq~Ww1U6_H_{NwaXfIII7qPz^mvxpldva42*$F&dI0>*HcSaiZ0l5^M>nip<~&N_46T4;REmN9gTFjy zJXTFQt;ano$FaEbgTn!FvT#~Bz%MB|1r5S$w0lESh;w4{sO z#2*s2iy?H1gP9Cgt%HeIvOb!^`mN*?@w5pezJBpYA>V`xQVQjE1e+Xw4GQ*oT`%e_ z^FMc3it;-w1B5^pocVQz6=hl{JDHsXJ=+w1O$y%fX?ot^bJtDW4iq9hB`GS(qg6gD z_$JWWpYO#~rtl2mW!<~s$pcA|Jjzh_f40WI%RQr;uoBz_zo8DSNh4E2~L%oWGWOfN(NW&6WRhJ42mXzQS)7FZ(Pr}RL|Ion3Oj`hmEXdl4W}HL8 zN@J?OXH(Q2FiSc*c6-o9d(zHJ+S+H-EKrp#b5YqX!gh73rp{{8LV-X_=mS5^kX0?Z z4nG@(KeAC1`=Xqum;S{$BUG>Er$^1nEzR-m=W)5uAT!E~$EP#=d2)jaT?g^2t3|8h zeFxOH5Y{c)s-14q4@LjNVPVORO&2?8&7C+v3n->fY&|8dq znfyr!t%tjmT^ZQ+URpk_vxB0Q%XVX-RP?r#{;b>_SRvCBJdl*W2k~Z{1hz_~Ifh{U zIW-fNA|6?+rn{}aDGPsQCbMZ>l;u%XWzs-2=>GHPCx~8ILjnE(hBw(kDyAL)2*5Ws zV<@Z)3OHyM{>RV!FR0ol*Ao_`%mu(z=l@C6+BU?>?GCzjWHk9ibOwi=a+cQKwnh-P zy~xRA^C$B9Q%PALIezN;$_8qVf;>HtNOdOqI|-X{Zwc0D3+QT3JZOKtRGDl_vdRE! z1C*P-CakId5Av4vVc`QXiaF>90JxFwzGQ2B$>?us;4Vpsu5$YFg{u(10R>}J%6W~B z!Q!<9m)T(f-9aOt=;qvEPtGc?(Mo4H z-{I{T^&nb6`i~Fa-c5CCkM=?T5?0!(Lp=I~l+*)x00EE+XmmRLa#mRTa&WGcE3mLAs z)2a&`65+(^p2P`Wht#bDfa{QE{*k()Ar$U#{v>v-^k}imaQvMqF?m;l_5P4MFaefTWO+Eu zs{xb!L&1hfvjbf7Xd)GSR(gc$E1$i5XZq-<8EQLY+MRgjt?|en9r<8g7qohT`NcU7ueiO`$dO*7rbIL5I#1ZVTL9;j3U3-lD-*gZRgA^xq!S6{0&` zJQw4tBI+fpu?}iDAmEhb2MTr^JO3JQCN@5<^y%{aarr&kq^wD|Hz1q;{+isIAH)3g zhX@WnX!Oggj0&FWxs1r%4)yQS91FaUG}`j#<%fRDds00(;0N>aoC)b}5_Sv5S|RUJ zu`6Qa_1AOSH8PLo>Vf7WFa6lBgj_Fyj3jRoPT!-yYv#!XyC{Vsa@Nq5( z)=Lju-Mr6JGh4-$!<&(4EmeibB|$tp7m~$b5eNCvE6d#Do6ZND`BMG*6a;;;{5pPf zlzi~@5FoW>j?m*D*re?DIv`_Gt8gemHT((~v1erITHblHSX#ck)ti9jUcreX!SL%OT;1A0C!%7DWQ@n-fw)u1C0`^4578a&Z;UrP$|pV_ zD|T}F4>p6pL#7DkUUcx<%n`kRSE(LafM%Fox=-%qJ!gJ@UiR{oK?lBzf^E?96$Mnd zm~=a2W3Ne-J$?V@Ptez&c_(GTO*+NjKk#o8`kXjhw@6wvG8N(%g!HRVEPaaIS!=&! z)d`k7JiwTm8`E8J6z8KoJ0G4qCacG{Ao#QOaD@SinV{=@sI`O_>n%Gku!voFe&71) zM#y?nap1TITf2Y^%M8|OdW@v3FV4D<3P;B|aG2{CC=V?Ucfy?1u=Lyl#l+9 zslNwNBtbg}2(R5?wsdzIzi(}SUnHROPWAE$@Aw1r3zp1=E1v-{46(2It1fjCf8cu% z*gQM1z{P64-YmT> zdK_D;XDa~mT4eLLI-6*c+ZEuCLlKolGh` zS!!Tbb8_FNyL>-*Ra$WCndtzU;>%8!>AuEtg;ip6AZ3|bQf|N_RU@=$)SPo87Y^!V z_DFngrr{fCEZUb6TkkMSdoOjfZ4!=ieKdD-Q}#>X9kJ2TEBUh{V*Ss2XC3$PH`ul8 z6)biix89Uy_;I^)Un3+5o+jPRKxH3<|Fg&AT@~Ljjm+v~La&xizu_}4pA@{)gbCDP z7?9{SV9}1c_GYm(5%33}hDFjh!bhJdL5&(!`>`WR9KRChG4l7G`q?Hckb7`x@)OW* zsWVY6Fb{Kv4N8E?--*U(4#!9Cg~a!BytR%H;ee$Ko-qiY46@;As`cQ#Z^9nt0M2M> z5Te`9$JW@Y%Cof^_Bqg+W2R7sSfPkq#t;q$`3fy*`X46+0mdHo+LDYm4MQ42?>zVf zqC6W_41v6QLvr9ntTfwG;E;C0qaP>Nl-lgURi5v36w!%p>`g(dFE<(JhWP9`537t_$Zr7gq&A7cXHS4a%}JR~3)F zFNapgf2e(R<|H%7<=ar(OCXH2^fQSnv}FN6b@?W1SU`h7=7L2^@OIKCvwEvQz3I6p zA7y9{EsmaXU7#m(T#o(sKNaM%CtLiPS*(lu8PYYyv}UD}=9EB|&0HNNOu6pzk5|=c zpKRDZ)&8m@XIrX=PIKaF@9LP}Q+OfrxTWhtO0FBv>D|Ofx>mCjAGiIV<*l4#u->kG z&?dtDH~v3T%?`alk9g4mqEqSbTiNI7IGqBY!$samAC803siklbf9gd}XL~QTI;n-{ z>HtoRxge+A8-3cT#i1B)Ip2Kk0;$PKqnoUjq3!gAbnQj^IT5GTzlj9|9`p`58brRo zCawdGiXPTC8OzVU+NXMRq0RnAdOy=YOYqXMvIy%GfLSgVoBj-^y~kDk_;LGD(#{iW zmNCK(fRkvC%CPlWC`AqSa6Bt^Q=*ur^T0H+~`z zlsj_{P5Cy1iOWl;s3Fq;jQJ|Z%kdz}6`*^pAi|7ltGgc+RU-5123(klNwRqGaMQe{O zd8*1Yfni+)aV!q~?&i0hq=EQ2mpl?9PBqfk2*-0+G#`3T#moCV+$%R(u$c*8d(S!+ zhCWY<)85Z9)W^irQ0)ybP|E=4VUWzhbA*5Qje7rV$ZJDja~SC-+PZ+e4dk_7wx}sv zG1-EF4B-xYWn^z`nK<`Hw|U<0ji-1ZL(UbW#pILYG?>^wFmIJGYp8;$?>78A(`-%7 zGw_L6Nf4+`It7fjls|H5%x3^B?!nL$NRe>Z{phgxOn6eTtPRO5cO{Qb&Qv!vB|r3U zvc_?PqQkaLIsP%V-rMs*s|T>?y=o+xMA0mVTS|sfGb^qMm1r$niF||cfO|#7%oFuy zHp2**bf14x(0Vr+>6ogCp2Y0u+rEmtp%n9Q$qWUy26vu#CyO;nIl)54TA89D^i$Kb z;mwN1!U9ij(}${Wl*5XjG4&wa%4*{l_M&W;;c|d#OCxk3g0@)J-cDOF>@EgG{LO-a+eM^F{eVkMa4@pPz8R&QelK=4A*na_I|KlY}oH)~hgU ztE!xQGB^_aOnpkTjH>P5JYElWs8ycKU=}$&?!QFDCM>P6TW&di*Q;;ld`b&`J$z_> zq5qm4s8C19UO7#movh0DD@7#8Ivl_gnts*e_)f>H`xus{`k&OURa=?mobAac{OJU* zm@#tmd2t-UCGWiXEFhsdi;7VJ|G<5NebEphu5|DKAWnP^$N0?o_ec*1o%<0Ze{v|8 zN>%5!(3}4KlOL#XB{i`NA6u7clB8t9 zUMx$7m%T;XUv62|MMOgx#j{(xChX2X5sdM?*b?e!CM`Dwh`&DnX3X*T*U`GZ=aJkq ztk`M>yGCqW^JY`KK4QIkg-WH-@V5CFx(p8$ua#c+57PtI@dB!YdFf~i-K}EL{wQ8I z4>fO`^p-)Tg3kOSH?kRO&*q)7pKNT+0q}5QA*1tFbo^4KwKT^%R2DcmlVBhmE{pd> zz{02jmzW0t9+5>p<+6n5EYa+OI25qR03dnerIubdUqJ~by_j3c_V08O0V0dk?i>IR z6*h#UA(5auDBSUvuewn*KP*h z-}7jO2JRF;P%Xm5JVjw0_ z_rJ@#c&Y{7-_ET)To1f|FtUodyIw=1At(TeEI<*{W>Ch8BU0Tj0%$7>BniR7MLEb~ zLQ7DvCKNgx{O|>Z*Yw@e68vKRDgM!S5J?x2upBxSb$j?Mt^xqy_>Msl6(bHf7lKlx zb%i-%;H`&}Ua(?mNEc3~Tv|%L`oOeyF6G}NnoZHx&k&`{pQ9?-={>@qo)uEWj5(-) zJZDC7k%VxQgaoexi$>@iZsi!7Ql3{r5-}v!pdZjVum+Z8{)aX!UCTns^F)@J&ru^# znsp%mEb#Hi!YAc{>k2X?0Lco#67|y#gC`{cJiQ!^WzH<`1A4ma5K{aZ0=XS$>rpnA z;DRECny#K;8?kghEMh+Z2@)%eqE}A3&(K_ni2^|GC8vy;fMV{;J%So@;lQ5(c$5d75XNg$=tn-AU3&gCrQa(r(fo)i(*4Bhl*Ec@PeX~G-D-F3jQxi0GBWl{ZuQ`&TMP7F1w0T&)=Wktjms=u15j zPn9ALv9pTc=unPj)N@pX-#U{Aw|X#*#;FsgI6tEC0$Z3PY^o3$PzN@psBb}3d4!Ef zaw%m>ONtvt2e&<%xX4{&g1R)#@3y=(md%8(hY?5;E)>#>BEmkTv?oTuF-CLhuA?1S zEjlgw5fDBH^nHyh`EbymTa|&H+D1-4Hc?N3acaoX&hj~TraB2~POlFYjm?V}TG>ca z2gflwm{JI_#!sq3H~HA0)7}+f`E7m4M03H#?IDM7>{rs@6v+vxI$&e+FjL$o=91CA z9Gr|9<#jK91X2rqr>fGa1p0+kW$6}yW5{KNGCmfbvO-teEB@VS#mwr!)T7-j`4&b+ zokO+zC58*?zEo*O2RTN*8-+puA0H*UoH0mzQiUa#Z>M_l&QRWLu{KCIQqQt@LRe?@ zLh@7f2&h>z?q*1621+3gl*Hv3qW3qz`8riFA7w2b(FD_w*wh!gnEvL{`-~T9oE>>H#NEqnXful>)dh$nwX-b4 zS#HAPFa*<$qYU;Y{7A~xOD8XuhlY=a5GaUh#6&G>NH?DF4l{bj_J>VeG%J$`hZ3H^ zh(R9a&}HXvxOkLak|Ilw8s)D^j$(QAr<9uYn8tpDQBY`! zR{)vIgFO`H3c_e6^K&rg(z2fa%+;P~=*RyzZ4hBVs5H`c7cbKc{(3QIb*o*`6Hg2U z3~YkH6fI~=k)PaESiV6#9y~8BS5!jn4883p!k~j=qiF+71^)5sNv9A#*)WTtFn}X4 z;p=1^0ODSd7SIMZ(KR+ITA0sjOG+Lw`!(~iGb(F((EMCmYkEZjdF#a`)bSjbTPGV3C1q^%?M5twwWdl0 z`rbVR!~xKdjcjhx@?#x#_+d~qHVZi5jJJ!KI5(y~Sn5eOf?-%mc)uoVuq` zto2<#3~#f{?fQNYgh5OSB0iGBq%ogE1rYcZ#wS$s2?bn_-cz*z^Dn5<<>maUu({XD z47$gg2Jd*$i9|3^Z=wE@k1{7*r2s6~tOHzGk=cLQfTx#FF_kQ>hbvLk5>cNnGVGUb zgzAB6=b3Uvyjp4K;dlKsKNfvB2IJ0CORvOsx(WZRW)aAWB%2TEii>t_FjFW^i9ult zI|64(LWHFw=x9y4yqCaOCfhG#!|Y;QCN)X)qY)-q^rZ`UP(b2=g(Xqy+HD9PQWZeP z0c1n6LIKpLQSQ(Pd*dZs#`GY+dH zOAH~aJTxnGu@v_E2h_a|#0M4Z=Evll$8dl~_}-hF3$2A*uI!5>($q%3g@e(-mm9Oc zUIm6@(Cg0X4@U!_fcK8p2d9u{^Wo>matX!}0C#{TC(=tCY&~x-B%NP7Qtn7=)BSX5 zs|`o@)LNPlQ+Uwy{c9U8&M?4f=&L``gcQJeJd>CLEQ&gy9Nmm2YGtz8=pwzCs+JOJ z4;T8#Zk`0zchb&6rj_>EPPd0M@&5oTU~5>02RwzkLq3u52Zf%Wu}h5;vPntplAEhFl!y_6$+splqMP{ADC+IV6E@rVpWU% zep1D>?TOs4c7UnH$cb!W90l^E&%%VI09S-aa{|WK#srsZGo0+fC^GV*Bl|na}3?dXzl{SdG-E z=(!8!Uv{@LWXZUGyf}-lF?F}CUHI7R$at5J8CESVEYIm1qAz4-W$~*Yo;x)^bMq&I`G|wRddNIFPF94!{+?JSd%pK$-}Ed(c`svJES$CMs_ZPQZB+md zd|Wzp{Oic0A%<>lWpOAOee}DsY*8o3X(jJ$>EwtKM_`us98Di5K~bAGOR|57Gvs&eEbKDZ(v~Q+cX2?!uQUyDI}% zX=nWio&mG*oe?)W7Q;FBL%O#~s>&}_&zL5{Xi!-kHz9$Vd#srvE^ku6(_lYK}oAtmnmMy{|k=nnSnqa#$XGtY=jJ}*-T zYiCTH0SBB@emXj=WA2>XAYmsiRi;&FxO zzCXp%MuAH$wzg?6R$CKn0w(7k_KYDSO6BNN zzTUu#Jtr~7TK3y zgC~Y5Q_FJT()Y~A!U6lG1~+rH^CZF+?yd82+G-AeOD34|d%(kOuCI_&SCI&!A`%eb zu;)uUc)zNpg0$ERA)mm;lyNBEoI0v>x0jPMJh@rk z`{URj9&b+~Cpo#T7=!%+>|Qsy76}L>X~FPuqSh*SMlE^FdAT**NEe^s`iZQ_I9j)d z33KtxO*4~MCC25$HU6=V%?r>1)Z< zPO+8(67}{|<5=@p4Bo>lZALiJD{ajzTBR>v8)v{x{MpQ_3NzT`n*0$cF?3+6tdc)j zG(68|lQV=+^1{GY9*g2#1u#6TfulHH@|L3{nMhxqH6KO9S(fe8!C9VX4O3Aa}4zq5qO?~(bn@E`~mRMZd23BF(o=B zd-t2q8|9q?YJIs={DI#tW?{lWMi5*+RDKwSsO!dsB=hunx%=Bo7TES=D^XYi@IP#a zZU6p`Ez%vy_;B}UgdY9r<`-Y4!`a(-wxLtooI!$LX6I=t$)k<$HFj_t75_()Luaw% z@Nq1Kr`5%R7SlIv^@ni$OItZd!ry>=5 zJT-@TA9%ft#B)7WnaDZ?z^0(vO*3J{Za1?wGsgzvS%{u7Ei%d!&%s0~GSRh4y?QyK zCm0FS$eN^L|26VVJKx=v+fo0+%7utqgU1Or;$wPmjA027z(-2M@MOh*m7tPVPqGQI z@awe~xdr?Xr4liFTHkZkdeQKuB|s8%&v*Za(CGd36PrP+`7@kmg;BP-(;oeshvet} zSLfef$(*2>tP;`7W&RlI*PSZgm->D)ZV`W=0i6Ob7Vw!)ANRJD)h7;Dv(Z9gex5=I>TbE_eJjwHra463X;lRq$HIa*U4k=Z2%NGLLe(P!$( z?x3RhgCJ_Yo)N(8$3&q=(Tk*cLqF5TB)!=${qz+)+-cv6<{p_TAX*npY6#)zEQGW6 zkHcl_Ks4ZmTKPpn;tt0Fz4I`I68EX3x3gvpV1I=zQo#VQxe60`_aJ@nG!sMw?+q#z;P9ZHwdAR#e96bU5+ zK|oPK5Rg55ulstA!~gc(LFXPEnw_>!eztmh8Go0?waUe--0g@^$iXDD{-gAOtQ9sH$=onxL+C91`p z32Db89WOT<(*ywJ6?#d-B%kFc5zzy)&E;>N1RqdPCo9n~N^b8{N8>9PDP#CPdz0zw zNgn4`^l1HP>D5_-TjpVI^XaJS&TXAmGW6gUlu8-jMztkWMAuJ<3dW?QUJI4|b12p~ zQqZ@V%X+M2q^oZ8jrwkfdn{tMewkYl8TU;nzMGsxWG>LCF znmHlxC#OLqUr1N6eo;(&xAs+&L4oXnea2xWt!V?9+qS-a>9qzD8D6QgS59syzkR23 z)Wxui;pU4*ZX4*JOe@5}HiJcjo*#Y`Ld~qVbEw@skV+Dt*qdy*H}%P~}M--itmh{VU3sMN-AHxP8QtCsAi3AeMhHU-%x-FTRi(#oA>qoDFu zb)L2-X1IG}n@e>`kC2!e(=d+njT#ZurAMrOc$>qLVDw$iN{SR4&MA3q6Wv#a}yaKcaL-T=;@98?w-!gsF6If zD!A%Vrm#l(+Sf8YsZr(uY16+=ySNPv8gtpUa;LbjGnCvcJLrxSM3 zCq6d|+SmvW8f`eCy^6#g2heq0=9TqQQURr!C^;-v_DlHG82PGLf9P|c>UwE#g^WhW zu9tl$ld0IyM9(>}SJs%TjsVGbCHq8Hav#t=%iiWKY@eVX_%K@EQQ)&SA~5jhxYwck ziEm3R_0oCQ=x^m++~VJ9hMHdwYHeB^#XQ*nC*eID&UZ>yBsXGYuJ)NXt$Ion%c(L}mz41UJ7)J9wT+ep|fNzACE7 z=(jjA7u48rV7-#5=q89&;564!Uxc?+ge>!kgg(5{YTS|QRxj90?dn*Enr-CWBc=q9 zPZocZ-cOV#-~yA}v&E|_D*xU$=MH;lS9r|mE4D}0hA{LjKH9WG0qQuaHC;D|@5!d_ zsNTGTl)5t=o<>buJf?YT@zAh3OxoXst#;sdH~Yt-c$XFbIL65Z>1$KF$@=VcPe*n7 zYf_cZ@v6CnmLK2in)JPIO}VI{ucA%%jGB{i{%e2cc~-mk?}yV_#Gl}&(K{|b|Hfon zzM6WL%;M|n0zWG9yg44hCHU zrblD|c`BrA@(r89cixNjTcgZBvQk!&hvuUI8d4FO0OFw|vLSL}6t%5}A+$us-&EO$ zRm2m-5$bvV=!@0VihKhFS3%XI*)>UH5Kkl)QIw`Wg91teW!F5l<|+Ye8nS><9{h;R zRn_N+DuF*PyQl)QzDRD04zvkvf`Z`my% zH;AZ*vg3%E3MddChDb78LvFX)f~Lws*XB|FPV+4<*PtBp?}TdM4o|y{ za<>_f%;cv}x3pBSagx{(0r^p(o;Y#qJNhN;b_35EBiJSVYi_cU9Jwn3EWAArC|HP5 z5J!uv8$#Q=QrIvKH(T6F;t^8fPOq2iU$ZlGoDy(n;VHHTeZ9K=E{3QG5D-0f^OKD+ zv7(-%Fm=9|N88S^RZcmdAB5fs{cgvU9LL{uOPcBRttOz4tef_U#tnll>=-LzIT~EC zO`x4Y>VX&#c}Y2UXJdcCf02oge9nPlv0c#gB8YoX2>5||MIX$^V9UAO%*zi&LM z=CwNaYR+5g)YG=(q2B7!Adx+%MBW- z+;gP$Qhd#4YzX4V@rF;o{f}`LX5nMekPQ(q!q>a^dB;)kgi7jE+p+XI3iPXKDi*0r zFbIZ=U>S8WZ0ZRJ)X)$uv1;9@3=2r;|8Ufid1 zgOLvsn+uGgmIiG`UX88kucPdy@9=lK$@|d$}Ms7z8W$pkmN?JFfNuW zHCBXsR60aM(X~nbsEGdCeGtXAKT%E51Mpj`#6LKil0RcAMWZq(4T&`(A@5i&&k_EX zk(9Tw+e9GINxBLiCQEZ4bNZOI`9~!Rw>PC6m?DF<#ZNz(Uw@j=avUKh@ zT#z6`tf5q=p;#3skJXS5xnasd3RN0P9U96Tpx!x-{l10@W4n@Uk1c9gl(aM_dlj1+#-g!2~w4F01OiA~HVqtfJ&Tn+LK_N&iT2SoDD!|V1 z$8Xjbc-|kMMa6P*5Bol8`va^3$cfQcF94GuxG)Bs7u#1;>LwmTbt7|A*MCqUxQ0orx3kP~byxvm-mB$j-P>^BC*Fbuo-<(nL`)7L}l&h8gz zlkTZO4hmh6>cmwqbdWdPxVS!=fEl+fB9TLxoKL3FVAJK(sHIW?XcXJct$$Aq{_-{a z%?pb|G(xAv0?>-QOH9cuq09dBS~SoEp9EOb8%1K7M_U2H0E93A3>XpX1F)U7!s^te ziQCu_k{tAH9BgeA8$(hol3a3aT&j}XI&EBcQOvq+JT8*FciY$xhC#M*ypJXM6NA{n zKsc^Vpfrg4K8C4GQmFeEJ4hWw9wfn$(k2dzzlCB!U`13@P)H0#o;osoNbEI0fna8+4444QrQsEF~`_MJbGuf7Y&0+Adj% zfs{!pbxX;b{Gsw z8%}f>&Ucvb8*j20>%lNaQt5&jLqr(V2)@GE~AE%u`4{K zAvw0Y6tkr+a`14_&A>V$h@GCDT5NOz>K?SU$aH@ybQzsjCGJ9zcR4*%BfSbS)%fG? zvh4DeKz7HV3uW5nReNfGz~GTMX48$m3q$#M$hyp@Uk{x+c8aU*jS_XlC}W2~5UlUn zD3Kw|sXBy97fTwJ(V0+UzsbdztA(xw1IqskN zFccdO#m1mP?%VM*?QaTwn0iM9Rec22_6cfFAq6(8nGvA{P@MS{p*I*&G_NrBu~$w0 zk19jo8T*9=9tDSBtEkH>5AqF8$Zi!Pt4%ViUn&&6Q7DdEt3gcU{~(dYMmD}ssChif zTp96{KwR!Z?{g?A%7>L@0D>Xd=k!>}~YJm$+vwwu3E zPhNaIL6JYKGS(kYhqA36_s*?KHlU#;jUmC}CL*C|I(N`CUNmm1pzd)7w) zb-W;Mk9*ku_+_tOU*f|a^~2v;FaW16T$rH)fP4kmQ=>wFsOeuee~!qfCmuzN4Z}1? zzMhPOFUCxip4(_nFy9^#dQ~cSHLCNfCir2;*qUl;)N9z#Yc9Ac_1NTxi?X}5*X%Q@ zfDY8y)y!|yEDSpeBOdeU?PweuXCuZlhb&$Ok0E&sF;SnsUG*19>s5{tjj5^f10Q-k zVv!zVF9T8Vcd2&WUa@&3=&qdn=KOt_^25@rMV49J?$8p`M=M`RR;AM32lsz?7P9>0 z(MN-S>tPRvP#2$G_J8h{{tv#tl9kPqUf&kq{Hk2_Rd4I;x$+tewXJ#`07GqL^?y9u zdB;3ZRD7b=F|6u+{ki@6gGuzxOX8)lQ^%u@(g`4#{g@qsJvswX8x9eTq1;1H53|0o zejEVs!@eIx8*{0KJd0lW`p=nt@YmM?@ZmuF_Sg?F;ex9BuyA01koXif_RD1ufE)&x zrnbpHK0KJ;K}?*-4V?Z^xo8}W4j4SX?A|%JGG-%20nYi@DH2IoNy*r~k>w+Id0ESF zbpKaj{r`>d3p!37Zwx+$b7^<*wz`ie-XQ#IIAozpEQ3Nai-08eRNTs!Vn+o$_nT+5 zv*jLpR5i1OB=@(ty?yR#7OTXu7I`7KHOqB*h@9@tI4-2SwAix?BPjxVDf1fQakO&WbM3%c1H*AW$)e> zF1C{MSsDm@)0v+iaNN^L$x0u6{>SK(?K2J1??t`ui^qTHn-s3OJviX%mLgz9t)g7N zZRi!y=P7@`Xj+F4JXw8mOCjK6gPMUh`7=?cdsXESaRTj4C49-V-AI1FBiKZBzEy_J zaj)8DA&j{b`~hpP{N<*w&Pn59%plo~Q24;UIL%!-8JiNb=-8enx9Zy-2MvAKV-$^- zw;&hqXpw~SrhAS+MW;|%X>tc^TvQPzfqB;Pbp9tL2~@cdYMf)}K93p~g-tc;U-*A) zJ9{u(;gbK$Jd-Cz%1-^?SXR2+2UPHkNE7m-y9C}hI6VulmY<#NX{J!4W%IfwKX)@? z-z||1imY)?fzmvYD(?t_tFWYXnJ8^}g3?5r9b;=m@l9m&Y6+Z#cz)aDI~UYdv~KzD zu}`-IKPNt$>#dV7lpalw9N-L@S6D?^qzacAj_6A)hA$ecwnAkZZ8}#j=#2Z`=QLS4 zZk?F6G^W99RF^PRbNauJf{kV8{xb#?n;yWGk=nKX_tzs2m_pN;&cu>-d<=4eS4TqN zLN7)dpTkKsIo_(gaNJH6IqM2Cl-Yd8bue5`BHR+h%|-LvqvAo*(nz<=jJZlh(eDLc zDdLSWR3n3Wnkt!0!o0!852*j}%3ph#uoXi>a!^iJ_^6EfhV(BOo~TuV zhziF>Oib#SA(HtK51^jr>5y(WQlfuvgj_F?Q|!!r_<2P-&no|cJx<%GK>UDio%4J) zdzcahA-20Y3{?4rn8+{MmXL`qVnKqIB?#ik^@=wMZX=9V&@6|AEN`#Vtll}rL)uNr zmtNWHKs6X~bDK7Me-_RB#~#NU>A_OQ=zRB-m{{2F7>-zo#>JWHQ-Umzn7!?5@j>;Q zNCvVbqE?+6XJstIM|2r6pYAX;bc%+q$W`@SV46pfJ5>i-TW%wBn5y6y%fk(Y+Dwkn z^|i#l*8QN78&e2bHU-FOrjhE07Z-3NIbV2`0SFfy!@e6^@w(C+q*)NoC;);!f0JRJC_<*7(+2NyHz zt1*!pwe%=lrud&Yrt7C?bwoa%X)bDCh!Ay@o`xRj=Jl0E-#6iRS(<4JsO{E?Zqzwc zk^v9xikaKbG~}QXoL`Yzh1}XYU58vO__Fv8X+E8pKy%lUt1k(xT>69ct>!J;C0aLd zuJ!kC{8#c5(m|U89-fuC9(~o_LG^DunA-Hu@Yq?pU$9b{iM%aIUDfx2a97tYn&~~# z@*yrG2ebA9;gpq%uE1m~UhcbeqbrVW9fXWfM-BS#2CrqMlL|xcd@DXago_dKXkAet z|MV;r-2kIrv@Cc2Vn(%a870L-#b*9c1AeZ6Hp$HN!vc@wME)+y?qvH#&Pya%I$ay) zJsF_LPMfPs>9e3A^3LJg^*%aXjMRz78Lq(25pBlYdmjRLg(=B$-J%WniqdCr?wTERzDK&(q*x zeqbNaM$`Shim_`_Mn_SEyh_~}Zj1*U@GqwQUDfCJAkMJSrT(@GT+lk!)D zm=riU;<2BcF_}&&aKitU$99uEkdP+z$9)j z9&QQ&c+jo@;>;fp-H4p_C6iy0z7<^@`eo(h>i*(Ur(VQxu=7c%aX(}EjSom10;SO$ zq3LP?te{B&Na9i2E6!`U@R+teUKUwElqku|us>{`Peew{74Hk@Wo_sovy!@qAFzJv05 zZzn2vN6dH|w-SqRY4F@He~$5{wvtd^mLuw z&X@#JHK&1SJl_&|ORJ>|BXte>*!RK{YvhV4AKz51J2G1RhU_w3h%vx@9&(i~GjhY0 zks21emIq9Z-YG?a@0jud95*KqI70Kot3RCpei4A{StQ>-^lJgmKPjU}c|uHo$4Sv2 z%qLqIUghDnWHtMdc2bG&J98%~PVZ5&9G9`(#>b#m*pb1N4(r;yxR;B!vhSsC*^)qp zZZjpWmsK%5txIYaISGf)3XZLg0Kz%Y8kl zzhE$+KSvIaS83(+2qL5fW#v{_b{09P%engNv;!aaoN5`JpHumZh#+YV>e`LQH}}Y0 zzv>z7ikJ6}lI5oxIdXl)t2D%4aHQYCZPCmzG@zV6736W<;?NgU;8+bzzO&Z#S>y?%vBPW$@ zB0Bfq`3cKKT8>iZvEL+`u;GjN&Z?BVJN7Tilfq6P{YpAp6W$6;i=iH6UR>Y*3hPQG z!A8F<<(c4Rt+yDoh|XefPNXD5Tz1SwOS--4PyPT!ShILUXRP(5lXF(>)${2zKh(yX}7Y&Na$_3K}w?M zv6Iws$Ut}=9$uG7Ee-$%wS@2m8~nQg=o4Tc0kKYJVk4GV?Qo$^I;t;7C_ckUUE)8w z%iP<5+m`Y?1Kxoln{tg2mlGWsW0n6CpGlQqMu})c!wxz~ty`dCF>xtNkRZ-b-<~)) z5V1%=Lj}C!GTs`z*o=?VHB;E7`UiklpeTrb0)fc*RE}7Siin%hfW>Yxn-4Fup zW3XG&GsuHi)zq7)gny>Q;;xXZT$RDQ(W%~)%FoF2vf{IJ6>BY#ZSpC}x>hJ4LUbfd z$PM>USJ$x{f#y%N|H?X_l}g&0I^(UZi$h-F$tzpZxYg1a)ksv>Ay2`nwP#f6lVnXp z$q^c&&w%Nh3{Ofs=|0`~3pS#e%hTxsiGUc=AKtg_V2JmmLWaYs_A|)yFtAm0Xvs6} zvhpXFc^PqD^hbE;(2(EDOxo)q65R|4ivUYqwLQhu6S)|~2RyU_06#fSsmc~+BJ@6i zdW(~1BBs&ld}{hQ;?m}@Hla3f3DUPi8GkRf(b^dt~S08q3S7rak><;t6%LB4Ow>JXSnrG&?P%ymoQ}h4H5kI&mq{m2^E)T60hd1LM%8@ZwZl|sF z(CoEko$*s%0pQgWlxhPx;8MQ_Wk&d2F%^vM&I9VT(B01kVI-et=$B7r1(jJl8 z9asR-4eOzzD8T13{wxs3QG3@V^!&{*3A{=6LW@k{3lNp6dP)pIPqdlKWTqE6J(b85 zh_EF!N`Ii(2GYLHe@eQ|vY(&JI4oKquJjlQ zV8*8aWlKLj&F3;hEZww7E8>H#!pf!?K|V-uLDDz%8wmjUUjT(~2KX0QjC?E98(pZD z34yi%Y4oYQh_vR|lWKmK8%h)jPiK)+R#4P1p8?35(ZcbZ<>HwnK$MEQ8wAJ>l$rhy z-n<1UCwwI@bA_!R7Y)7bBDl(`~=W%Dj^GxA-7nQOcU_Mh~H8prt2IL(IZqbK) zhXg<|)g;4+RTQjngM2$)@+W=Ch=QU=GKZIaiU47hq6zsF#&NUylXJvZIXo*h-$Xp# zNT(X6n9cAT(5rhiRmlY`yGpF1HlxjxuQF;!Sbr#OuCCf|C1u_Kp+@!Y1BlUR`paYS zB5`;WpJqa2-E;W@s@A%H{Mzey43R*+PF>tHJ){Z}fcBvd1AxqiYM~qyr0>a(kVQYF zn|_1!X=9ph{nf$i!r}yxbCI_g-AIfxa6EDKU?5n_6f8GfC0^DHqeS4vZ*L-{Cirsb z_ityoKfmwAdfHt^IbB0G3;?1_2i0DfXF{woFA`6Xe>32+DK)8XCUb zsZmm^m<8k$+MlDyYg;HT_!?8x z+sEpuOCrg}F;x>EE9>;1GXgu5$2q+1;mCzHxJ26*t=6PIx-)TjISTd(z`>&Ein8zI zHAtCCrb&mApAB{L$r4kIzjzOXy+Z{NCl}#bTbnjoFU4D4)Ol3*Qd-|P$F&s{m_nVI zXhhvWioudbElO`M_$$>Y?s3(HWwq|c6jU))`Mpd~6QbS3kj=SfMkye#k6|H^lFDTO zA#`uG0`nm%bz+EOfg`2-($%g)G)d^8Z6>rA4^_0cDz)sD#mGAgHGqF3&j9c;0QtkI zn|ya1g-{<~LK|%kyzDpxO3>21W+&y?Af9U9T2EsC5|z|PJMB+lM0w~1&0bg4X4gpDCsR-t#92d_C>1`VjrU?yMq0GG#EEs^GS zQ)*^Iy?ZYH5yb8B%GFexmqqwt(fkbfWC|_p9%SPfoPeg{!T?jn zaN2|T0qef_EWJ|wLaiwlFxg)|~aK;|eFRYtUq zz9iyi09zk8ZP+eSX@bjC;X!tJtikN`^Z;*pMdrS zmxDt9l%se6d>uv6$ZwaiuGy19m_g5$zZT)Jt^p%knEJkiP7jfDeqp{era*W; zV1O7%!GZ5DCSyz9j6>k9+6;MJF$B0^?zzu-?t9D{aiY9j0myAtGZdQT0uH37x zab>FX23XXyTIfa>h@)38gN|hY%*=7$Sp_+WCNhThVhwmd64;?b=vN6U+J6(j(ARxo z&P2@NlRy%PAWZA5?M-%^1nfp)fP$-YKpwIWQJFapPa&@{-4li_c`+V@A;eO~v%Ti+ zjyO!lKzdAdPf*H~V&{k%K1LkkCS;P*!!+FL|S9DM!PFg>(F>HrvVBmPEf#d5jCkOvopG z4VgOX%AAhaDAP4)3h+h#XNGF|!EK1T`rhlDc>rG8k`JW#0Xmw6Q6JIly>lh4SZ=SF zItIJ#c9{0hi2NY@J3ckuwi5m+FVUf8(3ht-A43qWk^7^)t`#|sd^>eZfRW;-`S>rT zOt_J;H$8zWCi~k1UGZ$;xWBjIyvDPchIA@o*kym6W(;h>_C(lCRqDsQcp!%NEhN_U z+s8$UA#rHU*`wd0rvg8IB*RWZ?e@1^e~bVXH}?@z;-IDy$^#!TW5IZ#T)$e#1y~Src z^b?v3=f8Y!Me^9_7wwyMSZcUAD4I|(2|`J0<2>D)7Y?(fG&C;c^=!XKCH{qRfOSnT zhS)Af9-A#;$Y#;kye99%D6e;AuJty50a}fRQ2&GQ=b3J*C&0<(+H8(LtHx6EDgF<_ zkEK^|m%j6zYczaZ-HUlYuyQ<8gwcNSy=k>Ufs7wTQAAd`K(Ro(Tf=(`ej^-}fc=bu z<-UHhfrcp0L~gbUf%&9mu_b}FC|HfbT}d#+^V>tfeMnqsY)+tWmyMNoM zb}}ZRF}(F|tP`R=p}4@`V?vP7?FD7J++FQ~ezzRoF`)rW^n2Dq*+;BY`& zX}#GDr{{Bi^gOVaL_H(`;$TvxB-kKbDQR#PF*;7)WENJoJYb9fq>f{y<41jxRh%LzY?G7vOUog51 zKwBZMRczm}j~W^KMM~p+5%{*8j;N(VfFbx5TIfr5@<D z`1Cd{ht4ojVnGD4w+@}%a(Re8?AF*xnWaoKZ1lUW)OS_~@BBrrGsDvy8;AIJ=;tg% zy6$Ds&!;>K^p5&u#vLD8h1NOU`jsv6{UYX0mYNWj>Z8BvMOT^C;4d{G-xWvQEql*< zd}dDV<*sHK&rC8d24RNFeA4V- zWs8U%+>GJWPHs~BI|7xqvkb&TL|}S?G5AFelW;~ofadl=-zcVi_eU#KBE)i(P! ze)pSiO(P$U?Jh%h(e&|VqS^VcfQxZ9Ycqj3oCeJ-jw0_9crexR1^Y(}{RSUP_(s2B zIOJpL`Nc#rA?bi%o$H}BK(qH^NkUw=opRl%N18SBr$F5JYS{}#?~X(#5cO640+A6! z^5&s4NWHa`e@;S1yWjLdeZ?Gk*jI_5rsmkNtxXDo3_aUGdNkQSDSyFOW{uw%u0*3k zKbv8g?B7?`jvkWv4y}<#dJ@SVdgZ1;HMykDcn+72Pqc{|84~tybr_&q$Pee*ay8Er z18JsJ(kaymhtMaFVGe8oTO~vfxTyL6F0VoDM!GD2N<}*24!g<+%5R(dXBx6@eNpEK zE#hRn!c_3e-McNwX)dtOp!MkwkBmhwJcn4nXzUL#)f!)UTd{~oMCqPE_1ZRF8$aD0 zRMPPH1OG$?ph_9$^;kf(%pBG8X#!M0CHj$>Q|lZK?$WHHuTFR)b$00wj+mB4zY-LkMBUm_pgpoSF!> zJ7B{AcOK?4hH8gKyT#?JU+gEXwnM2N^*+9_k|jxk+Q?%#Fp3LEYUg*~MF_Lp7s}pQ z?5F0=4q`m)>TbtrqvMqvx9C3fOlbKB<-A<;CXel%kM|F$R$BM2Ql}XgCw)+Afb;VH z@bWWBKzL`$O~)||L~$G!zSOvG?pi@}Q0>ocD6t;q`310z#K=;(W?b%u4HE6Whz3(_ z5a=|?z}hWTCFO8Zx#eL*0vgM6+YM^7JhFlsi$CBjBC;e43lYir=D1w+&Hk;N%sC1)!J42Ya@)};!4QKaV%PKp6Wl$y#d4?g zoPTAOuYGKnt!naaXp?4)mF5uKY34|=Jdbg5N&6xUcJ2`*SC|N5gnRJ#e!H* z;=qawy3C~Nca^s708sd|(HP78Z7woCPyseMN9xZR$J z%#mLgZzcLBrs48^gG3(ya=n{yTlvt1jf^X(1)IWQC3DBiKwf-!u3YEpu&PfEeR6fz`> zaG`Fz8}sv}?-#zWM1QNvynfxP?OFWEX_|IMZ}Y4!7$ zQ~G~*=5NQcPOTKQ4Zk2)kj^Yr+AXPLby@t>=Plcp!9{%(+`pc~n%8}gM>Kyv>o>w^ zdKn)_8zPOP7DvVxNX%T2&nV1v>f{AuV!taY49FG~<@0kr(o2q(A0)OMBJms|4H*J^ zqAV~&WdDQk!>WcJ)yYQUQaB(O&SP*2213q#gYXYij}2v@hG{*ANr=Hxu5lzZiH4?$ zbl4&B# z8p&FM>BbQ4j2KJEQ`LoGD@AD2@<5%%VDji~`g%%&p+01OJLgJDmdQNXMLven6?b2r zM5ZDM@P)3GeNm*_r3k`Y9vdZ<~np{aQ?R(M%1o!uX* zuUWv*Z5A$H%P0_FJ{sjdsCPmh-4pLwN9ORZ%v7`1j3r}rsNC}QYb(RoC1) z824bfZ_=RD>!Fc}&oBk+B3=eajNvvebomJ(H{*4}iPoYWIl3wJ5uU{EoJ#&(c2T>w zP#>90WzzKEhI0Z7{%a8)yv%a!FjFzqf~u#qmq ztt%PSE6$Xbf|nz(svZyOYBY*qE`SA%8xExPg6c=_&ky0JHeF24?q zf}m?t=Qm8^1NG?#o;oia#^Y#8?a_(u-tl4rhU(Ig3vq0>QbYb&{jcL<@1UDk5}skr zj&wtV(ze6`79(kH9HTric_yO@049(xV=gYK!7-$EW#b7LBbTSMQkV2gP3he&RsMi# zC0in?H5ru66@lDp>yGlz1sMMg#*D&@VYA!QSV$1wZu zREMD6g&H)c$|9-FB6SaJ2hqi{TL{Q3eq1b)K9xK;kap_P)WceQx>q2oH6`elXoxn7 z!@cw0UmQ@zg9;^8v$&mWq1G_V?Yb$EPv>+V|~x?rO3 zm#v$Xd}z8U6b$t`v-Wo!08Qg_Tdr=3M-r_l$U)>2nbLK)(_vfqh2&IkBC(OSnn z+LN@{u?ab~(d@7ySa*VB{BXvX(tK8>@eNBbGu;YAmELp_wq%{Sz~7R*I&nNn6Zhx^U{P!UdAmpTExo7 z08nv)`=r)@6`WVE9?uHD)yIdLxHmq?d+Yq~j$`Qd^a|7LfyZDr2=I`Y%5FKKi)^J@ z*-m6tHLa~M^}G!|iS4Cb*=E$#jJMaiMJ9-jov4BZGLYCetr~Z}MHX|0N)-=*RaKzKV*vq;)B7sSHf=4_OIi;c_*LbyzIVrrsBM(pKO5f(q_l;(g9km=y9Y9 z2FP8OLb-=2w!(!@Vmr|;uL_&ab3TW9>Z?{j&1Q@Q@G9uXU zOYph+R^zus5*)Gb5b4#*hQ_p8W6`F%UveQ0U~slcCyVLxx`LNP+B2;17^m=rdlNxQ zMfir(pg>`0^5WxMV-;#Vcx_wQMm^}>wA|j^R{7&WrX-=to2b7LuPW<#JH1uI`iquv z>pgrtJ9As=kjS#T$ZAEiesr@6GDbx_fdL&87an6uw?mI1IhWk|5%k=`ddKR{&gPb= zHAR9MD&E?EM_>rU+LG{tQ_OyM$N9aeTMyPUPi((IEWQpv$0~kB)e_6z;`vAH&<;aS zs-;1$Q(62ubuTe`Pud+IbKUO}y9efKjX@+7-FiRkuaMw`U*XJ>u)wAqj)yR>D&)2m$q5O8K%~ z?YC4i9Y)?8qlN;rpf?4KO`>z19}nC~XXv&-&!X66)33hf0=BDQjMmGfBRkw_7#SOj zPMbm*n>Y7>dtlx?3<(Z+fAZ^(w=ds3bneBwWAjMOy!Ft_poj)xp+DNeqH`IWB#!J~ zpAGOniKBXYZNcaD?ahNEUp%(8d99F_ttomuLn1*B>D~4H!w)j@R_j!X;-ng5T=X~h z#En=U`E|Q>{zU1uj8;CxjTPhFTiVt&_dmrCoByMVlsAFT2F`#8H^~KbXB=i@tw{m>~}WwnG|x z`lGK}9MEyee0c|VkAXzu7DVR2$4PjQg^-d4N$2I$@G@(Y(*c z`gNzsaUOs)TzUUR!g}iDcj}ez=bxYkf+~Q!f$*?BdV0)#hNEx0OZEHNemicPB|ppM z!A7>eHAi>Z!+t*4PY(8uKbteeX9{stA(t%C;jlo31;^jkKL}l)&>Wu=_3%LlyN6FU zlFW#M6PiCu&_juDS$+ZW%sU^)A15j<9~x4TKtKFsB6+D&zP1Ms_H7R?=l5Sr+l=Xn zqi(^|sUDu3&l!%85PU=OZii^vED8h^QGbB^FfP;O!zI`QM^(PX=OrS}y9|R8W;=c4 zN|g(GB%K{Y;-v0(?In8R13on;S&7FfyFSRQxivaT`pD~WAz=m|hz1=!a7j!cLolnj zSQ`bx&X%FPYW_hq62~`!QC#DVSld9rMS{VH;8{3+C2_9 zEzGl*?m?FygE{z#GTP!xXV3ez`^)RXR%#^i!(lU*h*c}n4-{wvLPR0vXtOwFj~C+P z9Ud_6WBlMEJ&d`2@NbRVC2Rz2kB|4ib}H2gEoiy-hzsX2nZU<++5Os~dh#^BGMI4} z*S$rb!(kuIPFfojE`4*PX2adFHUG|gJ_x>|oIf^mx$LR9c(N>H&A)^TyApH>h{Ytt zQuFIq&pM?3%{u#B4T&lfZ9u{|auzQDsCp`UhTQNN@Cyjk9DRxn@TPjF{%nRsGhYaWp0dZOI1FI{3Mf zFpsFZp6R|m$heA`r$&7lR=v0ud`BQ!CtQPZk8cou;r}VDlidAivG*UsPceUQh4<&y zcmxo7PVFr)FX*u=YVJTn!8M&NXye>bcb1N4~!eY2MgnZVb7NcwbbzQZCF)!@MF;^F0n!W)xDFUehLK3`|$HeJ>ExI&LyHDr#ce{ zi2Jt|l~+#X*dxA|hke3aQR>=0gwm0eMqaTj>SOxX>20E6L^T|4ji=j?;Qc_|GII*W z1lPyBHFcb3aOa+9{{K!vv;0T4-ZvOmn|y^?_=;%l1bPok(Ul4A zn2*?}b8hklQrup)7qxJs^$n`3T!O(|wWqCagU+20Q`wy_Za$*RM!cI}cs;EZf^apt zjcOoxo*V1gt>TpYk6DF3NWOhF_x%p$$lb!U!OgE`r8Fq4Kh|@U*gg+6kbA^gV4s?A zEmId(#(Gh2mOR4m6XNmn9?jzoU(fxVS0CAdOn=ImmVC;Fw)dZ>NKE-yR+)ziT8?ox zG=xuzLJ&f;Cm><7-|}iC&9DBps{47vd<#P8n0VV``VYRU zbO9_%adl38%VG(bZIia$gotNyUD*%)oqQVJ(7b%yr}QJE!8rkK@)yZvp!_$tODu`# z>lBZ4k(ohY@R`Uf%hAF7$-P>Fud!i}iByR?qMVg$JTO)k5n&?~lujO8nE6fEYWh`i zYITYjNZC@x!oMz{*_L&^)Zo~assdxs9kKaNo7T_a0~hbDKZSvJ@|os@eAcrJmRQ>N zR_F$F|CqWIGRc`|F=EfmzF?ltb~x1*f5GRX11Dldrz$=SM?DkbURVBT^aU>>SJknt z(HWfF5v!xj-RMY+SKk_Tjr}p7uffu5l=bZO1%`Z+_+`S>ew)dTCOmor{T*_qdAd!` zCu==_^$SKCO!lo_tTUC204r-TG&w(*S2a2`0~VeKJkD04InVBHTyo=a-oMn7MQs+O zJxbTvHh>F;N{D>7iU-Sx>%hbD)QDJ9ERiV@nADY;D&hEnlKw`l=y{cb*6SEVk-oe* zP+;beLRoUmP+6QZRlzI%|CFKd)LfiqNkrbGi~v_^Ufw|d(3UvX=Xv9SuPRfVuQ(Y- z`Cm&sZB4y%ds~S!hC;fnHO-X`0nBVtD_@SZp;hee-MU0|A=-JPLdo=4E4e%h+7E$4X@ zkFWC^)N@)4Lo2#OiJHzofjV$NuVyLdO`W;V1e@l!a%OS*LvKL7NI zd&`#1gZ=Wnt1(13drY`aFR5t7Fi*Lc7ZLVmlV4;@ov3bELA1eb#Lr~rHZB#-Z^1q; zUYqk<`A34xfu4+}8qbxbsSfK+P5ihex%yg(AP=E0Gq#;Y(Gs{Xgeh^Gb}(NO)rjQ>5mm67pH*uQUQBINM;$TXTO zC)89gjMcNi-+wBTTsrxyeX9cVnzWe{EMZ6$eZLXRKlgJfK1kd@WXX04M{2H_ByGmc zldi|%Kpox@%W#^KOhnWIZL&i))c>47CYVxt@yGGHdVO19ZT$F4Pd1@OCRy^Zh zS=QkHnA>^vZC7(uMDR_sLOTefa=MhS6OOu|8 z$AR#%r0gpk?=;Q$@6WaN*wEe&;<*-S0=W%D_ z=+M*FAf+p>U_%wxndCLrlCj@vN*HSfxr|JN&ULr}`&)_EG*p!^>erf@_3Jxkd)Gy| zlJ5Hj<)(cPNU|dB3f^dEGh9XEQNM3R^66wS-g(d-=YH>-K+*>5)y?ro=4L9T zb{h&eQ?GuohHxtPqHGM*Wi)BMm5i(N{|byW`p~9U7Kzl#sYf-+HcM}yOOvmjw2(w@ z-XSHjnkw#Bz2)l{v_?$*AzoJUM|MR z&Az5gvcEtLE-*@&tX;Z4_@9h6AD|JIew!q@(;h=vVp7>AeV z(F`~(opx$Xc_Pm;^D`%VlyMLNgYMg%3uagxu*>DOe~~ZFy^-xeDzX1rH2~@}1bGKkZM)zXAQL1(fK>q_2#cDz5Aj@wZyhI@cG~W~MY56rAdGmkt`2 z>hhL8cHY``D=?LI6yS@xblH$eb`_$q00R?unb^a7U(CESf!8~|XfF8Dxn{a}QBPKr zfIs7y?@Ds7>iwXnPjktt2)&0^PTu8vG^{T43{_^7bfaLJ38Xxu5)q; z8Fei@7meXC`>ieqKm??tcyoBYen(v!0AF#1oXlyls#$9n=zC_X{c`)l5cE+goEmFO zp@f47lGJ1k?0#oz{bx<6?ULQ%@e<`zzdX1d!LAV$qwY8lvE*~xaIxR-{tw1qRnx9t zcHULL5uqlPYaL81t{+^`6F1NgFYM0FFgP95?CVutT<2d@lbv+TB=su!s7tK7Udvv; zgWjkdcM>7hDBP-|MzJExF!z ztD&|>KYY^D%+)I=!eNYb;kW&+E1dH>j%S173Q+6-i+T@SFDPXyVosyPhIZp>*E^r0F0hT%d4@vRi}w74s)-* z9~eepzD9(v$tvGgmhjkE8;!a+{*=A)yUeZmJ!)CrDE5fhXBTVTG~78D1sizvg@EIO zGTVx~c@5x9EHAB~RhjS@BoE9lyA0Lkdan%v68v~wOBIYld@K}A@?HJfLVcsf@vp-GPXBrKSFCX3#X>zY@n!f2{ z;$384&gfV9?ukfqR%LU(NK0vDON~ftQ)O$rNLycJ+Zb8o{j|srf?Z)`WfUVCID~Rn zr31k@IS_y(K|d67WHJx>M2k4Fi&~#~8^L|#n5uyP+q+hr{N2phzEjzMWc-hXWP%el z)Di8RhYki>^xIapInH)I*##k@2hFM!8LKF>!5znf-SkGOJ3b~OEHuvvh8hq`e=`+P z9G@dZmXHoW#k$0O5-hgICSpD@L&x>TRoHze#H#@fFnG4}8Vd-XE7-5Mw|ng4Cg*Ex zCuZnTJt0{Q)QZ`t?S0JOOI3)Sr}Z7Dj$R1dQ~6(V9XGsLSZq;cf;-IJx?XLlzu_o|8i>pv6F1(`&Uy{N{U;AzPg1{*1@@1EejNPkK4Zoj{y$-sBS)D`wm*dWXd1fN=f?(3fjU8K_e(Twswu~+~uyR z5f;x1^4C(D)SA*jBYfn>BREMQLxegcH$d~v{#^3l*V6{wSDhZ>9@Rlc13Wu)Qnw*E``PXmCCpho)0 z4bS4Dq~?#HYElxmZ>p7lHK;7~C{;RXs>f=s>^ZysR?^0*KfL$-DIQ>{SG=V0|EIGt z00iI#r+@%B8K8i(>(mlEqu@xewcI`)#yR^>*Fdfo41gGfycXZpIV6Gxu`{ z`A1W_btW+S8CWK(VAgcva5AIiglHMV?a`Mwx+6Z;dtcOOFk!aVa`js##GqRm*jl_g z+Qraina{SdvJ1keM?iOU0szgIdV$5AH=9g=)?`!O3+&|>YQwqul1jP`gO@UY%ou%s zVI14z>FABx&;a)v{N-V!PqxTVxB@d~-?4KyQaN2;+{o_JRYObe)mZT|30EFlEN|2^B`MVyNq6bKu6d8ZUvI7`v za%KB;@XzcI%|{@7(SNZ@kvq%jjlbRS3Mwbl1j^OQv*0>p?uFtTzY)Z(B* zx#Nu7;vV=8FqkD`Oh=rq4o}OQ=hOwE^52hEDzN!YOJ}Z$i&nyCI2IzT4SR}Gan!ne zz!tQV4{pppz!d;}BLM^l>rQ6l=xu%@Q79IyDtdEL);ZxysmF?@7Usm5OQ_8QM7J`j zZI*%*T~%dTn$q1$3*4h9FU}YmMC)gbHh(UO4L@-qsN2qePLddtGi6V>Oy0*+`6k@h*b4y6hVL5y@RxJQx1@$?>RbmcI4}?q-Elah(F&_rsK5?wZEF&# zYqyItZ3PJTGzOR`sRDFey|T;yne&zUxGji8o!DO|u|jIGPitwiagjFLwh9%r$e#T! z5U@(Ja0k6`WM-iERCR!f7ZU(Ln$Inb5fCMbqvi_;k-)AhRkmir&?-0#EQ$jok-&bJ z4l@K_*T?=4fv17u0dV&<)KDodO?ov#{)wb%1Hd>;15lv`&{22g$~@5>UROw!^qm8FXuBga0nWm#22Dda12imD~N zmN7t7@>Xfm3IO4Cdknfrqaud{Mm9Hc3nqYwP_z=JTDG>Se@ zl8dOzLt2*{FozE0vNgkrA6#2Lh%Wr63zu#_OD~_1I|ybn$3gkD_py%z-k{NiZH1+u z{qyj(ml!zpQ)e)67JxAT@C8lIX_C_X;LLJDgN_;$RrQ+M48N>_!QxG2{4qjU+)IJN z6rxOkE&VtQ$dISEtA}QH@li==_eMi9JCk2A!f8GJpe}tc&3b#53fP|LJ?#n1Lacw{j11;j(vZ4D{y$vom!&z|MknVY47< zvu~R^?eaQ7vKx8l7Igj{kRB+;5v-dgs7ZD*O$f`6$|XHI&<>CusXJ2M`p~q_U-Hk zXz$qwDjhq*8ivs)w3XgBaFof>@IXtlJ}P*9 zw*AfFOV4ZqS#H{_cn^7gc8Kb{%p+7~kN0+Zi2gJp{oogm%WWjlvc^{UjaWJ2redY_ z#o@kPc5$VaLF>$D#SzyV{z2cDLo8t&J%HM%PLZ0cc2b$A$d+5WtUqo9hflSwIb?gL6j+P_Zxlv4UBX<6noWx(faCas=o` z;-$Z=JNP5{I?TTOP_;4p97(ipgj*gw`j+H)ZadT^nnuZ}h~xTzRprdG_1C&wWtda- zw%bWbM@7IN4-a=$qaT+@y<`@_HS_)IWh_ZWjsQyTxb|K{zJAi*hs4YP?cMy`@oW7j zGJVv8+(+5>I>nsb3K{pjdtK8Y4ncnlG%^W&x~P8}MHC1dD7xMysmh|ZYnfxQ3ZfMs z!5_ZK)VQiZ^3IP}f@48HGk$!4Bn*VHSC1)^=ZHFd)qpVD6>3~d;*Lc{Wh%_2d!lC| zIjbfB+JKPZHh5_E?OW;fC5O$t`6pmiBQ$`Hz0CrUl(!FGYhPhV?qQ^Zlo2@$k$?w{ z?abBZG9h1up4|!U;39X(l-jv;#eWCaiorawAW% zv3mP)pZ@v*O?W%_EYhW2IxV62$vhT*~qtstA;m1zsZ|WMT-)fj? zGzid3%&q?Y?++RNZ(oe!Z*F(^)#L|?>zW_F4S6_%?w(P8u=DSmczMf2@Yi)Rt*^uR zCRdL(w>3WT^~>`;hv)n@n+8i{iN6Q^i#N957t0Xf?n!;^ugIP{Z zAio2Eiw?HnC*U5I-q||JjpdBVP}5IaC2Y=wTP>hv}{>2ht-MM2igg;s$8dQo7iJbURh5a!3E zRXD&s*Of?#VF^WxFcYCaR|Ua%3Vw{x4ek)RXLqFwp3rnW`CgU+?MT^lPF;L=X}Bz@ zZ7Zq6I_#<`3`4j=hmUl@q)cvsrr}8y$H1!GV{k!gB^}l8H8Y4R0hU1c7$|m=0uZ;n ziegQp8K7sBr~9dsIyDXx?*PF`05=*ss78N2n@onMye4l2@y;cp-tj1(q+<(saPk@Z zv*{W(>{Smk^qMma<}!>}x$BNHw3`jJPBPSlGOeFy+BRn@hh*AOu^r(w;Esvb+nEj_ zSsu@`yqf9Uo3n1ES+&Ik+@8zwvw0R2^31@7rhx+8%7mXp$j&M*|o$e74nI!Z~uN--5@+?X>W2=__rhKlMC(Hz9%+ zN_g=gnzozt;-(GFPww1yq0D(=ZvXQ<4^Qgh?Ysl>S}w^GJ)xUt>zOy(oV75RIkKIx zI+*ce@Y1>sIxZkTQ79i*p6@6Bl5HY?>3Q}+bH+dUONYAXKk|7eHhD91FHZ+EfQn3t ziVR3a2Ez^$r2?8NG2dqJrFTfdK3#zgRiU~~fwpd;YFfcP`aJ5KY}8IVXGNA^4m&0> zQ)(w&KriE(Eralo!0~n=q9xzUrpTmc%=i{G}`MEH8PaS_~gY9pX?sINIe}FvDo#q{W0Ld&yr${nd0-7j-_ zBxa?}Gs}dczLJnrB*X9VEomD)L(`D)uBZbtk=`g)ZF|trCiU=2gB>RPJPZu_|0I zL$l^CGoAyeWs_F}{xq++sj^AbA8nCK1loNQ)VU+uU*Of}TI8!lngeR;dJ_bRfLsSq z!6DUbPiq+Ks-ff6@RstwJT)DrH9rDs9JXt()S=e>kpm>^^jfNX9QBw#a=C+caz5jm z9_<`}?BS*%a#K~|5L0AsT9LnbYjYXs>uCDcLiQvyb5h;cg1Yazjq$3eWdPZNrA{YN z5BMY3@hEUdsnIsWUn1=s5rKI~Et}L}H&_eMH&Tu_fO+a%LmQu;W@xbyHRe#?2*^PTs>J?@T9d+ zd6$9H=VjX8YE6kQWBGz}9PQYJyn%#RuYG$Z0tzBPBp2U;5o{$yxZf(Q49ni+L}{1+ zf7_jL`O*8J=O1|384Mo1(P%|2;}OsOsY$DCDrpoPtI&TqI;pB6hyj`)fJXTbys=^Q zCX4n2%MYj}w+hhpvpk~z1{WEf2H8Avfm6Y){5;t#sNxZ12w)9KG@?lj$`FMxFr( z(qhIe8fhQ|y2#N}rjV@5Ni@hB6bHkV_dVZdNxcRg7b=X6M`MP~!-M2C2)34*M{L4a zcYRET9FI0 z{}x6Q>QEPP_i6%i{LwT&Phl(?peN1c@3j!~h7c({#Y#=3dnIK{OutEpY#gGJ=3~s# z+gOu}_E3M_qXo^ii?S4h)){KdQ`~K7rZBJg1G1}=%)zjK;jLIj{CfCa{eq_5&y3}G z|IF~kgkc?r&k_{B6jHrJKfk1UFw1_yGjq@8h@yWv!aQ&cENCE-xNK+8MdDcE1F>rLfIE8J+kszU;sI{!zgSB?#5ChmaKeANc`}!39SF8_oP?-$RqXf;3ur?ZisY zvu344KOx^Jm;Xhf{fpxAm(RlE%AD&?Lo5HpN?nNn8h~sGtQ)j{S(sZl@v9rg)9sDi zlKcLt=U`P*xla1ufa7UHSjyVJqzNy*kIRO2XJJ%>`zsV_5Q=5+W5fb`-RDct3ygV8%tn{2E^nn(tyQ0){*VD=HUY5_hUP^B?j3X8Z5j8%IRkIy>?0dP z#e3|Z4AF^9tygSR`h30Ow5gf4l|+kruY`^;p`2V@eAeE(yZHGw?OIOzM()^GpWOx` z=gtJO{CMcWi8a(C+Qid_TCNx^=?wQ-vHrTTh~1H!1D=mm!Q|tE>4WPX4Jn{FBjXhw9?) zaZ}IXE~DG0=gSY$M-ILo{KEaHReOonxP$&n+#)$1++F+5Vw`dP^>51`b7m@s&dNuW z0f!d|^aX34lFx#8`b&lN$UpTc$o|Ov#{znV>5zaZLeFGz4rs3rNFo7Y=kTZf$xj~J<64P@H`T{UD)}i~Qz9QbC5`ER`_oi)e7_%l zfaPMi=Rlv#4dO-b6kI*+r`?SFcZvu*)eE}dv@afzS=XAAV!FRS4Jm( zSJ77EXrc{ga)*95MVz%h{<}}^JR2pS9W9p+w4ufT>N)OxK~>}jENVHg$Kh&4E^2I% z>#zvb`u^6R$*_WtskyZVv_Js$B}LGG>FjKhV?5x)sH}1PgG(b3&3`M`+LTwrcUm?a z$~r;RNaHum*LZHWp_j1*=i^I2FJZHIB$(T*8D1IX!@UP-Y_86g`pMkD67EX68z<}E z587?6!$pMr!zrZXSbnpr5p&QQ3HEoNi8H)AjnHS_FeWU^$}GGJ;FgEwOfwX0YCGV_;{L+}HX18s0?7kRvv3g|n z)vdllM7i|c6QyZ6 zYd?9=8(zGvkMQB9w501B7= zlNW8Iw#o)-*TwNLBX@odV`;izc+eKX6VJFDEk&W0RnTB$jg}}iQu?#rV5~xhN}H%s z@;92O|KTepGb=}p$E4pVl$SQsy;9O>hT~1(GuFSB*@%)+rjW5P)#iU=VQ#D`VZ^aOusBs78rGJ@z`Btc_?W>noev)e^lnp07%p zY`tIi%HH&SyU}#>PI(ISg=a4-MP_ij<~95KGj2B)oZLNc*!!&S^Df^X_b8ycyK8uf zF1&I>AXmNTWYfWW?>YWL!mBD#AVH%S?8HbnUchaQ79=S})qXkXs)RvId1j9zv>5K3 z)m30p1EM6ct@Jwt(Z|Pd$EXY$>gHlWaCU*Dd6U{4o8f$O#YU9>Y5^CgFf%bFijx`e zED_PVO^%Q|HFef!M`loU9);!(5BAS`_GSeq%I1_e+TRMC6`+tRhOqcqh4>~S1~I6Y znm;>XA8;+38S|ULP|<>E6o2 z&DUEmQo@^m^in5?FI9iWUG>rk)M5^Y-+3+l4gD+hu%YAVtlxG=ev>iCcIEwHsRjA; z9?F4ID3M>0rkuG(C4+?QV3ZG2gW<5zE{_uKf zUf;?3udJy*;lY)NxWUw}hy+j49$zdR5B;qzcl12&`VVhM59>I^)BA25&*eBZ1}zouDwNBW}c}%!Mb48!!gPF)%u*(wrGmv<4!rGCoQ+51W#e z;a#xLSm8glF{0n;_%eu9G7@v#!z_)gmkRl4KpvgQjaPIWK`|^tBqE*nMCZ5P-yiQX z6d6rOT=>YIBw$)}89Se935-faGucpF{@2m{0Zkc=O}(IeQ?W=mp4!`ac*(ON zhD%oie3GqRGXlUKtHYHPSq+wp%|+csOS~4T(!z1-jN8FFdm9Ke>aTi?X#AXz>*Wr|GGF!U8--|B+1Ui6=#a{4v74T_8gF;4=Q62(;>@AMtle_ zjd|_=yYd$BLZx%lINUv3Rfa|+=OJE=BhgpTMR(i!wo&8d7jpgD;%u0zf9?&KY8qEd z$!Gup!o+S2$#_KAKCj5iuHqOJo9aq+ucGH`@OAJFxx0|+XqGfE9K~?7zc79=F83Mj z%;R$TMx}x*?}XT(vY!*pqiAT$H}j`{G7J;eg%8@EP>A2CmsnI64{8f^^R?dno8~G2 z$^LlgXr$s-pt`2oOY9N=2yaXQ6q@D0lopen0cba6DP24^Yl-lSTrK*hhAA_ z2FP1ZnrV3`{O^l-a@Mn2d_t{SETd(5MsS#}nuKv#8l^gdu{gBO??`|w3b1%@bba;@ z(3A7|(tJyxA6C94C^`ED`l>ilAYhb(5et^6zbF`S4=3Ky85F!$I%qq0=Y_H420!J; zT-;v2gl#}-#&LE7`iU;bMRAGu1r)_rt6K2&8;<*xwaA?@Y85S2T3&%>-)H~g^uJHc zD*TA95}2dJ`g9tIR~jbIKc|%GSlh}dV-=gv_~po*m+8G#I6>QW&q%z`vpndyFIQ$> z*$0F$dv>|XEahqCH=06g8uw|_&VGIv%lc9zpwdC>lE%S5ASDOy=wtW}qc%|y}J1CU>$&r^9S1GlRJGMKi zZu8}?sssf0@GA!-E|fq(W$L|Doa!kL7Qb*&%6A&l1*XOoG0~HGtoFq;UhTKklR067 zZpy#n8`K%6;PO45?RWF_`KWP@J!A6AcMC6Ztn*$w?flD=cwa+tV^Mj1NcVH#=cjK! z<;&KojTI!Q?({6Sc?Ma{zc;k+ZoTr;JyD9ja&=`~X2tEL&WH3@Mt7p-WYz#pxdHq1 z*AIO1T&^u;u0$QRG(s3DkA6BYhx@)Wx9^gE-vZy`O!w)K6$#@qoGt45=#afeo2e@q z{^ClK|MA-yizXpGY#`FGN}cz^MeK_G(?-f^+RMm)_;N#^pe!_5IqQ>0?Dp4xq=D`q zT%TAdM1;C1M92R1wOyrBp$GtT3AQ|KojJ35MBceut9ESp=YFR71j=o<`JVqV{?3yA z!-uD1*YGdT9Pd0o55AVl^=$QSfVbVFjNcH}`gj_bpDa>>;JF6)h|6{6q?$huu`A_O z&GX7$-7z%`NQKsxPdqBXqmoAJ=ge?GoWu>alcKoy!Mox;GP<1*kE39~djY)X*OmT> zBp~=?##B>9_aju`ozQPp-x^xC3gO2O3$GV_$h1}!Gov&j*0Hp8u!_Qvd}{4qIx*6f zj0h?o3;OzcwZvIvFCrLi@jhXT(u6y{TvEK{W_{y!oHH?o?EJ7JGq{LTLsI*jsHk*a zM`72~*>?O>;M=#9$c~soZ1=gh8o^p!5K+`XuSzQFwyE#-E#&wAoZyfhu|v}x=@Cm; z*&)T(uC^Gjey_WKN9yRCh*skZZ687wonnn#SCn8R!*Scr5d2bf=USAaaaFtw`y0K$ ze9cC}2k(x}lRB~D+M0bFc7*dzZHz5cWm2TXSTxo?SF!b=chdTmCK{sb@xe)>vSt<{ zWleG75@+hz*Iy~jS`4>GXxbo3yr8Vki}5115mDSxJS44EViM+Qca=x4J|q5-KeWdi zL9;6j+op6T^!23kKG5JWwC%m9C(E-$qzlKh!U3`{x)0T@zKj#r%DzBRyCTsP8*Dm8 zZM~7j@NiPh&4D;K_1drcy_!Gcmi8&ZZT)xe3IvU)N8>7#%AOw!!EJ!ohI|?skK$!q zbkN`O;Oj1Ph$jGAVfysrl3-xt6GsoygN<d_x3}XZ%X|WJBdOUf2@p_lX2vuv6A1PWay>K{qH2R{!OC0S{ANKui zFuE`rU8|EUeI<%SK`lC1SUfxcrbrIeZt*aRp2Y*Ryk3=R+FwQ<=NP;x<7SbIaMO*E^C35Mf8s^6hks^&}T z`5|yTunJ?c9OjLP0BR$1-i;~K(mz^q^Y)pI~lmJ`Itq zWf1Mr0WY|+(wp8-cJ=PWm@G!lkb%($xnpKN1HGSKYG;0Mj-Q}iGVhNZ3B~tAGR6G~ z<8kkzWIW16&*7?qcqB`TiQ7k0rrOSROB+Vrr)}d_Oy<)+V@=8k&PyV29^uD=ld13C zS>KyZfk!{evC`m}`Wr~h7_eIOj5D-WyW=|{xLrK^RFN(MSttxp?02)XL|~FkW(n*F=TSx#7u(U8RutCGG5gFbJ)EZ^ctnD_0)RKlwfgn z>P6UMKaP2z5GrJ~Ej+(W8vl_#S8_;j>4;e?wgtr(=f!*!E1WL>jjr0U9mdDLaw=jg6XoJeMH#YTF-AwIFZa z_Ca-jF(JQavWAvaGP&KHJJ-|&r@ga`fA}u?2z;|-V`-)Kv$iapO1l@v<^ zf7!%1_=%SwjQb~vYn#$BST*T5cYd_3!7{$-eNDbUINxbJ+T>RBzW5M}eR#^P1w71# zV0rlF*0J#7u6=@_9B6!Jq^uSyTlPu#ebQg0cppNHnCKWfAZdVUbv3VVOzc)xZ3N&C zF3{wpNL!7ZjT@|eu_5^6iwfeFX^Xyc?Cs1f@)Ez9idX7b4Z)GTZdB=7I`}=~4jvTI@ zCXY@n$72#0YA6vo{Fmg@7;Vy+h0^5xAgqG%x2%Dk+E^8st9LDB827pwXPm9zy2b@} z>%OiPw65*v`fz~44Zp6}w65RhsuN3bZ(v=kDUyLD%7}TxRA9qw%+)&>_J6rsE6xoa ze>cmZSQkMzkRSv0fJyRz-cA<&kQi~=!J>7xHvO5u1_*o&l)Zgh3#ul!dDs1GP|(*0W1GtOuYpDs zdO9)pnQz|(m~RbkM9$uJ^1O^(1%m+FvC43+MvNJ&YlEp6d(tZZt7Dg@;r&8 zOs{E4@z3qCVSlL{U;8BXF?S>gz`wbe(8;>q8kVYGvXH8~E%UInoR&)VVs6dfYcz~s z<&-sUIzB+s{P}y0gcOCaZ!e2$CXbFCA~Zb9m@Vj^(EH)p?WQWlBJ<<_{U;50|En@n zKi^y5r>}_yudfhILuvXhZZgO>@9y4g)?Nf#%UqN1!m`(lJEigIJMt?jd`HgnwJ|O${efc_@gh~AqXf?mEZz7BSH!TzR9DX+F>u;zfJamjvp%^Rn-R&!jdt#4N z{&Dy46w0?dI>FJY3ek zlnink)tyOX&yKkCz&^hN!Y60x9ydwxXa#pIAuaEIW(ep?59y?p0MJ z*D=r$MY5yX9G*9f{1dH1X^KCNzjEksBgr35(Y7AcRR*DWw=)xbzr5+lwm%?C2P%w* zj0ZPl9>9JQf2lM+@VPo?RYNQFNPM;2T z&{l8ej%}_<8q$&RU#0QazU%l&Cpn0|nlhy3>aqGIAlw9IHGAZ)a+>fX(T|0Kf8!4c z4^TS(eewF>!@r$(H~z5Zd3NL-h7x0L`Y%^s`fD_q6uj?+>^#2R|5Ik=q&X0bz=3DV zAHG(KaTh!_{cx6^L1Rb!1KU2keH)2ifj58s+pKp)cDt&j1*X`^`#b%>^34Fu3VoFQ z(Wd9mA1=!C^7~Z|*y!`!u#DL_cR7mta+UgA+hrz#Twl+^xoo3QbczyP^_BeM!=1%Y<72Ov%8k zac!4JD|yQGaCj?#r#BU&EnLN)$~Tk&ri*37oA4WC&R6wTo$Qy4<_a4c`go$b>dbek z>n#$@uZ+YqAZ;~T2==8xMyf`dUiCW`S&XU9c?u2QMm3K8)T_D{qN;&K8GGi|jQqCs z$jp4VP&%IvRx|4@>o0y*IAq(}pCWR9R<4oL0vHygulv{G!$xI8ypOE{ocbW!^co9{ zyE0E6NqOIbziZT~CYWB=7&-OPX?*7J@ZK4L{fhk`zZ&=11?<=U7!{Y4XP#Rg^GIWn z{<4-3t(noQ!~c->MBmtBfg59T3)ekIJ8#f_NMd4X>{!c``rvnR-AvwplP9w#H`M9) zJJS8emZ62DZ%FY=_30BCPN$&z8^|kQfwwETJ*N$n-0v7oM?-2T&M-{cGGPs%oD*$%P6xmgl&(!t@!&u4SY3_0GJ^og z1$lL$9^fl=bN+x;GfXw7GV6e;(NgiK9yRN3K3qKu zbj`vjWb|Bkk~~cm>Kg-%4D_femy$Ou?~e%_CWmmyQR7zC0nK8nuLaTLHpG0c!EH`8 zoCP&o=^4{KW2pkyPo@Q!AO)*JYK2~u$O5)W$YvF40?^aT1$dTgv+gWbj)%kxsc8xl zpyeg>>nti$juQywyW(?pRkw^}M#Xa0^ro+}Q$t1T#gGElbu3|__AOmu*E4NC*QyOG z*x1bYSx<0JiCu$XbnnzC?u#t=n=6oxO4j*av zAV~hQ#V;tEt6<+xBj9~D2IU-dMMJ;hrM!|m#$WkMI~ zrTS}+Y8<$Jyv^xsjNp)+aY0S~*VHbg4GNDK2r{!fdVgnB@J*Di;@uBHabTY8(l;yb zH%8}|?|w?Lm8)u08*A86jeV!*cg=`i{8QUeh|zuMKIju{4k|u$ILHuOUEJ| zqcOTQPBbRl6JdKp&k zIDAT>S2jj;6eQ|Xk;08(frDLC^#sj(_V5U_j2(_fjn>|PhEwLmNc8VudGsSjUY;aj+TYa+d_5|$_PX^T{b zr3CacqRuQ?fgDprbua73)>^UwP^9TP=;>Aaz%tqW(C(v??u}NcVX7Q2E0os@b!B^c zn#7QAq{<^Mxt3fvMDbeObyc6b?^Cspm3hQyx|e8S&iIof&TKrTr+MZ4RDIK%nlLdR za}f}QNjF!yjILL?YRc@-rnl|qV*Vi_fH(B*yFR3!(ti1~F!pC}$v)!u!q^N(BPAMM zYzTwe6l}-)npj8U#e=&S7MK|E$cskeRg0vX6U^MeD*Ec9FCxp&2i~@SFw~Y5FQ5sW zz47Mb-s?w8Zn&M$#)cPzHI7%0=t6O{HpvJ5aBwZm>&&?ts>=Xj#3?OWPI((HZ3{ZR zO)WF}l1)yo^I`RMUTR^KQ@wh!D_YW|5W^0+tUJQ*(gC8Sx$z_Ee1Tn7rR`J1nKR@H zwud7;KmtNcU=j&4>2-4oxBI$V;zQlaGf@X=Tf0o>d6xw(AdY)oB3SKon4x zVa+?I?V$!jz7VGDefC}`vwvhxgcsTedE=_(g}5<4;u6X)A!65irUy#z8R2}c&3TNC zrbTp82Ct54@Bek>yVXBdZ!u~3hY?BV}E%eZS{bvN;@(Zvqdnc9d8tG>omSaSwDxO zBFm`mMxh6 za{m=UC`_a`z(sC~O=x@BjNk2y@W?09{~RWz-d)=KINJ$=i)ZM(&hj+q;v}HDOsjl* z$rmrhw*r0#6A#_`p@Bl)A=jz_8A|A&1#hkeB89+HrvtF8T{%&F>jvvYs`#Tr|`vG(KRn?@h@BnVjJKOIsJ^kU=_&L=0>Wq*sge(6ml=IVSk5C0&bImiO zA*UNU?QTvY&t1+!O>g{RQP0n&TfuC7efQ9^y~Y{R09*XL+S7%4!Jy9PgtStXo+LY5 z!Cd?%AlddosjN@$+q$ab;^S^8IlMtIhyoPD*mxyj9AWD1ze8|Bm?lBIGG^8Js{2Q( z3MX`EMq9%wqz()tV9(B3X+-RFWS$jBP+JXf%-*}9nE&S#%{ke@F0-ntn$ZyfLP!6- z(7ysb#{a^$IiskZ{N;x8(v@aAsGr?F#1YVVb`nZI_f;P!U!?lQj0Ijz3XykspX2CF z;*mU*0uc!yz!Z!cY`Gu+-2>5Dg;L`vZgKw=ilDzh(qdOdJ))@cSEV$%sA`B*-y~>-vsiQf0(9>X1ZZZ#jV7Kg67yr91 zS&b+<$pWTZJhT`vvtNNMc8YdB3dh}X4c>8$53d&N$nxZ3Vgq_vtp^yuBS-*y9}h-R zU3zhiV;YQE<>Aummc*+GTdQ-?VtAMfc{ni`fkKQphF8{Enp^FvTp^#)XFh5S|1FF_ zjvC7OGhZoK(j@ZAz8dyonm_9^A8n*iDTcp23di0dhn)iD@~FPUh}JuO*IZnHYg`+M zv^(qKIvzL7TLQlm+K2BvHPYc&z zoBfRY{Y3?~jth3t>3nHt(g_n)RXDPDUP=k~zoinbE@5G@eV_5VLa$VPW`k3YRCWi1 zh?Bm!uxU*vYh71hUCh=&Tn$pkgp66!)j5k~hj!g(d^sRy;rS#P1r*Cs3qC4;3+m?0Rq1HldDAx(w7 z&$F`t#J^Jyp~3M8P*9^Z_Trp;6HS;>_keQ9&+^*c<1>5Y>e$5MRs2cLFGZy)!%?}% zKGdi%rbmA->KeCQlTzyY>2Acr1 zgC+o`X&OWa1i&5eh*l0`VhIg0$^w=Ar4Xs7KBgsE%#m&q#26HSs_~scfJ1HRr*QTV zeJMmeWP>~wgSK(cY!YT*GMae2r^HQXbqc`qHK@~_=D)cQeT4*NA{;JkBxEjUfu0^j zh$wN$C-L~hJXlDI1}C$zC~^HmKafLy5oNU)|B{UkW{rL(j+#e;;$vev1bA|&-)KWL zkV6g00?OIllr~0_Hr|s?XVcLgGuglf$U#k1DKL#qIy6Hi$QwP_=xyprb7F;uy2vt# zDK6fHjv^&9oj?GX!J6*pIu;E*Ov5RN0xE>VVlJiWP}hJgX#|DoVUDQ)M5&ZkMI!Kl zxWELPnh>V^r(gC1HngOxIo70psi~-{fx-%=wnCYjsX9_5gxo`DWWq7j=uQrXi!i2Uu|0kqEXP*jyGHgt^ChImK1sTi$8hAvJ9%+{{ zmNGRawt}guQY!kKLOL`=7AOG!)hC3shi)w&S{g=?HbW+y+}yoY*9d09*2KIr`d_3r$i_s;PAa!{Yo8v&HPEMnR;;1g>R6O#SULj&qQu@T z7S=A+oj#I2GVGI%0@c#0iqafbkZLjrXem7#-MsDowA$7#3AVaTDujaAj_rPg>VWD5 zuFAqZZs#v;40A3BnE{>vt zzBa@!tin9NEc=YE-_-;@WWy~)Yd279Rm{)3E}rWeAME1d8a>1Z1b~`SY~z-#vZ92~ zAsjHQt6T(8+`1Xi7Toqy5=>G8oi)S?I6!_vuX|iY4q!mQPUJ}BLu+0Fl9JHs0^V3; zt-P+>(M23QT*BfqZu*`?3j_dMx^G4dto#`+!;X}nYe>*)i3Zy4<_u=zt77=g}VFuxY4LiB?;D8q49!}y{`Qdh2Wal3V|$Tbv@8B9iDmsc4?CIrL({%9BnsQ{>hGe|8oa1ewz z8VYyq7Zt9+EnZ)}1susSuaM1)7WYg@v#w5&H1{wbK~)koK!ZygF+d{)O;fJ5U1=KURk}1Zw<+dbL~# zuIAy(STBs&sIV5Z^i}U`Ry##U!*vgDO-@_uVE1(XA~qq1XeC|4G4wT{uC+(dbT|mM z3Cnc^(+RdN|JGgqaMsSuHspdo|DNt5MWRaXF(7sJVRmN6_0J}@#wFmezNa_X0%ULM zU!w#%ORk1mc3Fb-Qn!khB=kop-mvr)@>CKzw1P3Hb#8w|JEU`OPY`QIs#S5N+_uyq z%Qj;J+c1wd0B2=QP_igAgTle9koNT2z_du`qjnEj#9eA7?ZYGpgLCf(IOISNpabqM zL^?nNCzLld18a3d^?DR^8$oq2WpRw1LMq&`c3uZH>M^BLWLPUUZ5HOi9yXuGx&W|(U3r9^bTAc_Mv*$hDMUJ;kBdzA z|N54vdS|29fvcdPT&=e#_(5{I)ZdqGe`9ysmC zS4DI`J1tDZ8B^)IYq`QtI%the(Pg_-t0kri0L5Fpk4;6-|2!uI{m?JR*CYA0o9(>= z`_iW{($iAfk8vijQ#lWWC9r|j+mbjyLo2*yHAFE#GD>jdNz_}x#hL&x?**qPaLH&gz-K#)TwbjRllfEkPc zvphsRY(p}H!YCxeHhB8|oxJ2fEr_9;by(Ky$Mtb^1)e%<3GKnM^xkYGWB z2N5PzxKNw5g%2S{T=?&w#DNqsR>9h8CTqz%y0qjggTX=(~Tf`Qnl!D{~}1ORkMDz zh*D+PmJ7FqLRL@gMmPaN=tLOuo;PT>Fr7MGnE{BqhZ<~!-~Y3o3LZB z87I$PxXi=?6w3_St3Z&rapVG;A7`1;vRRi9&k?&+Y^F#{jO0SaNA6lOR+Cya%hs;n z?bk}((-a<`p+ou)=PO=3+4pYO`4Qrw26JlQp&%tV7=R!F2{cdu1`C|7EQ2tM=$>j$ zIi;G`EK(qVUykBOoot-JMU+cgIp&&k_~Grofna;_Di>uu$hI0M|DfYQ&R}>RMb&P^|Y2$cp(KfSx|xGnpaX8rqo$$2_}_SO5x=bS3KFo zkxe`yo@ ziC7j^PITmwQChKu7-+5uhaGbU4q4=pNiNxBeNFl1zB)H^tFb z{AtGvYP-(5)AsE?%AYae0TiMU=!bmDYB^?DcOl^>g3_1rkC2CD1P@slo|SctV5dU;-c{ zhzi%%0PkfFhOu)22poq(7fNA&GOD4Bo)7~e4lxD?d4UUDNRT3~%>~oT-V%RzM8^p+ zi2`5&j;L5gEpCyEUG(A?!5Bs{j**OIG~*f3m_{|Ok&SJ1;~U`^M>)=sj&-yn7o+o> zfvCX(3$TD11d>PcVdNlAfsEYRB1nSp(T{)>|A=y!M@aV_l2EQu}2?W^T8%Dq(+(a46SQ3+%GODHkkcmxn zUQ?M+d8RN4^~}jcsb~T~#~B1*jWcARJ@k~|VB$$h00zdNy~C$I`6+-T{Vg^m0Vq5P zxsp;!q@V)1XFm7Yk2cs(0KHg1WGeDdi4K#5eyONE51P@7B6NU9acEWo8qk5#hEkFu z2sQvP06GYyrvHQ~L`OQ)w)C_hIMu1&|ClFKXhxHi6O9N_Z<^Dc4#XZbr~yco8dHeM z3917z>Qn{r)v3I+IwRGpQzP=Octy?#9B|jU;N{cb@F_=R4UAfC)K;Xr$FAZGiy_N7 z8N3=q8+zrN26*5)vGf(1bfr>6h>XlGn_*0xqvwILkZus?%-r}$T%(4tkktz;Re??bZD2m-}GE0B|2Vd z%9AkPS>6I$WWw(ifQ2!vVH4N(!xss0X2Z#t5(}Wh7tXK%h%f*E?3kfi z5if|z3sX7GxW*|K2#Rm~+!mwm#UZ}qlc5}CDNmWoRkre#v7BWsZ<)(o_VSm(9A+_( znapK2^O@0{W;L&w&24t`o8cU1InSBSb++@J@tkKp@0rhi_Vb?s9cV!hn$U$d^q~=* zXhkoY(T#Sr3xf~=?L`6rWeDt}F`a3N00IDZpokF~@QzDsn$)E>hz4*VfPPp&2ctIi zt4nQ!2k1i&02qX;VV&zoLn8tJalnBG{DEs-4|~xbpuqy9AZ%hU`_N1nzyYkGY-Uee z(6AUl45UqMZTp$mamev=f`p2;tw6F_y}BJrR_@%dXH&wxYcMb0ifTWy{i}8FRJ(+a z1|EnwaZZ+{@|G+^X0$8Jm z0IDFs0Rkz^0_CPPMcQ7Kl4A5_hXO>|7N+}2$J#*qc%#fHq9C&kJQ?vL$~h4sVAMAW z6y&V{;0m+=4-0SrNI!ju(1$TGxM0u#3nWnQy>`q3%f9^f>+in+2Q2Ww`w|j~Dg-C2 z@WKo?%&@@-J1p_U6jw|LBKlUW@x~ncdvV4chb(f#7pL+GEt7ciNh%Rj42dTo4{Xi> zJ85%3K{N|svp@vsU`h}k=qQjW3mi1e(MS&?k3LK{?ex=7M=kZ#R5v}0HdSY>_10W> z-SyR8hb{KlWHW6H)@7%y_S$Bn&Gy@HYkkfxoP=U+J!`j<$vImK|1bd|0uU1GKz|1w z>jS3Xihuxm&>_$;4g9)Zqs1m`VdWL&rQb!$q9xzvZ2{X4InHo0$}!%|!_q#iRAUhi zJoLkZ4g$3y5bUzkEsh4An4%mBvruDBy4)bVs6$qpl8&1SzlU?A6Q}X z<4rM`v@#7l{yd|Nk|^~9%rO@|W5NR{L?aLY0;$iw`?!*@00@Bh!^8v )o&Zdu-U zn&&))FoaptBS-@Af+fyf&no=kM>vjw30YJFTLT%>Mfy<;TJU2z3uK7^w?n`JD)2u3 zsgFZKn3d{j(N9R)c-0mRV2jBrpE`xsI3|7J2mAwr6BmD^kj4Z}jK zh;Jr{h@upSf{27bLJ@9w11e~BkPTem2!K-vA$o8GhZN!sxH4h@ktnGWCJ~15>mfq6 z#GUaZt|bu|NCfuyl?V9oArJ5yL>dstgamQ|0~}&YiU`8X6)QgoaiIYfsg-Bk@j6av zB2WCmN%AGcAM==pCm%`4lrU0Lj=T^g6(Y$x3dfQrjHPo*iIP)7D3#2EBP->IJX%f# zma+_{de#_BHwuxCnd7DOG$|Ee3iFu`oLn(+c}rxbPniz1W?59o%1c7?n-5_oNNjl< zV@gMt*HjE&xEU62g7cj(l%_1rnHh9uq?L2@B}&*C|4Dbk^Pd%xXDsPysZ6m1pYeR9 zKLH9)aejoHvmxkR>=_b-nna&WaVA3n>QIkB)Hl>zr#6|RPK9oCqaDr2N6&f0|BQ4d z7JZaSPs&k@K9r4)l4xNJDwLR>@Psyn=|XAx%#>nerK8d5R47^#pKe7h{G7~Ci8@Vz znoy}Rd}&XyDW0bqH9k|N>Oh04Qk+@|t4+~rg@WqTfX-B`-~6gYkXoLQYQ~yTjVf+R zdK-sZjal%ue1~!g-osC}`J65X}5Uu;v zYGt>YS=Vfqv!8uzP9jUC$<9)*mi;AHqxn|U|8|y`^K@-w)aq5$PD(e7wQX)a>palX z2DZ?dt)hY}+^hOlu&jlTaRI|yOnyYMmlbMrZ`+o^y0oRkL2h_Ehu!DWX&{sq2B}!QD>)!n0_aG1*t!e*@oB$tmzywaD zfk_EoN;w#&3=Zdo!5ZNMcelN{tnf0k%aiijx5JX1a2wxy(f+E&#I;3nYgMdX5mT4M zqy=t_Wn5s~a`!6P+;C4|oD~-z8%#idP6=|CC%-4fs-9?-}HF1RHSON;>z0-!XjS=!{(J{i$t_H=2pS`{^4 zq8RLG=dek5X&?_5)@!Xct(Q#~q^N^?&A_0vr`upHkTVkq)9o}Pf&wAh7|L(~?rlE;ldxYK{f9hg^`qPcr{N!$(^R-Q`?Pc*> zrb)pyCUB9CkA$xlEb#ybH~<0F(YDozJUP(M~5a2z%+cRHC%`>T2 z0(9x@XivKU#*y~6yZ!BL*9qL`PWQUk2Z46ayNBWd4NO2A?nMYd543>@IvD=&h)=xY z5g&&gd~xxRkG$dA@CG-eLGqZ-JmLk=hB#>c^L=o8*cCW-n#Wr2sJ{=8QqTI<+h_Hz zk3H(~F8jRGqZyb8H{An2cz@L0_j&JzC{R%k;L9E=wFePbpxTg|=e(;r=dS9(T&#(+ zWF6op6~Zy%k7d*v=Lm@h|1dZq4h=oaJ>ZA$NuX-k<}?6-X$mpo*a5Sa!h?xz+LC}k=45#c}!qHqmC z)Kou*66_!gvak-EqkaXUK?+E0(dS%Ib%B}{f-;v9;UEjAkPRPHVlwy<{4foe;5sgm zO)1zK`P6e@cW?ToSCO)U{*{3i5e}_zgBphuiiHvBzzVoP4^(k}{AFxNNJ?C>gc0}{ zJ2-k6@o!O>4O6ItV6hL*unF1V6I|GZNf>{Pgj`}chB-D%9`SFEwhe3ORV1Yq-XIFa z;3jfd5*j3k9)=b${}?(9CoFonhu3k2-tdQkXnK2P74c9EqYw`JG>2!_h-LAJ+oVGK zC2?i=9R08jr+{%|HXUow0Yflv*dz#6kOwIdfS}L}9~c>;NQWzChY`hqEap7+XAq3W z39v{LS%7MS_FDI)3P0YfF34xBIa0|TV7O4?sS>Ob} za1iIf3b&wz!@-Y5IE-INZJ6;&B> z56*xI&ai*BW)N=)4zO8C^yP+`;GPrJp!um%LINZN!6QDxrA2ZiN#c}S3Zc*`jtMlR zyTwe_Bp>zAcgdiApoS1jfCP_elFH=`qW}zuc%>uiqZy$mcakS{GN^s>CxIdmg32e$ z|5Tn(NuJpD7c=P);js_7mJG=`rvzaL7;pjtkOfFkmw5UR@jwh^ z57#h&1&FGD3aA$`F6BZH+8Qnba4zYxE&|Z4^U@^d+9Y;h3hKJ9?AosG`mXRAukyOC zgMbM0dawAJull;L`&zI3`mX>RumY>D{tB;3ZC!?3Tv?*>#hP|u^9WY`#KIevoi#7vNt0DJ@Yd`BLFIEro3vC28nLq|HMs{ zVVbQV4xHqi1JMus@ImvS549QGf*0AiP6C4Qp@*5Ah7#|4$6=ty6F*sqM(p@S-t%ATze1z8}JaRzzVcrtj2q-yG6U6yS((#pU3DZ zrYQ^Lunf%!scvBiBVdgQu@B8qrBS-H0GuVsJHVPLq)c?c6e75sFt*946+Md(g{TX` z(3KEmzUNzv>1$!ws;ONoOQt&w)mp-L@s*%hg)N-H4h+M}n^p_dU(P!hE0=pPidkHn z7`*6Z!G^V7M~oH$xCy%8zx}a_4{8wEn3-S9JkP>}liF@W{GDlxynpLF z3A~_32F8vdn@UR%KD<;b$_=N=L@H#h+!Fz)3B{nc1YrXwkO;P{z8C=xzfhwkK@YdU z3JVz)EUd>sY(1R|QZc-MURKOFaSpA}3cQ8}MIZ?As2j{@9!?MdGf)!JI=<~J#oau^ z;uy|$c4_216Yx+BqM(KY0RsVG1@}D6ny3&|zyLmQ!3u$+I+{$4JW0Q?h$vdclKhfw zOj~bk9j^=xyUYbXum=gfrm-~?RBELZJwWS=5E%W<`z*}8|D8AvH=R<%skA~LoFB$9Kaeq zv%SfqAlw!K9SQ^;A6UXpSltMzJOcsX1T;Yf^8CAoAb?QJ)h?aSBpS(LEnj54)QR!R zd^w1WC;$)uys69xc<>7l4H1n114Cd1@=OiEU<=z=QQKU~e66?kX2trf)R9^lTU-oH zumK2tP-}e?)WEvIOcQ*7zi(y_(2%rh-PIlu(`&VWVV$*O9h!ojn=E0@vTzRl-~$0r z1cvR&E%6IhU3I3!cj0Ow+SVfx)d60X@)V zW)Lf&0Clk80Z;&Lyo&-zfK<5InlZ&h-QX%7ohZeYh#U-FDvbl1>x+ zPz_4D%W^3qIS>Fzpylu_-9DG@7qRX+{|@ri{?hP{?L$Eh{0s1ekrzuq)hvHP_^`N* z`|<*x+gUEtH1F=ohQ8j-5}+K1$~NakNuRb37Nq>+8_(eFe(KhaW(M5ieRvI;kk?bs z?*hQ=r{L^HkI%VoT^sD^7X7)+Thi?TWuBK0Hugtv*&=eJ01HP{KIb#*0^u`3oU24ua|gj z@<}nvwLD+y)RIz<8X3o}zEQ-OQR7Ad z|2Q^`rtPCah#p6lj94(GK$Iq1j$~;P=FEf3#z`zmQ|C^VG7H+wm{TCRQ@H5y6gUsh z9sxrnSV4->VpIX!KsDQ^6D3uNQ@MVf=yPVsohv`SBq%gy&X!^~ngy#7=tH=1?e=Uq zmm*4h%{FBtNKMc$n!f@l5MU#~lDh@H?rdj^)j79~c|NurxAI4_G}WH<2={YD(k?5v zMV(spYSyhw+H@UT_H5d<|53u8-7S>u;I@(L~0#I{QJd-+Hl(znU~}@EmJjq z&#hZ`eqH-^<{`P;?il)XTJhxF68N58HE#9o-9u#GIvy}i;!tP7Fy#IIf7zL@YeklJ z_~Xw%0uSs?8w6Pk?;xK_8)z$->dLI9n@FOtLd`bQOQL?R$pjjHG$au-gUsllh=%rY z29#|2iEuL#KQeJfo@Cspvk5Z{syvd&Yf!?Oc$~4rwQRI3Ln9Arhn7~@L9)Uc35p_s z84e-}7kJEzlBOxUJc%bALBkOvv>r6CG$BC)lOQA4Y%?k)FKp<;OduKKjyUc5QlMY% zNTi^?Ht7b&H22)7|4&5s5>up;i0n})G-G57tw#~<@Uum4dr!h5xmDV0H^)y#qIhykzeyYi28W`(X0f}FCnsuOf6k^CB zNNH_$*)lV_HPU5)y|zNVeBE|e3k?F$mZQQ&s#>eC3ai^wtNqp8iL%{mT6AON^~ifK z9e1GUGP%akeRY~OvdPSpcTsqCP1qrNak6*dh%EyO+<_s^i_UXc!DR#mn7Y`@iyZ2w z8cd88ci@F-Z5Sj+BW-!xi5shU=8zj4mqk#vaUg&I@(39ZGFBO>PXK9Y=dGCATshXI z3woHYr{kTP|0?!w<~C!Zi18zU0s>&fpO9AwU<|Q2nvx%A0A};zrcbR}pr|p7o8`KB z!p%l-EpFQ&Vf^Yw06qfPfW#<9fu5kByi{F>~ul`w*^Lhy?H=gjthiR&Mk`X1^(XE#qSL~B) zv|ZqTj}tym(H~!clGzr(`S=$*Z-gQlSt-l?8gn`CaYcL5YGC&iC_nJ+&u(#x2&e=! z5CJx1{~jke!Tit_3|EXo9CDfk z%r-Ky3j`u1f>FvH4eRH^0U``cIho;}YUmJp&|-r>*`Y-Ifrd3qkycG=MJlpbz3kO3 ziBeo*Pk>0nH8N3$O{9nrp^-xljuDP^0+F%Kh#?JmQC2IYV4GScruA1|KfoQ zR;;5_h0F*$LX|WD>=7?zj9c#f=)g4U3z86wl3Efevs`rp6e0@NCmr&yfDOcwKyn)( zwe`eKicXdI(wivlc(1k$WFO5C1vyx<3P#KWc5l2Txmt0HbGcHMWK`KRd6~vd^6!W{ z|H7g*(Gode;3GmE2teZ8v`hY>feYZ+$J(y(M+desDzEI4_H3CTx%>W9Z2%JOU z8PQl?Of3$*CQO!Lf(4*p89!mEO9kQq0MwKQGp#8AZi-ENR)(V6k|P~Sy3u5YBNV`( zo=6p1xqFQ?Gbe47I}O5v8knO7JSYfNt%}utEFcotz{X9w`qi*P^Qjd2sjlilj8l{Y zl>LHaJ)k9(rDm<95?e{tAfh?TP+$-O7z70h;#a^5Ruu@~00L4l3jrK9v5P&(|12as z*;&X#AD6{!W;MH6&UV(bpT+Djv;kVume#bV?QA$i(F}K>HnXC2ZER&bTg`T36V1Sf zX^k;j+V}t0l z16V+K#k&AKr~($}MQ?i5yI%IT*S+sOFCijfUijA6zW2p%dR6fWOq7DY`9-gM{|jIO z7r4N|P=qK-F$??>0uc;0aD*j1VfQ*1!W71Eh70Uq4HwuP2e^qg4p0yf3qZsLF~tH< ztYV%fiAQN&6gyafRH5<_t^>>lD4dax*tHXW4SiHf_}Z8W5JCWi5G+B8|9oV@>VXad z8AbyH;AALExy5&}7>xIn4FEdv#^QqqBhTSDAK#U8Efdm^?}7s!^n(XF5J(#Y!e%$a zISvgN1UhhV(>v#R&t~0FnY0Y1eXw;MO3T;)t+M0v)fLfZ##+MQq-H*u-~lLzhCl!y zkY`vL)Ba<^1QrkjYk*qRqy{ut_%`S$rGpd2C}PU8DL#5gCLJOxGegBEFVRstnJMiZ zMOZzf|7~NTv%Z;~L_{!0%kRg#Mp%Y?eM?}!bt1#o&^>U`3Q97yj))3`51^8fCW)#n zPOUcXn$587$!OZDOgG&yg6+(RW3?l?@;Iro$uR_A1sJgt%FexR|1axW)$y*C)XMbk zPa>R<^X6!q`T-41xKAKvD8RpEEr<|YiQb;vh#`tF28tZ5+XK(FXMiVal8O zbj&G!B#eh6!oA3OnuvqzNhc!`0+54m>nfdH4*k-feddQ!{{;0-RK3kuKaze-0~8iV zp`QdnG=U7CCXv%pW(*H$7WUrvF_-zP+SxMaZ{!}fkOk;zp6FAtNE61E66t3?`bfY0 z^w`h-C5_0v?q}p2qi6=c4^I9?5oLNMQa`%by~8s)g801wN;mJRzlkUrQ1FJvNTogb zrA>Ii8JRwV%O?pLr1-NjPFb1-bO?L^hE`~%rW3#~>ymI7g;qh53sgA*Op8w9K>16c z;K@3$V24wHwfUov2o#7!SOY^K5!wl<77Re`qdta#lMS4~deVvp0zrew223D44?ID@ z8;BwZfFaNjau@|&s5~S(!VY{vYq2FJY(kuQ!l{YE|AEMdV>ksUK?-ol0WKs6Cx8Kf zQbP$)fL{(cA2lhceBNRP!ajK=;8yQSPHMBe%v=Mk{1zm`>ouG!pC&T+Hn0Ll7%FO@hRw61 zUw{GHql!XoAB7o18bn1l5}{R`!B&i$D7=Q_lN!75L4!zy0FVHxP^|;nlv7m1WAwlp zVnz-;B3FFH#&|D#M;KM~RfVll&akOUILYqDP90dOV?!oXLay#y)bt zAt^~#TpE;2$*2&>n2aZ&{0f*nO5IDsgR?$hS;}T?%G-fFa@d4wfW4MP!JX*Hp}flE z%SuMHyRIb1m~qOd+zBD7K+K^^q_E1GoWB9wK7+(bh~l1jv$=^I1v$i@vxEtubUUSE zOAO?}xpWY?^hY!!%p07DeEY#7nRwsROu|3UJVYW#=-Vwc(^&Bk<0zY|SHu@(4ZO1t8U zVau_*9Ec$(0A+!|q;$wSTAH-vAKUy$_2bU$+0C4kG>02B!#p&D@PPnO5iHA1Wc1FF z*hZ=J%NlIU-f7OaI8VV$&->9b&E!mh;Db7#hJly|aF_=dyB6Z4hIDiA6YY2ZZ1n1ExWNQd7+`(JA({6m6JuSUH^;4rn!W)e^ekg`k=u8dq znFftSM=gkbP=-29rb#tM)R34bg|`Ql(L}-rS^$O>J%~FMI6 zj6Y^I3mIiZ=SV!AI6!T(A8MV59EFCD@P{?X0W@$3Lzn?1n1KLrf`eFvJZOZz{IdH4 zLk?8e2T@Lzg9wrAqiC(V|1x3MDHVut$b=%~3ONXX4}b$F2m}}7zh4Rk>&!k@%_Rwu zSo6eGKZTTw6`&j&v$$A=C@=$qmW@+qwtxAQz$_a znTH}kf|Rm?5U>IzAqQ6Yzi@fhL^)cmgc%|sTL`4szZ8ptloXu|J8#*aenR$btZXfghR;|0EcJLsgA*V1-*~hu2x%M?d{s z(D_@XiaU6PP8XGw7^D;zKDLK*F`HlqQK*JRNrXK}&~{>nRSCGv;shGvj6h+{P~p^bi>Ez^S0EI> zljAn|1uNiJ4f4t6!%RCZVLk58K326q2EIU+DsrHNZWz~j&B!>p1EISH9Fom63}Q9f zV;U(+4K3a1L{q!a*jH#aa4-Z*IAB^agdTVUS)hl0kW*8RWFZ!0PFrP(vSb8I+|xxk zZvcgJz^72|fPE>MOCU=&zGF(wWBW;EW-DScKH|8fPtg>jF~cW5kN{JuC?`QoF8$hI z*5->f2ul8*W0u!O1v#GBhD~Ts$fE|rxVjnPGFi0dNB&ZGmO6M&sBRvMZ?4SEX^d-_ z+8>Sz{|El(3RxspPzN%ES|B#)B_3vqkY`S6Wv^^h(X571I626300ns9j~0M{hD{j0 zW@F4_S4EVN-Zy$~DC~7&q&Vrgjly3j00#hzi>6wQmgq-3MVrRvF<$6Q9V*48ifj;t zMjke5sDnSi2*Y52g2;jo7}%Luw3vS7nZD_xWoj>WYM3bFU6TnJrRqk;SdH-556Fml z$YFtyJz@NadjN)0xHaP`R;5l(OWhNkmJ^+JYZyj~xGrUm;DZkc4w$fnI?zQxEeKO$ zG(##^V0KG{W|m^MC&lKyd!~wfCe+Tx*G@LUf>F z|Dzu4-w}(wl(mgM(}p!{wLY`lzL_&tpl-;7z;+0;<_Ov(SK=n@AXD4?G%4k-zKZ6G zDuwRoCg>Ctg@vr{q()Dfz|a>3?Q{|Ci5+Qhb~x~cxO*W|k9=WAHp!J}mb8B5+k9`A zHDag^l6X6ZOlZ?<8}AwMQUjiAC{=H1^6yRM%jM>7lk$;i)QEL(K)G1(3ZWg8ZQ|GX za5$Qh33tbQ4Dh8LaHtOBzoiFJK);NTZihJ5WaSh!s`2MR<<)%HMpJ0EW@w6ush4t- zBF8D4YCa@qPEV$YdpLzD-iRGP)pPaQQoTAV?-H*#?lgT!3y<&2(5kD-s;VOM|FHtA z3mJ2)V$Qq42UZa1`lbnRr~^HW3WY7&%T?`m4&&io%SgNMj3BJQ8mzw}bjMOG#u9)* zPqKmlghz*TKo|#mp!7<&^h?L|OxJXGkOgJX^iQYsUeE?mCv{2}1Z*tzRHt-zIM;2^ z2UUl4P#5)Br}bL5^;^&MVZa7l=k;Fq^<3ZeUl;aauXSUv24b)Eeu%E=B8X*wuIjq3 z>=FoPH;4h4fNRJ03Fre@psa59_HPGw%7O)3Py}ud_i&f5a|ib(m;o{1c0bsF6EJsm zr}tMF1yTqGRiO8M=l5Ai_kIWXfEW0IS9kfEcY;Uwgje`)H~58j_=iXM|AvS7fd8-% z8!>_?u@fVR6cdPyzxX)biGC;sTp(*2f8>Cj0{`iUmEQ>>)CX+M?+35gmpJ7uU-7bS z@h(|1BrAxWZ?Y#7fG86PpMN`x1s7;&1zc6|k6;5Q_|ZE*1!4%*Jl1kNeYu(!!ytdZ zHledOi?cavGq3M6J=>|ShciQVaw!}I@f(SmCPJ8h!p8<=?!1#md*B4lRjDyjj3fXH|L9vgl8yWlhauJ{ zh`P6t+rE)N=cQ`e2U)mRycr`aSb?0Siqb!Qjg;*S6#jUwd|fgAvOxaikC}b|24aAF zIj<1jH_P9~{@QjX*XRD5H{3AS{E=`5S}6J32k{n}@m!L7ssV_90{;mpXz(Dyga@B} zQ|Ry^LV*w`Qmkk(A;XIrH*$>FF<~@qA4ifbIdLGzZldm)Jh*IJON!@C;er?QqeO)- zZ}N0F5arE`JahIeicqN0qzMU{45{>KPoNstWm4C3XVN?)gg67W4QfTA2(f}C`BQAr zhC`W_P1{x}Tar%S($y%{V!cscufj}<=0YJ-HtQ-xYmh8q|B7eh7DXD=QBbQ|S zaW3V|2JcercgvYk#60)yszj%s=FOH1icT$H@#>zFO+t1JaklM?u{UDQO_=jUXS7fk zZQYXGDP8x7yRL0KGVHgw&F=PnRIPQpEqiBg3;f}>l}VqE+~;glx9raQW{zHW`pDYd z4Z@$lbh}9V-sK~tx=ty19fdPWG4*t}9%b$&R$oW_&BvgA1yy$ucM&G_T|)bulFd^A zYJ^WRqIhE;f^{iK8H5`-*jdI@odv-Wzz(56!;hk!R`#ikq56bsYQ8q7 z=BiQ27mg@CmKCc2bG-4!f2Qi%Ag^l*yA-fQmRfAK2&q~uwXxwNikGlj3Q<4P9Ky>y z-0~S;wWeMhQMV{=yK21#eG9INwIQPnU0JHr3N7vMJFQ~z7CY~$`7U^`w8ZkeC}acb zX)ZRDl2sIYYr2} z^KU8Z3@>BH09+S&TcW3P%{Kq4@X!VEJgRj-n<#YD9HAwSC>OtcvjE$G(u~(M>nd{A z^g&FW$!l|pb=pSe#1AXoc#JVZ?cBo3rfHXmcHC+k+qTL+?;ChwL{&peWQg%oO(wSn zz8=(wUpKhCZaZmsewJI*bUmO%OBh+m;X;q)h6(f%qn-=C7U2_f?z-FsCDROLJ1Nbf z=R}>wtmRYt{GR4A&Q5!o0;QvgvWYG8O*UhfJvnRy0gt%wu^$XK@;Lu<3#62#B1j=-p_4f1odY89AN0V)J|yCg00bamsv8J3 z7$AWi^5YtyP)0qNlfu*hE`cB$;`)%-D;TM)qSAed9v_Hee7chKnG-xKcYZwU>m9 zQGS(!h!GK}MhhviER&pJ%nXu<{}If(ak9>_IgW^_WN`=~~*Q`+T%#gy73KleWAg!4ek?A|HTvCV>@VF-Jm zh!uSBhlBJZ8=?RPJ1SDjr}c}Q?jz8J*du#n zgzTNYBC-jIs6?Ev-k;C!d;8vQzrW%-=ek~x=N&S}FSIFPok`x>5-)pVH%np z#xS)+V!%p~Waa_A&rD!s_L^aVRBXOff5!pj)MC6Si*;b2WOxf)ZX}x3u`{Yy^RjOo zD3&OfRV8+O4WDphtehcZP-kXfaXgY_Sa^>ztEC$0V^g2%h@InL zY*^}-*!1Bgc5-c4_L%gr^s@|bm9od1Pf(rewG7+leBXV5F9|m!c%kda`e}H83pGs= z!uzAC_F0YAJmo5fev94wM^mrsxyIh5miM2Vi9zdEWLkF|s6Gu3JviAQaT&I!XkEfn zf(Y0x)p_;ObcsZXAAKftZ|!5bsl%lQZ<4=W>cg@NiN+Zde?gba^j&q{8~J;+=}DNu z)a2dI>w=6ocC@ExLaECXE^U5EbQo4=5sOZ)+9uEU8_}0KmCh4zB5Cv+-4EBb>Tn<2 zGrAA_bg=2JAPlM9YFHb23(JgDF#O96(%S6X&&A;)e{y$6uRgg3pLZ z{2uNv{4sgqtnI?q_Q-?Ov&c1}k$$$l6WNkE2G~o??!ML5oRpbzD>;`I%%x%|-$<;l zKvt{>08BZcDg7BFJPb?6O*(&-9(;X3Um@?ypbc|V8?viZ`@Y=2@YoWnyPZQA!o?c|l}-vycv zGK1nZr-@HHwpg$-!zw~QQeJm#bKjL6HLm%Q*4VL=w&poYac%nFVvXkQV$C{5)=CGQ z1pubLeyqq64Bs1bv6$F;b(XvMclR$}z^qTrS-8L|{4Uw0^~W59^AO}fQA2Z{$S8_f z0Dwf;CQjEAoyk!uezVPQUmEdxo{z%}C{Lb0cQ{^2Ji*}YmV?M(g%DEWb$Bo~aQ&(t zrD==9n8EGvk(BHrizEc_sOZ?hUXxzLYAK!I_jDi;tcwHEH&)u$ukR+#`1eq*!BY?@ z<}N!3jLPw6#Er+qjpNl+OBcL0`T9s>(r-vZZ%kA@_Eb+f6bZG3Q6V%LCjeBqz=uDR z_i@28C=}H=`+Y1m;%DyU)Js)Xz~j!{pP9lTA(7ZW_{a~)bz$JhJ^yOypy|a={fu8K zHkYR#T7dIjFck!gq`kSm|M9OXXfPj3t;z^sfC-ylo;JTFmw!($rIV0>CHntO-RR~c zJurYT1~~u!$aKFiA+fgj;Iuz%5GYLqQ2_kI+&VsYKXDeEuyXzSA^EZCit0Lsbd!ms zBO8F(g;`ZJDec-e5ndJ3@*HLCVliONgLjkGMm; zKK1QBeO`e{zbzGuDq|emhw%-%K|AH*4YKsq@7@n}mh8y8^6^ek3RDod&<2fHt~fzA z+os)L5_>k52o^WCV>OE(Y5kBKX13ORVir|y!ftLt6w4G6dF!IrVN`?cc_-+Y7$T@D z*?DM)1l9`p8TxtCH}4qT=Q>_oQydV$v$s0!{!HI5%)TkaV8iETFR);bJP#Midx-p8 z2xQow4t&1Ypl{*2-N-?SAE0pLHYUtL|1D;L8H7^(|?!qW`pXl`T6JBz*fD8w1j;SoOF_S*%z^ zDi8R}Ay?^uOT8@V^-zi>l0X3PfHeu&7wQyP; z*w$SrHiAI@-+&7T;Qs%?=r@+bC#(oR%6pzLmYOl*>kgqp;vrV`T#8Pl-dW*nJ-Fq4t=CgMEaZ%)*C}|^VxVZDiby)-7mt+8lW2qq644fX*8c z0CN-}KP`97j;hJ5qyR|f_9F${0G5vT!5!EMK8V4d!?WH6FtO{72XpVo{;7VOP+_LE+ z|CdcaI=`n*>{OggPDzIVk$(@O!6P72MfcK^fHuSMpaPgs@_j2+PI99C?kRe11vG$v zZ;4}DgT7M*VonaTBZG5Y@P><;T4(O0KNLzOmqTU{^ipz@G%aa>Z|(Hk`^ge=)e!K> z|FzSL8IqO2f9BrU3C(E`YFQxqr2(OHM;szQgGeQ7H!P$y<0`nx?QJa~WLhOAik79e z>{|R#+04Fz>x~-N+wql-)QAC7F~dJVos*~>6Cu^)kbJjt+CaZIs*N8ACxGDq=CGfW z@FVikuqB&!DpLFuQyEac(Wl=uYd zA|^+9!(LKVABa3xT+yPWk`9TFh`YfmdqTEg0$=iJks zrojQwp+t8$0f6MvnG+WvGWknJc2a;=#=)r^nMVU?zHlPs`#OL?LIU1RL<|y?m{#Xt zuK4GvhkX=wEc^QC)>B88N)Yx#=5;Ty36lRn^*%ots^t@nJGGymROv`xCsRQH1c;Cx z=w?hL`t%z?$SVK$^ z%9a2EAP|lb=?2#9KfYV>mQIx!0}w}LK+(|gZ)Z2+ZmYgqR2}D}m-4Z~5BG)$N_KFn zMk+Y~v%frx*WeTXh<{PjvQ+zsw0k%ArIJnC?Gx^DcLBCiAowDQo_Qf>NMb-u*io5* z5Cxe^wnJ@zfbuY>ITVMnIUbA*4zRJ$V~FQ^#R5>1`bQ`Za{)&ffo8YNjU6@pUttP6 zHf?>HsVM9;5)hk;lfqg9C>|#Lhq7#;QUW+p(J(u{aJp{rbE7`S-6=6yR|KoBatr~0 zA&F$@_ZVHQd*Npb;aafuU97o0Nja_dOMZVk-NmPnv8-CDP`oDPlroXKnky-fVu)FZ$ESV!5q^c|=A_z4a<$js+S7|t3Swi7|Qa^iZ+JL7J zNu2&;WKjlh%;k6P8u7l9tc-sJHss_WYtg|ek42dfmr&Ez(JQ_34riv)6k_vh4o`7L zM2dw137@bc+yKhVWkicUf+}>hF2J@U3JSN?hwZYi zkM3zNuor3=hYmOA zV~=9>2;>&}HPhgxk(@{<3>0}%{FeQ?62W_^4^l9DoI>(xKH`4pf>}41%MaWKL32i7 z1tVZM2&5~n7!g|mu2iGqrdpL9KDR)F7(KnJ3O52+Y&VPBmY@PATMg6#IWx`MP-(&9t2w}XUo#x~@ovVU#V_UG66f<( z0rb6J7A{*-U#yP%gT|>rj=x)RwH_DW4#<^`tP{m7>8k5quJ(1b*qw4|q5|nxYl0@k zwj{&4_&QKTFQmhwu7~X7E8#nZJAEx51p|UDALt7ecTYrmwb9s4P>{5=!e~U3@qcUt ze>HC=&muJ-hK0T<U9}t6u;|59cOjyK#LL_S>A8TMs6>gqn zBx^W}>-=WK1;sz|41+?@>p9+DXymp`@j-+Cdy{u!NedTAp)R(-vfoz<(U#qZ*KQxn zTzw(IfvwtKD1i)p@2^Y{l*IRE6AnU+F3rTIQNuWdEYK|b3^>`uI{m8v8bo2FuTz-I zWu@cM5`+}?HKp8ztv2bW3LoN7Pn=VF`UnlkphIVl+wD48paon6LQ#J0AE&9I_>hat z$RHIrJ#b^jVTYTZ<@-^{$n%6^ap|yi^FctQ$4m0r7EUX5^^c5u#JY@8n!81q;a z^l)Ej_NY-b+FX@*J$8@FziYAg+r(6m41~?C4clWxcF|`Ak-iAmUU3Aa=HwaH{6_c@ zzKT@X$T!Zs^4Ea_@=QsRJ{KD4z$#g#)(deCe;-a4?;L6Qj`}zoV2fG!0XHlnT$g9P zk<`H!B+&v+34x72YyTbm>zeiDB63|G=Vzf*0u)C^cRMlyI*N0(Q?eS|7x0oPoBu-g zuz7s*#f%?$=NYTqlx?4SU+4r8!FkfN;6D4uGIaBYcm6!&L$WO zG>rWM)@qs1vQp z4gd!GzDcJ+=k}52<&ilB)Z{7=$vm8r`wuzH!xGuF80vtfb26?ia9vY476DbH5zI7Sj~3&7!EDV6BAdk;w7NT-W> zad-3Tl`&T$<4MnHb56<8;gqR3fNF#+w%eW)4R-zo-s_JnT7X>+C*!OqZ>B#^5YyN% zPm=u|-y@SS;FmD66s7bWcL)bOAP(ST@Ka_IztAPgZ6>|TFp{cAlk&m{H|1IFQgBcy zgN-S1fBoeRQVtKtvf6D(Embh9OaVPk86QUEGoTSzR8o!qSuuQ&r(jllj1@o@7072;u>rF}3b1h}dfWU%fv z!y6&iiXieycdY=qe@cHGE4hoop@+voN@V5K2`!E zg=7JRLYIXid>DiwQ6;R1_kivn7=J=6;Km@~R)k)^0D>T`tzY zEH+>$F_J4Wu_!SMD7o#ZEZR$~mP@QJ|AW!xN*ygqodZf;vP#|BOFfoLxt7VpF}QeP zq-t~#Mub!e(_}s51%7hH%iU4&vL(Tzbl<(*f6A6a4DrV1SeLPAR#Gl`3(E0k%KvJWYI%E&d|R+g-ZEOAMEJIR^zCblid!I^hp#G|p5m>KQDJ?*5kQRbWF8phKaFk|ifWif#~<yF&g$QkPh*hoJji2q6Bb!6hAb<~H&v~MZsvoWHKg+$oH0+Orz`^G|K{0#(b^-v#@ zLJ^V`@BdhH6wxOX8Sh5JrCT-LSS6!;p)})D*{gE->}H(l#tkQi&KcWIqo??wCcGZ9 zHvk!~A=xK@_>DL5!4$dvVf|Nz<_~hs>=w=T?)4K{&4KQeR&RZ*{k^v>zLqtbaV?SWYadz)m9>Yl9Wo*e&4mYa?cTRJ1h(RW z$g;Z0|JL1t+_#2pn@@Zrt2?8(J4TYIFzYHT=g=wdEo;(g3yWNPEq(_{dfNS>@}L#b z*9K%C-@|Up+9EW`-xKmghR)^pou5}a*RDF(v5Z~Br*}6kyLJP+_OrXJQYsEsx{j~9 zPTajpTN~LOIxJqa4>ER+Gj?{PNj~$F&M~&xEaaV9cH;$gf8+;*BD#q`cSFa!NSS&l za=P-hKm25D{q5eK?f$mX61EB_5@-8YCT*S=rt-IZh<}f-)A-!Ik=gydo?DOGMq59B zfO7fE%QqeV@|DcGu)k=6BN58mO!l@Q@9;%Q`Z53Fj4T7dHk!1xdj2rA`pub3P`hQv`wpt!;UgooZ#7q^o3?Pdi~<66~g6 zj_7pswi6BA%NY?Qw?f82$3Krlr^kh#!zMb&#{~dBbJ+6)7}b<^I0A%Q{}DX(af}@A zD+tOCC#ysO`;~%P+&kj ztjqu+TqVz)e?a_g3OYSSkn#~f6!7~+LSO)+=?tS61k~Yy<)NfZQ`*6BaIh`0C_L#{ z7bH40BUBBUhRuoz&X!WIFem(amWpW%3F z>-ftjOU(dL>_^h}TLT;R3B$ZxsJLAGaJe*ixjc8dl7uOyZn@@qxsG|IL2+dnMlgn0 z_Hu*K1IvB3gavvJ@kK%H5z)A8pTUUF98mJRoWL&_h=UUdsQcUpWP(p8@X5NU{d zZjd+Z27B_HTLJdv8`D^m4CDC+=GMEycA?An%S)|SFq1jhvh z`>)~KAV89}dJ}HLHiefrpr;!kzMb1sdG0Q9-lTlsE#(P7xHm;^h5=+T+l#7;!!k(rUKR8Z48cDGk7}~IWZU=vcus;&sDPz?%B_)uU5>1U5F5_Of@N=;LHJU zX_E-%;cc3Pd$=3BSFVS6S^I@u%|C+SFOsOfqF0%FNMJA^9jLjD)~nH^2i0HS&74c?r8>Abak~<%wI=^iAJegRhzY7XuKdPq zNNhJw{uxHnB=qiITyM~;eR&L?I&NP6>Z9~+zGi=sl&&X_>Z+S?v77vL-rB$V8hxy$ zeS&xIy9UGe&b1Tz&3(Nd(oEPcf#GSF4(umzau!s~^x-Q6n|MM%_+#Pb5bwu{p3mti z0`>w1M!?qE+sQZ3yY5}568B)t*xH%nwI3{xW$v|&McX>?imcQeXPa{`LbB-a_j1-}WX~lS&4)R}v3yVe}HgHnE&`Z|C`dvYMYOcK~&OAIVjzAgz7B zvsSy0FVcc``(fv^+OUty_fKpitqF+M3?pI{kKMWXK5ukBF52Bu zn113?@-iHcJJ;f^U2hSQP)&f4ajQ!zc2(|gqcgR-Pf^l0W4&of?WrDWQfbnebDz19 z+%iW+KbfP-HQw0ly{TvMfR)&>3b(e^hrJ<1c|mKIQ~#fL-tY)~vJM&A4=bD94ydM3 z_;y4|Ltl`T)JtAMzrL$NT6{jL zEHJKn?pRQg`_S%M^ZvYF+DWZVi<6Q0UQG3VQAX*_Q>A~1w zX6=SU?P?kP{^x>>cLl|ZJ5O+39=-M)hfswB5TCeQGmj17CV&2AldjmEv6edqIkLhe!#su`c&S3+eR~;(!}YKyam=cL`<~>5pMN}# zT!@Kg7_SJ$k4Vt4{u4qI17Y+Syc6?h`|aJEfQ8f7Kb|c)-4kNcLs@n34S61)zo21L z(7V_c5&oY&Q*gv~*_RMg*g6nOFm{jnn$vrwCSP097EfguEOrDO8;DLk!Mj5@8b>5QwV^DAxTM-1V8YMx6U{#&M zcj)iN#ckV=cH>3CNvGjX<_K_Vt14}GZ|uDYd#Vzd0Uq`+SR=-s%D+C=q?|q82I4^1 zGfbo%)EjTF>cBA1t8NU~Cq9mFVA_$bw>yaYy``xa#-OI0p9^@e!I_xZYY38NCMJDNY`wtCns<4P*@A#MfLvX7+9- ztv13*z|uAG(eRJ7vy34rIu{-5Uo&qy`kmxm*odD0oyizd-4))ki*uBk&76#ImMFP1 zW*y{^wTSI^mTJz_^`uitC(Q)dAPDFcGiT0LQ$EYS0oqOi1K;D^lOLd;{1%MseJ4;y zN|mj8`@D!D6G7W8lz}F^^in%GqvHH3F_r2F^Rf)h2fVw(LrxI*xUMQlZj0&o!2(b? z0-scy$1u*qq=>82MX~M46TCN4e6G7jH`7_!H=J!Jv`W}CS~z?;zG&Z7eA|h-pqLWeY=ERuo0yiDE#aprM=iRIramW{Ip(^>w2{lbp&UQjh#|<`#RUTS7JwYr!Gi7TZ zuQDct0p6$xM69Kj`z`wA3X*K*^skP#;Lll9muh`c;%V&}Xlanc!6#^re2kjfb&8SZD+r^vGMD@=rxRTvX2lTdSCF`B5qs)yKS)j&ENt~Sz74y~8hxR{ zl(wWBxO`d{R z()UkOkZ40^e}cK#V)_WB7Cx^VcmA_FdpKjLc>0F=Ugc7o_|eGIjFj>9sHPWI!b&1) zOKfo-Ii_r9<~U3chg7}t2R-shXH8+FF4Z!ZWqYx=FvR9(a+Sp%=R8e$^`5HOzw7{U z-KkMk9mEZ`(-L=vj+Uja$!%ztQ1+@Y$r0SsYHXdEekNSQqfDmXdcZbEha~DM6j3qY zR&AM;vNjTQcXjt)7WR?USj(;PZ)R^!&EzdvBYi$|b5S_et2TcfoPms>Xjq_@(5eH7GL8 zPnrIvGHzCW*K$qVhu+>b)NZ+-r6*b-j-0bb#t!f0MNE}T^WtQc<>X{_iw#Dx*4#mG zPtjTUo$#tp+z}3KE8<;1o?1K~w&QD@y8B#-(wW9pYu){qf0`eEe4Ko~MOVE)74(^6AdWqCInAJ!s20H%_KN@U;&sy{q-Ay&* zO~pd?swQ*4@njD2$^>OF9W8W`ur+6ie?R&7zLO(Dqh{kP-tXuGto%v>{)nWM&z*@| z%PaLUR94+EA$Z*S5p#uq3~qQ}d?3+Q{XqNo7SbTJCfy5`2T0Hq>J=9!+Y+Jd?@tUj ze|ryE&Ls^~WhG?pR-WJ)nzuI2DzL|A{|=X) zbP$?|m!Ixa`qPNGj*q3vu1YPh3YEh*Si(!Ogy!>hS7K7lh6SGyDGFaH_`mMH=tGRP zDXkC^(K0mq~n#573$Vh>GZ`-suG>1b8%yrT~4|&@7Tz3L)E{e z41sh=S{a7@&j$jih}6!J>LzjCK+mc}jDt$=J8%Q`Mbn2oIn9Wwy9BrOj$?bZX0+aL zJ@7Opa4OOmu9VoS7P>r4c7>mqqaOG)Zu&4GnRv*-F~Qh7iepPWSUT>_1Ao?Au*XuIK&dVq+UEU_K~d75fic)-+=I!8Q;Bkk`%dlYkwjW(0R;gnrHlug+*9 zBAkF(G09nRwOMhJD6GCWuASzrbmXjz+U$RK?@_|vB9Z7>#hqEDpR;#yO+?fn#?U!s z$vG7@6In@IRlwL60oAgoG+Zt=5{oe?oC`bQ40pk~#h3l}i|@&?M=|L}R}s|)4#bK? z$X!HIs5YsOC%o*a_(|N+-#s=ike*Sc{>QOx>m2IG#}j^H3Nqk%{-i8UPA`eh4CKPI zprEtGnGoWFXJ+0Rd7EEhz&XYQtUh=Ht|L&UM2keG^1k^$bMw79%E?Q-uPIOo?01qV zfMoEU6beAD9Q6pDM;f+>W~eam{P=Ju!5xSUwu)ij2VRRqh3Y_tv!ZDTEg{huuj_#r z`R3LcRV)R^{f8wQiFK956e!JA^Sy-1icJD`I@FXEU->J(N_#W(`TYstUV;n=*Zd#Z zZT4*8^;B(SxH<26g8$Qd*$&E+sGgGXrG9ap^a1rPmuO>XTkHjp^$c8Wx%37@Wo90o zTO!NMl$M`XmCLZ~F0h=huzcL{X{sFG0@eSx2yeMVt85srzy$ZrHg!#P^ZN^n-vpN3 zy3igf#@=Gfh;@7?Tik%|fpQG~gOdnX>P3sEBVE%UHX?@N(OAmy-5eis4*eIi!A&<|I6OsfP%*vsEx3l@bToj-hMrTWNYA?X z+xuTj`1UT5!;V(T=3#7picxjZ+~&HR-l@*eNPtu9s?Y4k^gVVy`&7_sOw#6iYO?E6 z#K#@$WHbs8fkdz4n`?rJQ6NSrq~VmreEXASN!ttq1=%kKSco?HTFaSa(wkM=M3;4Y z6aL) z@N9c_Mh>so)Y#h4&TE}BeP~kLy+ERC_-*CFG#TToKBFR;yz&Z~)u`jlq;gDq>q_M? zZ8W68o_Sjvn;~}i!Z^AkAV;E>^UA|MJM~AyvS!=g9JYV7;#+j%GA&r6(cv(<+i!M4 zFU>d9G~3cFo8Na}>~@DgRDJ%zY)_$15h8=<8o8Z77fx8TTO|nP(*(O2v`?kMZAsUL zxgO0&?qt2%@hNqp11))%kAWv*Y*670zw`vHVjiX74t!(OrFoeB!x?MzX)pSCPit}{a^0Yuar{b z(%;3a?-vH7q-*N&J%z94zrKAqwY1%h3!cLD&HE&}?udrpQ_mo*QiSgCM+ICoG_~)& zj`^v(O7*ULdKOdFo=Qj{n!_+&8sI^@}TO#JpT<=*-qmczc9t;yrmK-;634a&L8NYi0bhDX^&-L@IW z%O7@pa)0>5*E}9=|E~9Z!WD@8NJqJKfC5lo&c1%hHB`bL3w2NoednC^4AwuDwDtj~ zA3dSI{R!|o*HtP>2855&5&NQw(ZQS2emWhTbjJp1{Y>|`zN}ijtlqnSHnuf4o}d=cfu8)euX{6+d^OXFrL zIl@WvX7|O-p7ga|*v$+pp0P-9pi7LcWSPHq*)t=v7upL>)WEkl{x7ipucMn|VsaH8 z4E32ul9`8I5aJ%QB;m3WhrSv1o{aI;yYn0u%A|04I>iRp4@d5MPswC>+o^!S1PoNR zh6s8pTInZ8`==Zlo(l-;zrX*%=zRAZJU&f3YQ5&(7%8Nltt~A*6 zJsHoSE*VZW|Ni6K7Ki1FPaCu3vzyL#bz|mq^raSjIYX_?H1?0q`cpDdAz?Vs^_k% zX!O&2XU0aTt3#AUFk9xaWzxi4z?fHd&bO8Qz{}P3^yx0zWXD+6jStRd#(o3ECD^=3V)7BCjEThp*QQCOD)OLWa{cd&!lT)~sWOG6PLmE)` zdU8^&KgXz}+mE@Dz>v*fPNt4=nl9+f0<8i}Q0}6$?zdt4F+ENnjYN1ll|PG;D*eK~ zHcANJ%^5A`wEr0KoOe4~^_BK~Oi{b@jBOSGeHE9j%!`l-O8?ELS!m(NS0_k5Mp>!O z-dX`J1$#%fxqCcNpxen4j^DmQ8ta9))kpX;&MMkh+yV4JdH;(k);f zn^tUXnn}`F37hLBm_z?!NbdYaAl!D=dnMp}aP$5sb3!aY#CM3k!|?8+?JGTv%McR; z@F8e$_ssn@}Zl{v~ZFe1#QpT zp>+cuzQTAcw7>oAxuO{Pf0g@Uivf+h`jDN&`J=B&>foz1nlF=5G{cs?)CUcrN^Vxmj z&GU^uMQwLzAe`6P08Zfz8sH=&>CJIpN9uqINm?+tNK#||Iw_+JymYM zF+zEi2cH5UO7$jWTk$XRtVW>?BAaBRRr~t-%i5#UEJ~iYHTyR z)RNcuup+E2)@BVTO-*pA3upO@(NyB?C4W^H!L7hXXw2IiGT!Ul-5RaC1Vh2f>!PIo z+I}iUb}{}q2{-u41`FryXN&XZXCS7+9mDAIdmBiTxT1ky75l*3fh7t`t`e}5yehx6>e%Of9PMDL~RD->14dA z&owVr9lbEkxao-^SpuG$Z460>_>e4^4u_H{e7Y=7SM4^5dhI*D^*6)xZuBadMceC~ z6C+j4`1K;XG8qk6R3wpEbZm1U69j46jVNu< zdfPE9g#aabggT4PU8rz)WTu6f;OM71CUXTp7}Zr52LT^7z3FBf>CH;bili-lB{%s$#EBftO+_5d^Bn_=s;YQx-UY! zJT?zSc>X%Gf(f)JJNleEwUB6Fd}9AW4AD4XMEGz`$&iA~who-mxU(Z8f1vSXhLkJt zT!$5(u=GuygsAnI#vMLTY>)vF8XD)S%@oJ})w`)E>>R2|>96~oTm0T}wz(+%<#_T% z5p$Evz}>M2GUcUMPL}rd#3z+}Q*YhW!lIWCG~bU_cV;%p2P=-7|9P6Is~gS`C<2*Z z;=4Pk>TLTV<*m%u(Uht|qv9aW9sN!|;kp2dl2ESLVucRH^a3{23kUF%CRf`cqr4pGG7se+r8m-+#-x5@s1hWe(;?T zV;^x{8gjk4Nm9O@(1O8t7Wv!F^u3jjWtT68EN#pBms5AyDpb*>C(buQ;x4+sUjl7K zeWxsWbivdt`OgoBv+T zB!1oGmRlB!*X9V$y3j-)bJe9@(q05g(8K=mcA3(GR{^b*o6(BDe(A)z_Pc^u`dh+{Z2dNjtCS)90q1GlzzWjO$hM@KzA~5H2^lS|M>g0-@k5e30K7) z-}mh|JGFR$TZh3rZPg6=)fh4SP~+*BR*fb+0&rKs7Q~x#i;?#KeluZ2;^Qwc|44b$ zAw+}##vP8q=2IQJQXga|o?1Uuh1t`{VP&Vnh0Y5oJNMP^%FVcY5h6Hq_e(GlLhRG$ z6~>)kE8uEe+J?`}iIop5v2sg&LeGoNtoCH8Q6+*;0DJc>fa$?|V0nVvSiqJ;y&UPg zZ%s?7TJ$|+F-i$6e9=SMbrMC}A(`iMF(BS`n)Fg(n?v}|h;hit4-vH;EQd{UN+icw z9#&!JYMLzAS4HgSMUZe8=yJZX>t_wNLn^_?FI5)>1H&WUOB-FSytgFtts53$@Fovb zMZtJZ6;C3+9Njy+zaC4qegDhT%ymie`vg2%GIWpZKprSiX=DYaYv3KDR?srnwQdNH z5iGu`hy6ers!Y|3jxPs6L}Kr%0@jK~uanlvj!A8EmmiKVaS{L!2I3pXIA*H zazdtUBn*?40?EEJ30ZiMvpSHY$Fz#ECER>K^sZkG$#l^rU)g z!EDG=3_KlGzYb0fw%3qB42|0cj#F6$M^LJhQr!$QP}phZ?0 zD`i6Na7WR-VtW(Z4+l7Ki~V1A=L}Q+7|Vf_eqm^s z=N``J+|kIXrok21M=!?!N58yWx-paR{)^w6QgZDMdD zO-I$xTPqn`&wkpP{l)Bg6flHsdUqGON%nC&;vCYAQ`jP?PWnOI>+0j(1m2wbOX~=s zEqVsdoPsT61$zqh*t`d+YJj?2Q*WFryX$y2VbGSkEdr3qFz&FmAm=>Bu)=3Zlr18a zmD8AxO@+ILbOHwRLVFY7kt9I?YaKpQMh_sV_VyIVKqyhGhDbXkLwiDd?`RWS?bv0- z7}&2O8lfy@q8`{2%5O0sJRHh4USiV}E?C#gkLhF9&ulUMB5+cP!g8hiloIZepa@3mJ4_rJ)J2rTx$FlS zf)Mo78X`<8?iED^{@grD4sxUpc`0=Aq})d_T5dwb3LRv3P(6c>aXqidZ;fbuybXW7zISxzTY$id-P$W(MTw@F*y3*+#5bX!p|-lHm^9{qX1g4x3=g z&3+V(ijkPnGtIbzN4!Xm$D_RR+*oG{c2^*4H?oSGJu|*sm9oWYGuHn0+WAwQ z6e|gL&MQ*m*y^bGney}yRi7kfX{Lm_ejL#`XKqs0r~_y1<=r>9Wszd8ISa1F=&!jc z5i&Wwf>4WkDq`m4f?&!0N23+yGk5kdPWD0DL2iu68jzF z^BlLwvK2Zx;kvKrD_SQq|Ll2gx)mND6tdi@7b=y1cdwb|Eo5-Qn5ECJG8Sj2ph2Cc zT)m(v%2~phUjdi@=k$Cf_XAC39Bu?wCDlty#?ZC%z_yKVH@%_YXX}1jL`8e4Q&Bmw z0#!I~w_8M27>>v%&4ooTraj8zx8iwkgX}4~FAv(~(k%X@Id;0Y7)Hv}DNCuxZ~?d* zCe#Q9GTY74wvdR%4f|grj-vFs9|uW)*&0+(3z(RWbNjgmUi9&;7h4sO^70A@8Xd{< z@wJN))-N0lhAg&=eGLxv=rfJH7ZDU8XkSz z65*vR#5oJ)drw@i_W4DBx|wzedUN9`$*6pv^Rmyl4f_#rk=|Bxv068PXR@O~9LZaJ z=f+#ee7EMqCH41RvdvdDkGfUF&i7tkMsk^hC?MTXiSI#AAUJZEZ}!5^@M_4EEnifB z>+YQW&A{(kha;2&=6nL77zfTQ)R=9%iR)@zLT*n7yYWAEn1gttJ4khjctZ37j67X{RX z3k>%vy7GK#fYk0R*Q{c*$ca$o9Vn@N6tTG~`C%5IT7PrO=eo?ZA@(}s==(bgjk_M< zy!&Cl6GAD2@{Rv0;|EO}BOa&uLa5=OT(Yao($6`D$8hBoc@kTfBCX3y< z_d{A$`A%5_U#%E_Hjec0p=dV_XLdNfOb7-z^cV(3AmngBp1a62uf?CE$W8UOU5DnJm^Et~%o zCJ-*#)F}T!Tww^?sL=A16AqT26j$17RQfJ{_jlu6tT+PSSN?Y|9NL6rl~CqslE=s4 zv+Wg{3lmL105PG$Oum8=NWd0Q;OJ$#2)$!+F8>>G`?P1}l~8yS#*0?|KV02qP?T@L zHvDUs-6a=x>4pU)q#Km(mX_2dC6yK_mk#Mrnx#QSK|(;lrMp8~K%_xRL=pGpe?RxU z&&>0AXRc2>bDh_m$MHKv$Rf2rHt6y+@UeHvU47TUvcS3umOUW`p9%m3hCEvZ5vb&O z(6Cs?a_^OhLOB}_HUScYaW?63^_4Qd zPw`OuTfxgc`wB`shbFs+J#@ZcK^IOf$4(*(kRwkoQ-7U_hZCJDzkv%DYR~Rt9d$bu z2gYCyZ*D7wdM!;w#Zb-~>ab$KmEU`flln?Lx`{bQHy&5@7ytK%;z=jJ}BQOE>5v+ljxdir?qeF90~byz%! zyQo`ybBwr*P6L5RT$f~~aKc@H?Cm9|GG1iG{D8aTt!9r$tTyksap_aKkJx+yLEt#; zIYfg(wv;=Dg5cx@LEv`4rIoB~G)Vv{e{*!3j!XlXKhQ%n(1_1XHcz*vEG)I}KC=I-++;?`0G<5Q z3#39Kh1f)--rEp#Hi&ZBi8yPN(W(1jN^9zi;aLB@M~7_<(@56A=A@@R9X}rT?Rm8Q zICy$bUmhpcp=C+vf$0wJlV=wwsej#OLNxwmvey2upnc_n?;lsO@$fVIh{z|KZSvgA zs<+#^!>BZ6AZ0yYf*L4>Wm)j?qU(1PgL)Qp^DHk~n-me>=m^@FN|NaXr}nOUI9++1 zI?he+EUh?Yg5VZ{7+rM(a|BqZdXqakXn2DdeB! zuVhXgG!vW*Q%x-Q{TlbekH#*O_Xo?PC__!!w*D?4SVsG|ef3_i@U8rT*w01M@G34OK-tieQ_Tr71Y+#aUm1SyR}k z_iZA>v5dC?895Z~H8xLmR<)fKdFK-YGmcPiATB0;R1gdUKhD5h4-nY%rEV# zFWU=L>qNOl9rZUfH3;jai$Q$!*!d{Mq&H?zFe;agI?@>6E#~%367@HKrLbA6PlLd( z&3avy7gJ>VDl50^`^70dwe*v--8C8X(tke|^s34seEV3cvr2)E!Gqjz?UEX8$QJF8 zsbD5;ETL)6q`xy6Iq``wSI6oS3RR3EG=c4$4n~cDzIh!JQ`}j>C-Nk-4~JK zU}_t^03BW-XL(G$Q848_%@D*G&55DN&k_9I_!p97Vfy^eO9#Pw8qanD3gjEUt3Lb} z&-zFNrE#DAIRgPXXvz-yN(TAw{tSk2ReL8oQfGdr)Xac!w0zQou`2YPY&i{{@%y7( zy?48<4(TsN?LgEojjDcpCZJPdWu!gEWpWP>pg{;C*#QE8x6)1^T$(yZm)NuH!%qF= zg`TIlWD0HdSbTc&OQVYF%1M8V7AR{I!(I*ttD8tAjFq~}_US5AWCQBym#U1>Lezd^ z;#5Lli=Z6%PFS9|kg$}?SSP&UT>ay=tKX3_&!A`36dx?Z*+paeaoeY&fs1%vdNqtP zuOaWh-}`i!NCil(1_fvlEeATc2Z0U$muo2rLU9hwpTpSdqlNtpEpuXAzLcK$Ls<={ zqYE*ak~TPpC!ESSX~=OBgm*KF&!!ll#YIBB0L0=4Lbx0I|L?u`setI(a8OmhaLST2 zwOc}IHv{4&l={ec9)q+5vxW_ty6pcMM%T50p<4fU82x~Q!`ZG+l!SmWe+MF*Xw;{! zXGh*)=s=lNN2+7v!0^dCRdX8WL84OOWeRzi$UfXVw7wQUljSyXOyF3_U<&Z5d-D7W6-r6OMlte@LkY5N7vMz0NHx} zT{xUU&u&kQa+rQg`11+e)60RW3ELwy1kw|QutSz*w)mjz$p+0OEMN4#i|BRg1nW71 z(>T@sA&d<``Dg4DBGDk^njEXrJI)|%w{pxR2KJ#mw4#f(U*%w2zwykaj@kT}Q=ik#J}a5X{cxc0cMi6|+&T2ic1( zW67SG(NtBs?fT4qM7pq1oN9^rAKpY<6L-YcPrjmW`<1z~A`x!Kehb~ns-od9JVHHD z>j-u6qn{Zyt4^j2Wd{wwUBk}`?)Ain0!nrDDIN_f)YEH=MQSD#_O+CC3Yn0 zv^dZ|9uGL>#^=KO?QiVgM^i5s`*CqLEaB?BlJXPlBK; zKZi(?5tRIbwTu<#0wtD?aD9zW{wNqEw4yjB*=fioQ?Ck>$hl{uoHlYs^WL zZpG`HGNQ`X(SEb~!ILO#u;uR^m=H7b-3ZTmay%N?xm_sixYNzCSi_;*Ls@EFbg_iRuxEVm&(lf;WQ#3 z`qy?WJEJIUF$4bK{cmRQttPUbuuX7=FahEC@3)%QQ^KeaPF;pY7Jrl+b zigf3&Id(+XnmSILyG;D`5IOcbe#gtf+N8{2p-gFkg4bf0H|_yz%Cy){B5n5{7&qef z!~RSPf_O4O*#MYKA*nPZm$qjcQ-&sDX_PvV#;SB)%Iag9)*Q8?BemUk4mooX$AyM7 zV?SWtUV48ziC-$2Toki(*)g@Dn8%b$V0BU?ND<1kecH5noDg}p{>WAd6_a4g5eK#Z zW9nW(l24CG9CT?&52&n-;8{sMP9hSg#c9tDyOUn- zH6_IL!RT@NevAu8*ayzoDIqs8o-{GOEFZp{4}1lue8pn7%YANFf4E(9db>`HztM-k z7x3uTK`~fQMc|dPVB1@8tbm=L%KLd^V8RDAWQ^KN-%|1vT{}hWItbxW z4aIF6kt&Vxi86)HY(PAT(A<1R~yJhDU%31%6?J|ANzI6d*O(u$ss zxZ}y8OaF(B)^g}uObvJ|6?!DJc zZBUy9XGrj2O-;4koM;Zz(tPBY*n+^rP-f_Ybc`g8Vy^E*lB?;NRya!qyLXL3wQ zXn#JJ``V!OvqE3f-k|)PU4z7js0;B$A|!^|Agf$KGUDF8>5VN{jz$$G3zlmQl_9qD zpi0L6fCQ(XymsXm9|D7L0XdN@W2C+IE5ClZEKV{rmAj6nAfhHcQ@}ByqU@3MxR<(S zinQWS^OI>2TYtvh+e&ooBi|He`{F@)CPutQZo$a^YC}$ z!|R_9K~iXF0GhZ74ZlDmrR-<|>=>HtST5{PQuen3?D?AP1uyJHr5q#!9AujuZXlcfH1!w?Cj%O9pHF9Ld2@Xb`AjNjc)C^eY5%0xwG)DHwjBFVn?Hdna*lQQ?vpgCDp#u>+0vG zb61#y-U5e;tE&+AXI0mkW5*D1>7=rEcHS6V-*DX2?u~B;`GG{O#^F~E5+qW5Q{_w2 z)uUJyVr$cU@o)28soQtnExkgqw_xap^yQv8E3%Lx18dg;l#51r7&KX}&MIyro*6OC z#Efq5MZMx2RPSqzam}YTg1E ztMHT3-t^=E@~!vw4ohqQobnZ*)Vb7teZ`$b1_%ZETn!wv(5?6qT*uzv8|h{@IGl)? zF^uf-{V79Y*0TR_I1aiS9L}gnn}$`!5F=_yfPr!SG>Il6l{1WB?39g3Q_#>u15mX# z0&{vU0faKiBME36DIfG~+Tj*1jQ-kjcTt4fGB{8HvJ)h!35!F+&JI0vfj0aY5)LHe$-~Pkx3^j zBj;P`Et%V@YEUSe1a+gKNy)e%LM@V& zR@cL!E<`el^}c0fh)WO;`4LBKJ2IaGMMo)<$t(0>;S`S@sCp3BW812 zAOMS~yk-1eRIrW%UR$LuBxMkDbxJ`XsooXOWfr1bA!-Dg;0>J1_=6>=1-Li1rF z8c%PJOwsx*BzBS*hm4bBL<8}9Wf9&JanR!`%|8~pK#iTDqE-or`h-9AIO8FTiAVGL zWIT)t$;t3BE*DCVV_jgj`0tHjY;{dCOG@hGwB}^pNw4ttn!p_l}Y7z!?<>>cYP~}lga!Vr# zE5!~@(qWz9I}$2*j&*_h0vBp-(SoNVSI?%M<`#4Vz>yJNI^}c#5U%XN_cA6Sg9DMp z%K_!ek2KgU7+K!B{>N~yp9>A@W{+1mKy>$s78m}at};!G*CW+Yzq9>2LgPQ!O=hQz zuV6sOIw*f`r@Xu~_&!>KW7?j!!JF$^Q+%74>V<+t2^)vfD@sd5sYJ+_v^ejFkl+{t&=It^W}5%QnjjYYb}Dho z0FLq=)x^3Nz&{^-PFRQ!)U3>dm z75gY@4f{=qy=C|(KeuN@JG+aT;T>DX zkvcScf1Q6}J|TlpW5+-wuVUlqcF?BwVz;Tnj}53p6yf*O2nZ(n9?US%lWX>NGxT}t zCgvl3m|vIa@foIss}DN3w)*F*5e+?VCxRwpWS8>okqsjgxIwk zJS&aZGRY-ez8NxiY{wH75+7;K7R2?ATF%AFZRQG4MJY#;b!bCbaT^f`=RUm4&o@R3 zHq|$7TN=yp)g3)VyZ}uW=4A$;Br&E>`NN z*UMs9eA;{O>}&tp95}{E_4nc&?TycYh2`cW5l4?9?5sove99A9 zFN|yYW}Esd=ag-#Qly#JjkPLN&rW0j0fp+C7oNK zM+IW<5)(UfDo3u&zZGwGewOfnm8UO!YUNQ9fu}4F0&XuB^5bQ4zw$eRv?sA#XJMBb zaUvMpfX(f=s+M{J?w4;&xb~&Cn;f5%oW-9vS6V6W-uZ4m2LYL39JO{oRxP@>_Gk_FZMe z$EYKH;fIx^A*m?vM4Z;9|06GAfP5qkLCU_S$m)f$a@k}#gDGWyWr>}mJ7MDP2gf~) za9>+QA#b!Py%7umbD%|qlmy76L%AkhxKm}>T|5<<#hj>^ z<~~YEo=AZWm3_}BR@K3LwE)2}Sn?Z-A2Ke|B2JPZHV5DBa>yN9fQ-3EAFXW?lgLAR zA908MSQhLB1R;3Xy<%LmC8&*Jm3C-VwCIxuSpH1P-KvWxn26^%jxUZ2?@JTxiqxqJ zjD6!0DL9!xRU8-P68E8)Lb8^P5C>vLi^7!%sg>g$0^%}%EgK|| zTDB!aKK>p^8G5gNu0=-mPu`w&TFaQxdvv&0B``T3) z1&b{O%L@gozYEqF3ODewg`1XzThDGfl7)NE*tXOWq=R&AQREv@g>$KtKU(s)Fy#Kv zijo&78b$N|y0XEy3Nt|rZBg)_@r4!WBIsWJ9J`|*12(prqIM#Wa#1%=0zr3&nlKl; z-Gb${Uob1n7NF2z)rzKbsdHcAtSiw&l!1nkyhevDfvjl3dKV?b@2o;@5C#y0< zP?@t%cCb!vC|-y9IU`m-Ee|SM$!1kK^Q`jMWYw>_D#9s>!&> z)9zF+;D_p#+^TN1<`Uec{^deK_&Qv)1C;p!&ayb+7)^1(MW<3^uY(l8<^3 z_u?9Q>fjC7X3Whk@m(s(H+2nGAI+HxEOeQzm>9D25Z4IuW-Rdp?%h!*Mc!Hq)l$h^ z0;2=+jlOa#5vp4F#XTmb7TNu}ySlk`?uaWxcFf)@k_3}x3k9Aw>UVEi= zNA=yp0H(%~ypJQlfm!ocS0cm;d(DaW>;4Y6mvcC*U$rx~buzbg5-oPJGk0;wb#d8r zp={K+^Sf@hbqOqYQY?0fv~>;x`HnBx7)6k|00rvclXUUt#QT)yD0X^1tY}*on@x{a zevi&FHE&yw!QUP}n<7K9Zt=E4sCPGBiFCcTTX@*)>V;qBUDV&J&q@2#Vc*+3?jpC| zwC)5q?tOZ5kXJb91!uV3X-`Hqce_4Kr_U*|KNHmRJfug4{|#|sm3bmn@nQ)XKB%8g zt~yArZJnPAje3BQd(-!#fROoPp!-0q09E|*C;EiXOYU`49tf3$+%GwU<<8a!5EgL7>wz$Z?;z3Ky&#=rBC z3Xu-E_>W(P)TNT*Ac8r_n#mQC@skl`9za29`-((=C^xZnCvor%>CKo|J0r@r;EJ6X z=`k5LG^t`IX#aPzab)_f>=fp8z9b8Sw0^<97YQK$N>F|%(8hglWV}Ug8l*pIsXMd& zyYZeNhtc6w*oc>z{LHlLjBaSQwkOsGUO1cD&aeN97Vag#NTdvUCP74P zi10+;h1jivF{|M9)nk1s9mB5|HIQ*E{7?JWzbjw=U4I3H96<`C^@ufC*cwsc8cD|* z+3MP#BqDOwbxMVGYS#5yLsFW;b)v^JYdN6iR5&TQE>SqZcjNeB5fJ5#5T6Y&c7t1C zNpww8l=bF>Lptg8O{VbMosMsEtKSsDzTKdGiVB-*4>mQzHnj>jRTYSIRyPg)Z5pm_ zrlCoU9(-3zmhZ?1Wg^Hl-`PQZ90_rhi(UY)0>VxRa5zHP8*E7^uQ;OGQjF#lYgWoy zmUi8zI^+=y>?BJ9R8&g(FpDkl$u=0VGYs3=#jk9o+pc7U2>2*$=jbyB9Q6ejZr@WT z3oWFS!4X{J2<~wJ6A~Pdy4`|*yEj8E)9pKnNB2_p1G4Jp6N%ce0uv zx4c2{R*A^6HV4{&v*w6D`3*g6pGI{K82?()jAwF}P?cV)t~A;dD^pl-!hIQ8uqHGN-w=kxqB z{8;b(%>D5KiK1iUuMG}QCTW&WSkr#CeGeE^#n)g1tR5_<`d*! zfLP#Y$&=zD?CXT?VYgWdTfoDqc3Z^X+NNlclO(pE4ESFx4=*zBU9vy9lzoE8Q6xzl z{k<^S?u-A!OVN>hZ}f}&Zx8)nFr(j+Zht5h5!Ijna6aiz$M^bL|1I6PDEc}PPLW+g z!P2UjZ;ikB>jf`4ej6m*`QUH2om}S?-ukS8VtN?=YV<49xN!dD!-YwHl8-=5;Vy`M z?cXu}-zgjZToHfq5P$g`|0f0iga-iDm2pZD5d1ZNw&6N163j^JL4UHQ7DL3Q0hyrK zP)oi6;~)&DoKo%_`u_vQ>Ad9DZ;WCv+0x6NYnUu+d2hvQv#r8WLS?#RSfZZ9s-7$1 z!VJ6m#qtAF(jeDCco zNAVZfcEIg^+G=~!$fTS|jdnBoqAY6@`xRbl&3VlCW(it{Ri&1xB)pP;4y%#$b(t!M zX5W@yJa?O`(O>c#ZDnoH>&4GYCKm)ZDp<6Jek8)FuS+-mKdNzKD|Mj2zPwtp|fYX^nf2;tLp0V(63>2OR6yA0$bTnA4R^1YV_TJHKK zzrm+pk=#k*%@h8#U%UTA;olwK+7CZeNQG5MmBpWQoQv>P$nOfx7$_igNw=vdZZnJC z`L$*;kvqiBoOXxaA^*4s=FnqQOg3J66R^pR=Rr~XLiE)*gr~pf5;)0;p=e^yYt%=u z%gH*ZN02&=f4Q6KSe9OQo*doW@JA^APkIAd5~K;+lp!8AXM;?=89qa@zTN3vax61b zpC$AD`rPqP06}wu9<-g|$D?OV{c;`76MYA1zP_0@IK5~%8QJ~gXgtYGFq*_{qgL%) zWFUW?I4OCByv3q5nJM0-bJ*i2sZVz`u3}KBMx$wHx!<2>u2IchBpCct&rBj3Dr|&s z@b@yedXm&+eiEQgy?}f!C}?4BF{m+R(rBx>_JHA^sf&=6`*pS zIo_>wG-(SFHaZIH$}O418Is)_XX|m{#4N~7;cy_8T>Gte$Gbu*z=l&6#p68xO(laf zpOCqSXyZ|azs&7pPmY)ae=GZ1RK1rg^T*;_=)CP0 zIa4{FNl#mlEvuPswd+*DSg*$mj=9qQx_Rs}C0c5`tJGOeOf7Hz9q&bR&6zlK>>hZW z&9^!K`f(OQ9x!j*s4J)WQIqQtwReiY#njAoo1A;gk5MLXBKaq9zc=c1_r8XFkiB*K zGRm^p=yx*{7 zJS3WGBCQQWGwy4${zDc|&QnE|%X>-ZoFeEj_6@gZ3uU4PvlO^M_?FmXURx=H5y`-7hc!KnV)^pd=$iEVt4k7 z02(E^iaO$NX53zpBWb7)7{b`T9SXnmSYQlA62?xE%^FoSBC|Nj#Z6VV%?krsTyipe zd}As65t4mCZ1!T;GpTmoUt+l?1xGWFY5r6({z`*Svy6$W_io=T3lB#0_}~aKKTwGU2*~-Eh=N-%^6(D0`A1=sEAh53-C)G0x@y|DEn z+Wu7t1xn~O)onC_4>h$@X->~;sEL0R zEv_fFJ`jJ%kSH`yCK}0s=wY=d!VzjXuIyjD%rsrG_KFTp1$>D=q(_(jLM%V1?L>7M zo<&lWAadbK7{->mC-#DJvtKptejj^|N@TC~Q zFtX!~b}VmViP zPrvD-(#GB(t5fQcOJZM}f@f^uR?52Hy*6T$Vp%8D8m#S(7Mqm{bCGT~f!h-ymz0BE zv(W;>JBr&Eav!wrTZmWYZc6meFk4E5)iI9>4-2EHHdxB#Ij4-;=HBGee#lQDDS2EA zet#>9y1K=fealasBS8U$HYmBdEL~b)-aW1NKD8r{R$XMN9&T)ur(2b~t2ozjfryrW zxfK^P@1%Xv#M9;B|1nr_GT^CBpj-mm56;zvh|5AYM~WGh$g zK1q{~+k*QsCN>$8Gi{(mJuX!im&JzH;e0WEc7vmhG~I_r)EexpO;?JCb;3lX<*as z7y2@s1@0eYO_d>$z=*UIGk!!~#M@swWpN(F5wv(W!l#Dc#;7l!F2t{|fT`%)^X8pC ztbCULi^uJNw#4ZyA4@20#z1uDop^UM~ zi|emmLa_)BD9Yz=)cN^5U%53xa58d+(g26*<~n7gLA(|*DhEd45i|II7cFc9M+K0e zrrX!|`V%KEQXet|AhNffyNB}Lm1pzEM2wdR!71F($&APBD4jLjO@uD=DEJ|;M)zEK ze)Z|(uh-{aN>~Sv)8JMfB@B)+Vef=zP7xe#PuUk5*TPCynfl`!2e)rv; zZn>HN0ps#jm5#fWY`RUAqIGs4E^!b$M31^-kE~jhR#mi=z>T>QtHr$Z zMHd+#{LRM%w>a!m43ONmnTNHzmkaatCAdnSAmpN}2n}(H-K22lweYYt5DR^rl;P)y zV@=G>#E|J{ug!k%16JPy7Qcp9#`|Oe7#N=IP0SgX4-}_>UXsDPCpq%UIZGrx5(y_% z3U{IJj^HB7P}9yb9T0KU8uuND-TWMZX|#HloX{NW<`Qk_1sht_N}f>+N`#BkM=a)Y zr`ja#-Q`W+O#eCDra_SRy_Eg+dUD7POq4UmE3WU>-oT)D5(5#ygG&qMiVI7PzKR&? zuJ8TeuGkl$HH9wsbBWQj&<)N*J`ZH{A<-=ogG=y&%bAf4%yFK_lD5J1O`F0#nY#Z> zID)ca1~O2W=2ja}1i%Y+Xv2PLKoZ_+1Rlo?UcCprg5AFbKjDwgW>qL+p=Xfg{;1HgOM$ z0Od^|&r&W?G%*-(`~c;=z!V>~{E9*<2OF{;v|D5gvWc*pgM z!v`WVK}o#mDoK&Zj-K+#zlmP-(fhiie!)Lk}Yv z`tarRL`B|+ZL6W(HA3?pn4-f3o$UmDmeJmUI%q!D69?T)7)wM|GpX9Rd$Lo4&(n^jSIdBQr@DzeR1r9`oE-SLukX8H1e{(34uub$;g6dt0 zCT(VkrW+&DOcrw#R^sHL(YhZ6rnTg!i$fZAQ}qlGP*cQ^cUmO*G3aZ)mV807It$(8 zx(to~^x+6nAxmL1YJve(8hk9hz!e*Yz9o+3kw+C))u{`_c&^pAERjUt@Jl-Y^!T1PO~K9?q1)w{u;@;qydW(K`{-Jhi9=5ARe-ELfL5j)MqeczuW3EbdX1DPbc|V6-`C zKwY=|({oI$8yadv-#2l*@NJD>37&_h=|7PPzeziUH%D^d$|^kJcMoS`{U^1fCv|ET z_`~(Bs-&RsrGFE`9}Xv-!a zn#23E*P3LK9GLm-#Y%LhrR%wE>X4~XZL3k%1Y!LANYaCg zJEPI?Bwqj;>-nWW>3;65%D`i7!^=gMa^26O%|w*T*C?CX&Jr&Fh2`s2(K4&}Bpb}) zZEG*i_Y$8_+NHnCzp6RGzss9XR7H{xfX?{fE;nz3N!#7;wn-*mNk4oEnE4|3llM1` zHRtPxU%b|KX#iV!5D9sb-$2w!)aoTuvuyqPwoEg;aA6P1x(1ClAJ8IFNh7~{x1(>z z!b;>;MWF1pK0ZL`HL1?nkzQn`$sAyoa)7Q~SbR6S+Vz2!W3`G?cH>bm9l{5OR-(o0 z%RcCrX;kx#yoXzpoN5YWKKU}h1JgZ?>qNL?Mdr~^{`cuF{{tn?K9_AzY4(J z3;`mvqUorhBQJS*$1Yxe3t&ZF6toRZv%P6b7w_Ej<4VyljoH_;DWUlqK}2ZOEEy^^ zuCRq>RY*a5k2y5YlI9ZX9usI^d`Kv;H(#nwRGokSkIAVe)(}0HWVx55VLzm?b(YO9 zzrTNki~>@DK32-0*`4Tl0EUhtVssnjj|;;=A6*Kc*I0Qc!`-?i@J?b7q8&``5Npsa zI$|O~6*DleVP2GJ@R{4h;b>*Nkeu~Ql>Jkx;s7{7AtnE9>L?8Ewxe%f|FE_9>s_l@ zJ+$+7%>3OK^(#j)*7V}c3=sf5I4Ea>>E!6i6#P5w!+Wb=UkmJ4^x1bhCk5|_T5zX} zx`d0?{vP+Fa(5#4C=B!OkHl>d;c@}Xw46Z(U)O4UGsnV3U%wxBfF=Kqr|@+ zbjF$tz$zPeWn(Xd=`eoS3s)yr{SN;jZj%p zbOlOr5qB}4$7>@PQVFs%wwhn=N5ox5*MjJeXOTHE<^zN;2**A<|HzRgw4#spKnM6( zMF6$opJ3J#?7Fvk?O5p+o(;;-dtpBM?@eHCPKvGw;#hrNsytzX{MdRXSwdr?Xm|9v zc|;@w(Dn`lm&JlraS1%H=I{f}4Yt++6mX&12qy?Ka02pu>d$fLW8CU`uvZM5H(~Ts znT(3@^UXN@v)G5VkhYW{$8|!>iPP|%;M2cX`NDCb*{}t&7%Q>A%U*B$Ud%ps`7LAw zQ``{1q}Z#D^M+Ny40&P0-(Z7359PdmzJcuF7ki%0RKIxfEAbhIK-Pjt2#5J|M846| zI6Q6=exKj_KgX`_&Sz{R!*BR@sOxA`9^Ksj4P4^JduSMY7yj1oX#lQ2Bak;n|MJP+ z7dEyXOy*(U3Y%Hh{h7R4y#KuogaxR8Ansv=IWe!xF?&}O$$rw}OG7q+Xi6UAw=O3f zUC;3%J_l6@rO%O!^63Ke!c0}pSCsbk=BKwtvI(z$XYfsC_NOsRp3bM13+mW--88y{D< z3KHwney&9BrnTANm`rJ8<@z& z8{U1ws%NFN7Lo6i&J<0?W;6|^Eqdp9=54h=bE|09(~`&e?VIQ1iux4PE%BwERKHea z{5`6F=X;)V)4$c-TGZX>u&_b>I84)o(H$*sJsrNXFe`1g`8$06xOlj~Ihm$5*rKlc z$CJ8G>OXIly?hP=OJ}P2WSOHCam*%@!BCa0Nil8#OqUq(f=Q<`&4cV>z{#-|Ac|sF z`}&OKr-?rI7cyQZPs$-)0Q0HbWld2q>UcPjI_sCc6X~BXWP-nyn(wEqt^^_|B(qHj zD2VuOGPinnh|7UAc67hA2FA-?3;zY=Pa)VaLBN{0aLW>%L`|H%rbrG^n#d)-j@!zU z`tx*@@23T|U4hG%S|>Z6OeI{)Gam#P;}LGWC7uIVBVp2>3S@#(jd+5%UB|#f>~*8| zLOR_nh)||H;VDnyv#y0A8Ek_u5?g#EO#}Y=_e>w$CCX_1?$gCkhP=cKmKK2Uei8sh zW}gZ)OzPYfY)D0e<8RNnF$tog96t#*uP59UYWbcU{FrU~^(UcEhpkrvsJOPf!tFm* z@Pv!9ctpgGKO7%fKNfek22A_)+BwFY=cD`UC0 zGU6y*w>g`M+fOCzEeBnakvI~o!QRt=+tzC8~ zw`rc_gGVi~LJtv?c+e&g>gW?C5@kUYC4cB5Ed2!h^#TG3-oO3% zf~i0ACxJEMkd^%uTqp2h>C77LzZ<7gvwvwG-Vam9@Q)!olM?uuK^ojwxaU*#<(iJX z?PF&xNn9ugICQK8l>S*!^4YkGjW`)gAa{J!pIu{&4&{F=Z@6t)kMXz2Zdx-Gk&KSyDm0jxIkDuM}9hGoI#F6}U@e6eU)( zjq;lrOj+@%PYh)ek88bhywIYM$-b8{Hm4 zkhNu)#8$dZ2iGvy%VjA*w!!Z^SVarNxojJ#@{`JwEZaDeC0D9SlodYf&sk@>D~**} z#PV4?bgLwrfXSZJrNFPk8E6jYOM}(wP%1xOzCr|Rv3C;BS+ym$%~Ay_}6V#4y;#Ge%iLqB+4H64v)2Yfi= znY7$SD=jY+X+jgQfTN)bWkOY$9mjan*%<=~$8x z)o&!=3(mNd@qo2I za_!JLA5{{(Akp_Vdo|TGrs4`r>m)aSJ6Y+cnK@1z;6FqRL<1i)j8if}*og)XX6%$X z69JBx*v6MhL0sVv3(ofFUgQ$H$Vb>S*4&rbaU^&`=}bs^yh!+4L|NM0cSls*TEqxC7oE2MjFyr0UzWAn7p(&ck`t* z=(HO2(0_AwlMqy_cY#}GpM+eRa9txZZ?m+J!c|p3f`Z67z06|;M+`!OsmEkOFrRt; zI{jk2YBezzo0`Ys0%2_Q6v*teZRY^j^b_k6`X*VeL{Djeu4sSwjeT={W63+Md!FLN zx9cu9$}nteR9Q+LNE}kvoxBZ00s(h>ZDsdnXkivCVOE6~+;hL0$uu<@zX7I7%9bJWn3n-zCgK0z#E31+ zh%as{q3V(6QM3hXRq+H0ZX_f>XHqw0bY&A6qc|*Ue=VLcx5_K6r2g7mx6zIG{H~qN z>Ze(mJz%t;0*fbke4WD1T2Wx9Wcxkdu!W-gwDb476G8l0=U~Ch;!~Z^${)0GOfBcM z#|e^FKnfYzr#m^S?g#Crq>CEMS8qmjzBvh^R*k8&36G%?HnV2tB+?fWH_8e^Y~(g@ zwxv-v(RC36wZkncZKiRkm}k^}_xbRp{b;1R&{n!>@C%s{e57Xfy?^Xk`0SZcs0bXq zPfBYXw|)ecm7P@287wG+3MU9XA95&=bZ_oOsb_sxN#l<)i!IDi`SaqD1p z_Rj}HEU8gET`b1;9bY%Dq~XAP9j4kL811fy>DY(5h&gFeww;$4qQi$qy`K;ZEN`9{ z$du#~)8e6uiP4jVYg*@!S3=k#9=tebjTLO-Y0|-@Pzoy@&Col<%#b}m*`BO1C z25NHNHQ`RpKWAFZ7qJ4Z10-&&@W35I9ricaxM$UnmZfHbNbFCQMhzoZy}fXx%;}YLWmeHWOQG+ zC}9pTD7{=EEnF#MG$Z<`QZ{}1UZ4@{HGsjDOv)dm{LJMOGFIWOk-H8Tv)0}^%H<4! zCzHqm^SN@2nK<(p#r_i@VCGiqze<=8o|ewyxbx8DGRc4LYl!Qxolcvnl~>5~R46%U zE2~s$8M)AMqJ&5*^ba_+JCMKv;KHqoSxY|bw>Ge_$mr@5@f<-R0Q`G-djd1X@#O)% zw4T5s7uP>-ZKDO0Z;Y@BJFLm9;mc!+}aN*30Ijra86sBp|Ue&U8AW& z5Iji-4>7FXO1o;YgZzyT)o`(tAWGGrmFgH*GZV11(xKOx`9sk;X?AG+Cp^^2osyQA zM-u=ZigR_<<5f4QF%?5UG(9jfqf_Mv3&9sW^7K5*);yct)DbI<7+(8^8da5QGaWPt zW@{iEMTP*mKaDN-bB|sCi>!luuS?So+=))y0}NtBD9adpAgaTE-ALyM8MO@@zG2*TrtHJnXo4aWwB0bJY zFjoyz?)PWw`Gn5@xJL_GVK#`PLL2E=kUT$!^_P)oOY>)eDCv%Y3|&v}#c{^v{-bM? z7orS5tf^I{z(O5hfmQ>k-dy6Yd6F|Kh99iE0ED3P4zFC|-{a|jCs`@sK%$MP^oxaG zo~9X=nlYR;sBJKxZ;VPCwpF>*pSRxM0s~Ld;P<8XGP6)pv7xl^O1$OQZq(py)X+w2 zaNT^$vaBc=$R%mpO7>DV3h182h}`6x zHG6to4~9jq6@3#xT^-A(4(wS~JIQ29aC(NuH=Nj`LUniRjgB6U0qNO2ve|`|EVh$f z)nyxLpAJA3SGnhO8%+aVYj!Pq)jUua9^jO!Em*k&-FUtY*QH)PRNjsjM%A^o`rc2C zpRnQk@P0_SBU-|L$(05PKo1@Y^!vQuXme-!E#f=a%rTozn_cp4f>#7V;OJ0bppFE9 z@8_>s18M90AP#qv$_{O|9x*ye}H#Cz|e_ zlh85<>_@k0wwS#@yp`^@q>?uoh*IT_x#Ymds@@FTLkom)HfIZpYMl*AbtFDFt2~H= zPTz0#H1pLSfqX9=*rOY|2LXT+n_Z(DC4nr8Qr}M=+3xe!ZEo%#{G`?mgT;Ho5)hCd z(TR*!{U9qeW8?a_36!)iD11j0>YJQ zE^1BQk)L}tDD60akjMPKwTBktaSfkLn_+-A&xX{51E_@v0i*zyl0>L~KdnaqHv&xm zq?P`KI3l5yo+L&nSY1#l1`!m%jT#WEYGwK$&OF-6{PCRW-T<@&ErtuAr-)|#)yjq! zX9u^jO<_6N2k1Tq2#!Vbl?1RqX$440aBBqKI}6~x1LI=E6=0-TnjtIb%uy(l&N#V&f)OIT1 z8!10MMB%k0=jHSlc03aBqsA;&11LlV`qd2P6DA-*D&nFapuL@r*+sKH{Wap$hLKbB z2Ql$)sPPAHVFp1%YO4I$e17}GRfrNGnD9S`;X*8x*g#F|*Y^RlDoF61d#OVA6>00` z3|Ur-@X$UYKUq%KV1gJfr2~e5&^zUibU?|N7GC+Lf5PghplbLeXsoDNHW4HWYkF(5 zbUHxJ-S>qC_M-2}s7G`FzQstwTI*}xhRT{MY^yu7%=|sr4y5LdA~~xs3$xMl zidMvPN_+2#{L@ebfXT@m6;-_`0jwvh zQNsyo@@PaKm}f+Wwx~j5WM7T!4*mv#eIJ*-{-v$R59VbC-`9vxjR|uh$|`<;`mzll zh9is6+}DsvjTT0`I$U&`Sz)PME$uU7L><*7NgoGQztewEWydV|?fu_Q?aq`Sh$@Ck zsH0#f?k{Rz*7|HvrX!kgx=S7P?kQWY&9&f`gi_`boA*6U*_MGJl2G+jB=lPGuF;Kh zb&D6$R5lpo#YM|DN{vxBe{}kq81%OOl~%oM*DvhQPd|_p{F$1`$@G8O);AzFNL`2Q zY?sSG>x=)ekAH%zg=>O(#<$+Ks45wBXr%s7n)?Q1^g4lexxFo4^ViM0VR3(^lf|W$MyRS6yqx8#4Y)-<5?%>#Rrg)A3|#+@Y>CHy z^I~|RJEvSAPcS?$n5sYiL-d_#HLlU}P|jYa@0_H^WP9PINR#_ZPjP&OR-+AVeC#!? z@OX~EBrmt^ncHgYc|+&i!nYFJcSO$v?IM0T(h$gy(lJOFBYWHnUES73A0RD8oT5}_ zCPFHf#zKeH^MucRv3+i;|7{3kSfq?)kX@Y*^6~`K-M~aVz5=t6{^*ZiL1&lVD8MLu|vFeVc^Bl7l){XXN{yNe4$Mkbi ztxX|sDR9~0Q`gogS2KDUJr&dsLLA zNoD=6KIBuh96|7MBC?bCV||TOr||vXW>;30d~qf;c9`RM)~!c|V?ct#LO;I9#qk=1 z5oZbSloy4d%qP19L%K%Alhiru7EGVMO(^A;+R{fQSU2i>#rSb|7KYO=bR1Rv)=6xk zZ=)3!pP&fhoB_odSv%q;%My?!SC!?-7ntB0?|E3v$b))~_s&m1Q8 zR&OV!?l-|^0#|xCl@U71ohbzFF3<6#GVaNzOmo)4E=mv7O4IX~>7K8G+6rqB)-nP6 zxwb|1HN_zadoK?P${r7v$8Awscgdz%v7VLl91>p>3l^7-)yg9ue9_kbSA6faCVB8d zpZ;nB%i{(wLi*%;4An1flfB%Fe0nH7O2e|Xbao=YB-OHn%n5GoL=AKx4 z#nDpCS$HMChCihw!(~QvVUwP(;5saKQ~MMbb*Uao|+w0Tk&D&YUTx=X}qm2mt!c3 zH=NydX4ULypfoWvZbFFTUApW`+L_mJ60T&V^@oEDp~7BUu{A!WfSG}mL4)~jZm+&b9M&_YEX zc4RzOIFrUX)4*+HTYUU}B8gr9WJe2{dn%U~h3RJT5X>kNT|bn@G8hG<=ad{seU_gs zGzw|XDLo1PthmEq96pm%cGdA&`MmI>@TLa?uN8neFN#^($`MFs0#^I;`y;wSvK*j1 zh9r4v61`jr;uL%-@Zb|Jjt){m$fLs`(E@6S0 zfPFQxDN``(jTRe;XN>Z|86bLHs#Z~x&lDfxomuuzst#fbf)e__a<30m(vfaBeMWr0 zTnhvYy^g0un#{?O8yjO=8_e2Q7plEOOr$J~b|xBnskP!kG1sH){AWzTB|B`3avFpt zW)Fbd(xuTnzG^>L3qDj-k$C_Bxtx*~spJza;hNtVXh@c2#?b72Vy<=UBo*vtom?-a zb)0XBtrkQ>4T5M-f_94(mlz?yt?N-)DuAu;9ZDR`uH#35UJC|2=z^~JJtn(Yriey` zIdeaHls0L*MK{DMRi~z#|CM1UE061==2$?j5a8^sbjP$I(UW`kH=~&ynen(0pyO8u zE`K!pH`@M)d9Q~zoG7LrhRsh4Q}Ar!U+CZ8T-{S!#Q<5y!0#fGe3}2#*p9u-e@{>@ z7T*3f>%=Hjt6gLa0z0Qrw_4;##9=iY)eL}WD*%@fUy8jQoSK?@7(eZ=G4&UPu+3wa zq(i3t#l~cXo{#t+oZS!gy=#MojSHp=pgV;$FImS`AXp$pbR!so2eXhQYN+PIErE9O zlgHeW6dl5785m~rA^DFNrNMK|B*v)^>FHOET+dyf8x^m9 zdi%4pwbak=aq-&5&!7KcSsn#s6t5r1{OX=9eH8Mhc;h7W*Sj5-$KfA~H?Q9Q>N_ue z{QR_d>-Oib4?tG`D2kG80@-UUWto56y^bx^!4AQ}JygnA}Y zGM=TU_>}CEEdj{y7D-4vt><{2{O(UX13W(h0z&H{eAfvjmpenNIu{3(e_aDh zS)pm7Rf4P6iiyB-XzA?t!S$m|bYREB>Dsc8uu~;+uBAUq2O<3n0imOf+@7!!yui&;_8R)GG`{B%ANYh zIro*gAJwEVh4=`|K-A{;?G`o zm20vz)9&U!6h&3MY;h}uC;M%flZh6jniRAf5;|g#E$$_4{LA%2t8IlFe?S@L4YI(+rJFZ|u@wU|6G2S-# z-jwua3*N=EI?3`WyfV_Jhux8pV;Qy zl=KeHWiz~!P#@k*CePSh^=_A-@jr)SZ+Ovz^OzLTahpzGjhmLeX{iYuXo9=(i1SE3 zP;W`32ZWx?>|)CD$t!$M6)cK{$xk#}jIK+(?xl_F_$a@I)G!drcjVNU_>>rw@d#Y$ zyM~4@NU?Dbl(rzoa`TAu5$?+E-6@%`+|%@CFY6T@=7~-TD*`<%{6azk zsqs?hW;X^Ek_Ofg9B7$P^Yc7h^>W@wcK#?ZnY;E#!cdNHurs(NSbJS|;fZQZ?q-C( zf$)RREzaibnyID-T24X3844?M8k0N~0C1Y@d0=OEQ)#h<`_VtXp{bUFI7Zi3uGvJQbqXdlN1;P(@S)X9lQON zA^p?>ac&YLFTJg%b^}EMiIGIih<@asRInCUcU>L)HbLl?16|GFSSOV~74IF=$b zY0c7Udxy+Z=Q~xKCt(Rnt`v6R_t-ND2|?!M>=B_sG4OtNeiJzJm&^o^=O6ed98(cp{p{RuHFhWikqhD?Gtr=mlYV?mOW`6b`91+h z9&lXGCOfNxe^?AI4Y?z)DJ9@87IW`9UinlPKcn+3<`ux=GZ9EE z9-Y_DvVx2g<_$=8v8!apL+S)8oN&oD9VHENHHH%YMt&$z=^vB34<4ovqhgY(v@cJ)?hxvuqol9kgM$Q*UlENmuYnV4{ggH@v6|#7Bib#8rUjE36nJM69`7rDewum>M`}1(V;SAfRz< zrUOFhr`R(q+jMA(aGKJKSoIJ8UK+e_;}{Z5p>xA`TnQ?FL#zC|BB&u04CeTM)Pg%S>90}Q^U@8LvOS&Bc4Ap4u(8?aW$HRGP2XQur zJK1TLh<3hi<@=n>nBkajG0gK;M*_L6X%Z?TeO}dqPk{!u7vpyU*JKkB`mT3FT*qFB zHKFWTN{W67C&R5DC)&1hoh;`8U#&)p0&?em#ZbP%kL%%kbn1nXbuNbaj+&AK;&K!p zYX_M`{cTHtq;955-p4zm@-=EHx?>>5;m-4Le*;G{#U;TT&tYkDXPBH7h?g(ksp-4E ztGE#t3yGzKp_|P1<(Dpz6F{61Np=i?9f+S)ty!7-iQTYtbnZHa2l+Ab+D4ali^v5P zQ>&jz{~2O%j*QcmNv0$=J)*t;w5IWV!fsPFhk_mllhkYL{cn#rmgR27&1)6qdKXS8 znq%2kJsX%|7&|zWz*|sDG)EDLjG--H*OJkD=H2nl_>&QNtNl=U(&kF+JTl%p;d^VE zv(+-gj=$}jfMRc^H$5Wro^c&yeJe{dHXOG)P^oW?DL%-jtHVKv>ih`53*aEbS(q|C)+Na2z>MNfQwkOa6inFQ$t;emrZ-d9(dp0BM@~@8@4d zf>tN2i&k^AV$Fu1Je2?XDI7Lgy@SO+mD4&3NF$!FU>tehmGtknjN-?M5FbYvs%?%! z=l9KLBt;J{fjp}eetV=t|5Vzhl|l^54zSeu^D&O|s=@a5i9+2!(%yVF$wb@vbc6lEHDawjQV=pO3Zue%QWuX4&PsdU@4(UaQSM~v zyHLrSnmnO>~{U2@9KiiCt7Pw{*l4F|x^?;*` z9)~2kg{n(kKcEeZF(?N@&!Y}Q{QG7p-U7%>oT8J>Vzv0`^bo?zUG%@;#BXF`94TW3 zJYp>PnI3owS$EM7(FNIY#wDo7xrEWWSqXS_(W40CDX{UKYGhO`K(d|q$NaPbFe`%s z=368Qr4B3JgJ%H_AjTy)Mr`f{={pT zB34Lwy;m)B`QT4kN-j{?p%F*m*^8KsLUe|}^PATmd# zG9$3$TVa_+Ff_3j6KOa#t3RCe4j^I&umV6#^>9w>Y>x13-okAD?rg!8Y~kP8q5|0< zASh=ybEZ;h3Llh%lZ4MxJIN)b{rWHBhiL|sEB(i8#wn%0<}9IiCfwtU@X;Be8#^EX z4G#vGzY2J1rOPpwPYIzxf-hAa!;wTN_(Lyb_F?oAr5h$ejyBvtXN8}E0g+(w7L^du4_=CqUp{z3d8j1@V^7jkWq)-sG0wEr_)7hN@LM-qL*7+1^R)$v8mzl&NJigW9UKe89U4KMDpE*umiDXlkN z_b03EC;rq=)@@zVokW&}Dg23n2h(T=U24s&Sb=aQFgZB4323RXw5Emh|5t#viAWM1 zNe{crzO9sfmoIyVBzb>Uwk{9*qWkK)@YSF0SBV(nzrSAr7%@8xL~#pcZ_p&UXkx7Y zE6^$iU_+8aQ+9f0FdJ+LHZ`0>!9{og2=DUM(X`J_6pfjwyD^!ePB3dU^t*YQ%1(fn zX+9}X*Uz*XjHOtCbL~3%D|qKX%B|wvYCy=kRJS@%RGr3MY?9_GQ@&=Pt~iLm1nO@S zBdo_}E=c!O5B_X|=uR~J?um$2u<&`xI*%q{ItKz> zj1B0h+EUX7OK?^?mZGG^Uss%B`%EpFTKL^3Tf*67Q7(pVLH~Dx4Suc6=V31F-W;2E z??}9_>p)VHKl~9t5H3dX4_zrM-Xya`u?A>ZO!lVBYWl{}m>od!$&pHbLWF*t2XAsm z$C9^Uo0Wbww>dUGu?hb{+$iPpCLK#&@RH`Q!rd7z&OCoNFiB-bH2m3@TKlJTi)wH5 z-!}2=a#Q(K1TMZY15>I1z^{=S*6J;d=k*i0G|B8e}sbL5l}3H&LZf?ws| zM+1S5Fy2~WEJr)(EX5Llc=YVKd@?1cA}hHN120L(3V(aAAH$XVxp+4g%ZPOgKgKCz%ADv1RL22=o<$(}G zR7GcgGF8ZS!_3Zu$Osm+59LljaYqX|0{Wk#P_FXd_9sjoZHsUI`}3ctj{pOf!nl~! zOi_s;pld0sE14wDuDeqP2<0$=M7)+4y(EcmagG|VPB-mFm{Lq<5`6-^4*Ag&@YN&8 zho>(;dAoti&Qb1_8p|D`r|JLviw$C^nDPt0g>Qd5<2m@<9LKwCASt1IpTIeZe@lA4 zIEZ{3N*Dzp76W~0t)BxzB^?QpY=+B2?j$R)U;w4P)@4u9=5@zBO#4S6qtU~KjD{&-}`p!<$$%Je$ z39g+(O~s(IE$@UYslMTe-(uqLnGZnMd)cph??AYT?fx_&iw5y-W=pnzXtLU`Z^W?_ z^O;0`-EH=P0|QwDNt6`%xM0y|EN*JyQa}0x0?1#^_gvCbIj%D~mmt1OzW*UZ&cfH* zgB=lY5-vu!EI_G(8ks^;5u~Z3R(PwhP(~{GZGbhLKEe?kYy(fifi%uU7BN_#&(u5Y z#N(M&D4|iE-q_j(ej(p>VeM*BXZ*PB8VZ9ccC*-jNV3=LE&fh0{T4#{T!IB9c-K0ItQ~v0!7KBdN8>5c+Qq z+Re(FwoXIOJ2w2E^P7G&e>U+lko0%a)WuPN3Z_rEV>+b{04s&RMnlVvz%2cQ{A#km zQ5>|KyaM^I*kfSOH~s)`z`KDYsbG5d-xms_7NEHp?wK!~>aJD7PQ~mC2DN}7v~xt| zI6dqf6iCtJPx?D^l1pO#pTTT$8%1=?tU_P?2xipOhFa@u5(k!m<;*=E4ee*5Ix(R6 zYr=iqKT4Ix`0HEBf5?hAj4774Db5>X@E?n)S&Er{qQAmZrTSIBJ>r*4NFDsfs#D-L zvWtR2!+~C({0WI)FwR*mKB$!n;o;$xz198354Fl22~qOdiG$$))qMO0iY$oYt|}?<@%vb62Lh0ZmC{c>Z(0Ny_7t6TiMGf1gGPi)0|) zlwj5;F`Vk{JlPVXp}h4cavNIf^WJ7`-I;6H*i-k5jiPAuPmEt%Z@pe=;eq!~d^|}T zWQgSHH{@k$uHObyRN{vJrtJ-dZC>!hr!#w1{sjm}a%eo_(R?IJHcMV4woz3?`7tL) zr8@@%Kb&<@UY_3yHr)kfkqsfYLpg>ucXkI!_MksjW7grHGl>eW4{o{gJO$t$0!L^E z1F}n`3H~6(DAEN)NiL^+5a4hil3VXya3J{^zSBbF6Z(k(TM++S1GICj6^qiVI!ry^ z%Hf9}V-zwUy;WnSvfhUL^?dd~G^5LID{PR`eH-H51Yd&_qe@~)^-DimYlGCjJsr}H zbcIvkzRmmtBmzj<#ZDF+P8K6imdj37-=C~MI>{1)ZLogdRr$W}@O`a}xEOhYWIL`13tqO1Ein?l4;R8)7ozwJo`)1U z`0ewo{&TSxKjdEh5LSgqwh*&#k*s2VsHUwb7dsX*n%_V7f%GO%I97OeXyCPi2`f8t(oQ@e0%fo!1$Q!i(YeJRk2DoG5la;&_xnxorZ`#Gy{Ay<}qR z;8|9&7Ig`$zh}=VZqKZ;+&)WH?cqe=jqLW{Zd=pt(fMW|vR+Vb$3))aEFtA%#GH3)wjS@8_+5nY%X@OCVrB!S@$WK0U-wzG_%|NaFpO9&m1q zM!x`&kfY>G*au>u47{-j(_K_Dtq7G}SQclG6XX9VKxW)(vHd+))EMFeog@PL9#;l) z-T}8g8~6K1VjP*|{x{RHo-SZ!3|FT$xS`z>RiOF1bydsMp{al@K*iM){`ph2ef!M* zk;S*=JlNxKraFmZ{c6{ZxsLHm@3sFxmJl)X{N35k$Hk(`|J82})muCiH0Zh#v+R5B z7VpPg=%!`8JJ(z?W!bh_BrB_ZnV(3}SrKS-2T(uZ-Dqy~5Y*Qy@II`u#Z%wYx{;S$ zPVagCU~2ix`aza&_rLF})}j}S1l|AvQ*&Y5XA7>WbcfS2gdX<=KGH|RC$8jAOD=M z9}**1wqsw7#hkt+)Fd|H`h)xbn0Z6v0(HC3WpTRl1TU7~u5 zB~gFWZ-tu%tqj)^9ch1r_3(#Q^~+@1N%p6+Iv1H8iCRJ%6Q0@6gHw&$xmr=4Wy=4S zahz;9DMC{sTV`ZP8sml6MJ}8T7l!*|>xpX0uTW!@k^MtD29R>QWc*mkzi(L|<;bW> zW}COM`;)O3t_xUsp*acjuY}2b)UgYK!PCFF3G_@;RZv$l<~b!sGdjOh$Mfn$OQ+4Z zJYUwC+XI<(n60%=5=I}cTsC4Y+a(q%w4eAqnlEg_#!c8|yi8q6d^Sus6xFPz#ql!l zgpS*yvop&ekmKp%c=aNI_bdHC6l^|lTwRvq(W!DE#=RlH%Pum@!hbv2@u(jjyITFj z-YZ40hS83!S?FQx&+4$zXy0>Q$E%WMbaJYO!mpi2vM|7hCgT-J)P*R^ z@xkoI$L^P&jXcf_Rdt1*no3RURQ?_ph|LrzN6k6$aJ=~>73$hv?qDnN{_r;ebA>7~ zv%@#hD8)xlKF@T!|76X!KBeO;>OK6hM67fd=%)memb`LD8yI45Cd zQKk0z8@JJjw4wN4s(U-9R+F~I;?2OUK5@9{_`s@jBfT>Ck2{`m=BSL|cn^7ge9Co; zi#@~f4Ma7b`Z6(>zkpjMh)a2K<15(Ct*pe(G-veSG~)_#lv%{dxHzjAr%G3=TuKO< zOnAo%_M}dn>R*esM4^^sBL6!)ORKl;e(|ZRL@e!16i;y?4pgf%OyD;jE1ASe(Cw*u zkCQC*mm+)knRwDjlPS6(W|nC$gy@;?Y(|LiD$7ckGK4OUx#_5qjsDXJf~bvuAzO!1 zBymhn#w@EqlHmj$n5L*}n*HM2PQCC7tu9yGBISxk0y8|D z1B%{V@K|31lS4g&(vQEokGwzTwVkPbwy3}(r#YbC-zO-sfg#X!NRoOn<-*FE#5a7H zG?C8(V{8@pO!Ki&^u?n?x)u15*lWvJz%`(JxTNYAowtF~OafcE6;$QNIPSUGyc6v$ zsglGw&l6`dA_BmGwog(|R(wY}Y*h1J@(Z|d(9I}`EcqViad6E3wEc8>@uyZ zT3EKG>{-=ditr$W1c{Yk-?eB-wg9-2`H*}lT9h@stTw-zRxv4JN=qJsi=26mQ1uj6 zfvOuMsCXQ;I1J1qW1-Sw+GJsXtU=z;R*+{S-Wf`@GTL(>1Rl>l`xTzFd6xV1hJTUbDU+l^&yE2|tH=G*q%~fzPj2vzimGxTK)v5qArVK+; zw6wZO49YQn#InC*%Bj_at-PEyqol5;cLC)eqUQ3<+Otv++17U(BwcUz4eYtn5#^b{`qvcn&%^V9RDG;dA5tJfWEK`Pbe|g;DEugH) z*MqBgwY7$OYx_?*>h<1Y+RVcR*5_{?J~-0oM;W(jT#!;L0SIOhFaY7eqbGy5fXm2V zy=$e9eZg~`Sl*1L5B3l6kpvOz2ZB!u!ZTVs?WvzZd#r7G?67TT;^GOB!WKEAKm_bb3RuGfUkOq+MiIxFWC*L2*7IN`4z zNPDq3`_4hG()ayE!F~)aqEqLib=b`NP!a^L-)<_Y+k7;RdD}HW%i|tr2&GZb-LKy$ zzwoes$N#H+vmQu4sUlbY>D`{? zuEcso`6)qKK1tc$qt8#*$+w=Qm{j_s^tA+-jPGZ+G4mEo()9^299;D^k6@} z#b>%sZ+{hFYGQ9ZNSjeFg5KgjM84NyhohNEhnO%rvZpK=7uLqy*OP4e%E)u2?XJk= zgI^>!wuOf-+`kH<04*RO3~HhS%^Fkr8<5tZ!8#r!!o@*YV@8cvR9IFNVLFS_oqwC$ z6+?-Ljx9)lBchUz1c0tYx=e{dW03Cw{l9<6H)r-ob*Zj0CHcz5b$+ zv;eS$CM`HMm_H1CC!T|(`XJU&6IgF%SpTJIGE*;t_%b(i4D#5Pf{gpa{_B)*t7v{X z^}_2oX_G>H)EQKcJ-H7(@aJzDr9WDR1|7N_Ys-)%bjg~4Q!km#aob6-4C_in#|U2& zRMZPRAW}DELQUJ$A-PF%SHQ981k(ac!P($0up;G1WdnWJe2tqViUOP^RoIpn4;C?? z(b5PZiK)shOlNpB5lbrUqar`BE5W>uuy9YFv81OxCedVphJ+}=1e2f0A58~`6o6%& zmGa&pVytKe;8mI_ziU>J>}mx-?!=@BM}o%UB%>-;FJUdwg`9|Gh^HBoII8raBcw(* zQCnm5H>UanjQMV5euXh91VIoetnCzw)cZyqc?`8b%bX>=-8{ctX*mNqlml_Apg`v;~sLm)I=XZoPa=bdM@*G z1Nq5@^x!c_g+@s{>irZr;UPO2m+5$nV=MrTc2yUAI!6|%Lujc}S>3Ojd`_8((pyY~ zn#v{Z!Y8z2Ct@+t$NGb(Ryi+)qq+Sj#9OhKuM?kQ2<*`>r}x#*i_mHHysK~t9Xkfzp^6^N>KV%uI${ifEf6hsbw2JX zvRD*%vW_M5&E{Jn}&MRt}NvE<6=wO6S-l4;coyUou;j!-np9!`COXSuTYQe*y|v}$sxT!rx_9J z1cPnW6vr5bG0?f~@HYd)G&lr-B+HCZzrUjth9R&;r1t2{Q2kN1j>vg>hXouN?7i!~ z{Ea4;tLxjCz zpdYeOlzCqZjfVFx7!z3h^nYc-^XY{Z)DjRM!T$+WN~~_trRhXA+|nS;un=)yq+6Fq z`8fWo?QDxHjelm0zA!Oh;bmwPz3G<(@3C0J%QThFh6?a~+tR+-b6Fv4q}VqL+D|#E zFf^H*e(Br{)9p(SQ|8rjs7)pT<|b98iOiG5%&Ro>m%JGwN{u0v<{^O`H!Lb8m_*|m z{SRR&mo^X}!tQWf;x`r>=Sm(*fO^uW$@zR@al+yhnTr=7P2f49&w+G-X&97SNBORj zwa3dklc0`{1ZlR*_tJ*k73RGa(nH|{DiE49dnPqBxb@sBihvBkQXrSama>!J-4F3R znsc|XF7qV^(Q5V_4et)pKaArmjf1VdGY%{!cb%ZW(-dsr#;0BC9TGxCRzmHdwWu=y z0BOtUIlts>eb^7RY-vi4S}n|3E#*fyXv$ULg#D5doMCZkB^g3h!XxU!{G zATrRzIzY#Xq$0IcEUbfVvz?t4W^RS{3^1$KOy6%>cj&QO7`LO0qxQ*skOH$Y^pD4p zt>1I&G^a-23zfE@1}I}}#+Mw(0&NZ^)bm zyBH=2iOUiydF$yTV4+soI%`m$GP0-*(f zj_z0t)DfVh)vf-lT{isPf6v=xE$%25$7mueG~&obwd|$dW@?xmfx(O`5JRYs8NIw_ zNd~%=-E>lz03;a`Bknk~0z%P$nSc%IniRXfZMTR2-28^um1GbF*V4Jzj63b)4mMky zr14(dbMST<3`01?v)H8Ws%c56~m zDB!E+qnGZ5r)o-hh9j^sG5^(XltB8wxH=Disvr2@f6jCc=N#wQ+p+h|jvOOoi>#1U znRP^>REJ{|$KE;itn4J!F+=FcE|ryx6eUsVT;JclkH>x7`zL%JpZ$Knp3j$4PzDE& zd4LN~TtL&<>+qEKmsV2moJ*J9PN`*b0pJU18Pg_(GvkAdCZRivJvCW^>ua|C)y@-& zvJp?dCR3Rl^DP~Bzn07J?w#_#obl{-ZMPXVtf%_;nEj zotYgFia@@)U76yScZ(EnNsALg?^HW}3%Ijjn3HwL{q5-etMh6XDH<38Gdopj zM{?Zsi?@)Df9PI$E8|Mh#)j3akct-njN0R8w*M!iU3JHh==NBBt&yCch-v2pZ(8gn zk~L;IPw@384%Tt90LvX|xMS^if@^Sp-_<}hB17u#wLmV&nX&d3Kn6 z+h6{hl0P#RnJ#Lo9O+lsL`J(+ci$fcMweO z`Pag15*zfnyk@_LX&)x~9V95_HNA*{+=vk+-qagUj5u~4Ms(?3{WIFJrx5+8a(ny1 zi^Oav=Q)%`*+apr9sALXOjl_zO9C9jjqB47B}pD;UjF>V6cIb^znT^`eD%1FcJT$ zpO8F61O?`{et0b;W<$Ktjs4H-k6B?6m;P%ksFHon`0<$a_QdDl!E{8(TS zOcL-+<@{XDAJuG^Oj?4pcYO@b9l5<}bP1h5_T&W{?rAk&==9DDiz^zo_cY8qnXXzD z(JbRoqFll3%-ka0f9tXDK*gr|@>I0yi_A|+_5m)X*d;6e>3Y{^O}befZLS)dlTR(D z&$d6sZS{th7w=96IzJ>an&bI@t4Gav`aBZyT7G3BXMZ9*s_4x{-bj_PZffA24j0#D zeHy$W`n$$&Mel(}$Sd%p&c%)DQ-_h0*O5+-qq3fb3l-ezFqs&-C-ya>`*LV6 zwvEdSeQCXLfoV8?kq{5X_e5wL!0|@fP*SYP7lPP`%p~1jC{B%&=}jm~v9dHtNqz0( zT?J%>mE?RSg7XIA`_ES>f^j03S){WF;`EL~pSkpS?Fp|$(V5RKnJ3s{myQ2V8c|## z$C3HJG@_S_gcU>Ln)sRl$>qj~j`e1>=Zy~;ksOiZk>_|7^EpZ$=- z^L``r+7!*mAeJw=7BD9&0|v=Ld}~FV=ghH=8>weUqe(*NR_@%oq;|n1WaQW7(}xja z9E$T{$>Q}2Kj+J9ti9TBFfu|J0fT+&3VZ}^3xNaBqY*j(X7d{PGktF4VU6~$1J!MR z2Lb}ljVeyDYLAgbE!1~a!euO4zdJoJjxmX)X@aA&2nJueSiTVkFyh~y!mFB;UdZIP zplBc#UF9Aaf0S}Bl3gHGD!r2JUN6o*p?6rZ z$5&qU6$5U{Haw#6N;h<%9qYYw5_S$CJ!4v}90S1)8$p?O?|~o zPks9TT7Z@uVwg48h^k`+D@jPtE20s1e1_O}8}{ zeOOOeEXMKQ(bUNB3}!WE$BF_XJ(yLk)l3#*8<1@}o>e;{M$W~|V4!OP;S4n0-X{KP6^(PqQ5&icY;vr(m@vDOZql~o5Z6;BuxdldBys$Hu4 z`D$jplC|81s${TlS=4^k>qA9^6w>RP)cd#nGSnW7 ze#R@wwaijDi=plxi5-Uw9J{`Tc-p0lu{UJ;t>9P9*ngI+l0^hWknQSu5|P#k(Y>WO zcfUgMW-=!Yn@14M@6TJcRf_kEPQ&*1k(+GT^?lDG)2|s?AaMqA-JUGBO*4Xgm-*ls z-fX8~^=)7NOQVutd94G{J7NOE5wF!+d`gv*GZMvRSMH1t^{T0wh#quW|78Z7ij6cU z-<}^<>I4#WMK7oPnKMyQo?vFROQu-zuC!#<4xMKEuJ(CuszLlr$#LGSRzEkDSxm6c z;O&AK|8o$xZm!>mJ>MIfdgEmdcj^Au)Jk=1L1jA@S#(~q)!``zO{aQ-*%Ir+-z;CH zmc*+o_K@wKS1L-+*C567RA_D;i64sk_VxTey^Qz7uK`~JFkKds5xB)KS zTrTf>>bmjGjiSd*_SU^$YE57Ap7k}!uB^3trEP78igJjpYX82mg=)d)t5yn5QwOfL z;83AE>m^!o%!IqLw$<0N9i@kj+f==$?i;F=|3R3Zu*NZ8jAe+~+=8y0YyLeEnvqqb z{IfGvBMHZGp{xIt~@ z^KS$1Z&IF2SqJbV=NVI%PBh;RcDrj{c3rDkNPc)bHSK)PczJ{HMt;1!WOPd4l$!a| zRE5xrKRK(4z7?-AlJ(#rSEVrhnR5JzMlbZY93lRHO-AP6Wn5NgKST0VNc_c^WzN;dLk4c^r!#;geb=zJ-3CNZ5X@5_Ecybr2yC3fYc%M0g-A*ua%Nor5JP|Dn} z>KLD?VOVg@)w)e5&Nl(DSN1x z7+}Bf?}>yRu~%2oUr5+3F{{wAo`{=D4<-F#Ys)wBo-|!Rn!3Kpx}wbMB&XkQ89teh z$pO68M7VPbC140Z%V7+A*Vqf{LsY-)r6+dN&4}A4oDr}29LYIp-cgwCu}{`~N--_> ze?EFC8GVTo;MUPX_tkDV;hKRoIr&?0bv*acZs=FcSBLkgNQoK%lcl`RtzQjo^15XC zUjlcwIrsg;qfF0G$jO`yjZQ-0M&Y#+-Secl1E=53X#oehoa2auPVOHw_g;rCvib;c8t=W`Dxz+x{}EzAID3{ z;*gLwtVb@sY>>&3a9H8`4}WlFK>SL{mhC4=Yqj(*>)#r=Co5Pb3Z0SecR!A2%n>Ww zxy^JtCQy!U%UqL)E6i6R?i8`A70|#Tq5Vzros$Q1`kLBKyH~IgW-mB9;!U)^XY{w~ zIvt!~e%>S|%hM~s=J@&ZosNP2O*C|Z(@5G6tm4q8gQ6Z$=g(5^uSb?TMqg092$2qh zWVPjO`U*e?gdm~`w&yT2nIxLD8@^jtVwZXvxc*(=CGQSxNl%jQe5tH zlzp2rL4BY*>_JZYLS%}2|MV31lsR$sPI0=ra#d3_NinJ7EcbhidC~?^%Cz?Bfm4Zn zYE#3~Sctf1>1P9KGuoKnWQsokyQ`f9>n#z)6q&Ay_>pX2(NMiM;Q@6c&9Kw@^3#Fx z&Swr^ieenZJm_N8X6mWE2y1UOD>fNJnEGGCwsTPZ#y)k9K4}tIkyhH7wCp#!Jgxpx zW~LZ=YKGOZKhG~o)Eb!|bS4iK%d~?6=p?H~yj-ea6|rA8jDWCwnT!`bM>EpYGKy%9 zQS~*tFh6gK@KKj3&C3=9su|@+W+j!%BZSoof);aS>;l*rtl`=BFa)a4L6*mgfJ2~K zPyz@+$QjE!+J&Bq?Nb9F(g(|GwO*c}Vgk)a0QW)VTCug4h^auzCj?-w$l9C;JMPc~ zSJLEpV)@z(tUgp8D=n8Q)@mLvfP590-^e%hvcP8 z)t7Xtg-4@>)fj7+6v-;Jy<j4ERQw3R8Ah>LB08FNyi$$ z3H!_th?S8iS*Sr2`WM)E``L~crlUe=+|=zuBetfRTWqlc9MSK2jdhjF6x@38ju7oH zMnB^Ef1oRjfuKRoY91QF}1}QNzYydf)PiiNwj%#_kYP}<~VJrxZ1-4&(C^&tZ?R`| zGKhSFkfZcgTC=*rqqa1< zS4surR1VIqDQBroGtn$Iq|($YPK;3us^k!Y`;x@J4X;>9OAoyd zXkXp*{?d292Yy#%i5v5>PKT`E*PE}=r(OxUIdYs$Sd>=X>^!rD1lPmYO4||{MsnS< zt$z)1TA;_)#=6eF&E~x_Sfhrsb@wXe$o&N`o-}mXHMBW5csY<&=eErL_T>BqoAr~m z+{mhKa7nsh0W*n6kh@0P3@6qFOMkhf67)c;(Sw7`@4sc%7{e-VpadOmk|fJ}f+dGy zR2_`8)IL;~`00LH$2T`9P6x2|%DrLs7pOm@N+9?D=H+fDYg+cHbe2j+d{IyAYYA@{ zs)kK~8|XJ-H9944%HOG)vz#RLKG|n){Rz>F?Ne7XQY?-UPmEE>meCIKo8a3HcYZVX zoI0#(Hor+3xygLo38N@r^v?0MiB|oB21Jn(f!Y(&ERMqgQWaz;L}f zXO=$Dm%!%BA5QD-h?XA88toXJOf=FUKvd^q-n%NUT``g+DhdYYSFyz^=OPlzEHwC&_S0N(ftZj(_W{8dh!-EzsxA)oelAQAL8?AcdSZ5_yyi#u7`yb;zJ}D#HgTad)^$sKCmF( zK&)ssP2{AIMO!pe?Ut^3JgDuJB&#tpwnyAFn{9|DaRH0BB*@5#nMJ5dzZCOMy(Z7n zFH`ef_a_-g@Q3qF$bD|Pb`Pomp-N|6lmFJj)9_CAamx|vgo>~+r-OmTIv@}6R2PPV zbU`YY3256^_0Uol63HT{6^8@GTelkY6HsmaEIbTJo)@hKO*FNqG||T=^vG_yll`Z* zD0;1}1XeWz?luEqHAAU3LnSpM%{C)_HDl8@V;i;8PHm?zsF?_>j+M;@s;?Lv7eG6T zy#`L?C6?I`DsuX{%u-^_E>sY*4dC(sLN^T)*=Eq#X4IyJ)`}HZBEf2VX6uuzxS?kD z73$ztfTO)P4ra=9W>923@OT1Z3}KqH(1)%P%oFts+srsd$_U&} z5Ry?;JAthdFb0F?dNg^WwYMma?8dH-)ScN^_1F8rZP9wMJrHPn*1}Ihr8=QQok?W> zEYtQ`n^j|;4uZ1A`Gj`Bq2v74;*u3(jyN}KzI>HAHu_m@uf^c1C9{Ra2f^Fh%uRDn z`mr6Z42XYUr6n_q91B5-QiHj@Pw4LOa~cRL3J)mm(Rc3S^(EO+#2j|QhkEu+bHjr# zbcBZPXX_UWJnFA2aT0-jVMF zj1S0=YR?ak&&|5Lo|wPEX3S3_>AIyEq}JRjnhX!QY?>O81ko~}9(?x$ShG7ZaR-FX z1ARcta;VeDkBlSIuD@eVQ(~|t6-5|OJ5$7-+`ioj-Zsr(d6nUlMi@FEI3IFc*|!dg zEIGYSfJUo-M+w^2#yt#;s1HA`6CbNaX+^bBD zjjU=dxg$u1jxm2NjFixofY)oY2Y0(N zRs9>-Z~0uE-9J?DL*2?;(>b;uB?R7VdEr=cUmLXTU;0m`uHvmmYKbnndB^}#qU<9}^U#7etzgYE7_Pft(+ez173 z-({+Hwt~ql8!tj4g8;5Uf2*ON4P$aZYU6baO)oWO&f<>X^G++4_X&q*Iih|nzkZ%L z&-b;^nPv!(X23UfXC;@ij>6=P7khf=VYg-Tx)`0+%He>ACGvIT*rZTD*Hf4Er>OrK{v_w$&IYGzn$qP znoN$-aY6x}OH(IV@X8%Z3!fx|+9v>+{r)Hl%3pA0Q>iQ)ZGN+X-u6l6^%92_3kWBzmO%0&2h`FN( zgZwxCssM^u0E|Gd2-HS`jo*-%)|5wL$G{G{N`Sa7-Uv0mM5;CbvAPlSMbiJKb3lP( z=9(9vzAa*qei4|ZtD@MNMX=?i?jfHEIjHB0++-Jsk7VYf$I^1-Aj5fc_mh2|> zv0Ajj04QZA1_40a;^&Z);J3;$IsgG4aG0Rs0g$8| z21Ui`@y4_!tZ1Sy7UE1Z`~B+$aJC+F8;cZ?1V|dv7qPdMU!T-%A|a|ipW@|-H=da! zJ*fH`wQ*j!3O-k2CO`u&Xk~^nK1{`@m5lJo002k08I4J?I#Er_n=LQ#*`@ah32aML zW1!aHSI;-$?}0QpQaMqq`7>GM?@NS*G}{k<;5Gw@{XM6tF7LSO_T7&J5*5Y42SrkR z)qHMo?B#(t%^-Yc>=ysQ<(tHSZz&)DzBOf&Hn&U4aUp>m!yiWb?Fzebc(Q*R8WMQZ zoW%>~G_a*|umg+f>|S61F~FIU-6Ml@9*xaE%_bT_x_ypfxF^XL4T>F!WE` zBgT^6WF~3=O`{pBnG!t$l4p{6WhFUkQI~@p4T!c+?{-r(JNl~%-H;ZULz%f~fiuHl zP8=KENZ53-nbMRAL&i5eQ|`c5^2|OGZ0@lx!L?fhv?N*hoZZarce4a@;f<2k`!Hn% zg_@?|af6mgnQvdDk_%z?@v>MDyX}av-0$?1OM7m2m)uQo&3X@`)N)&+YITf$W|DN` zs5v48C`A$*&o)_RZ(nP50r{plc~U>Sf#d-5jAqmAaZ?Bo5`ilZxq>~p#Eud!7v8`I z&P5~7Skk9Pv@(!bLcJQ!3|=yH=A|W2cBCTbT4X2_%)BUg_4;dWlbY<%WzI&^qDcpr z%yTtC?G1qEmcE;eOEjwd)Rnj`!djQ(3{j#rg%h}ZNS+jP0V^V`nk zj+CAWUw8Ew*XQ9H&5TZkGuQr19R$_l;XDB*TtCZBx zn^|0C4^bhp2YNgE&uE4oOkd4^UdCCEJqIKb0Hl`7VsOt5mFK?`qGq>5%zrvTAQVrN z>ceVAyc|tv|BJU}st1{G_0$n3aC^IG@#ySkuY3j*hc2PCK-oYj+nZ=2&^=bzq&cvt zXQnSn1dw;c4cR7C(z(w@3%?t8<-^nUwJ4y}ey3-rwZBghgKW9jjcEx>z~0*Tdszd1 zj6uZsqkA=6D@y!N`aVr_zv*Z30`f_jQHNhZ^h(yqFeYb71Ud1UYZkNaVh?AJO&sol zAK_7?=sunX9r8H^u#1cS@^33Vu$)#X~US&TX7cBn-mXA z>YrAWx_Hnn`yYYTn%f`Oa^4OMA;CcJ4hoWAsPgQe`i8H!LV>6^z|}2Qca$3B{^Qb2 zB-fDcXRtNv!HRHaM_VoLmRpU$$%XgtxDBtEXG)Ep6;B;UIGF>$NkVF!-m_n#3Ei)tIGEB^UL<)m_km(r<-C1FBh-BA1i+he0czg`e8D^$KXKV z;5*gir{|Xx@9cWJox&N@{!XbfB213`nb8f`XXPi3t1DD_F_sH5oTUhRDZ^`7WPzN# z>(Ly8u;#K*Bw!*{+3q(2kuXll6uqi5{=o;&HM5}P;Z&!3kN%+A0KX?}n(7%9+%d3kl`yfaFwsgJw$ zU{L?mcP>zw@o~dB;Kve23Fq=)*9uoZe4h=!2L+R)`+svxK%P+&)r|olOEf|5@#`b~ z@Q=65n?2SVKU;j3SU!j&3F*5{(7@L7O5D_ty(*?`AGMturf))KU+N4YW{k45Qk zNYnEfm&{M&Q%Ay&nEr}IU-_E>z3{7BbK^;6D@ob-1K%PJ^cs(Q^^0|kDe}EZ!~)Z; zom_#>r?E#g0$A+$moXeX!KFemkR;h~h~h@}0d*{dodB|20%wTuEQ)x^1M2TM{R?YC z89UJ;S}_t4F#$dR9uG!W+-c;zvQc(P605y8dj==1>e0%lXrgfy6-et`UIfV zr266|zYWiEM~gxxq`b&_^x_eu<_z43ULgiTanC4eRO?ij6yJ1L8zNy%cn7!v{rQwDiUgrg~dlp)VW z0yw=FWQ+BI^>A}arnJ?9IucX5wA9zA5MCND|HVL#457=5j^3+D%VA2j&iI%zrbpf& zb3ALRDB!FtO1TEhNC?%=!+q)mKIf-Rn*p;t$B6B{D6iD^h?FOtDfE~87xCa5Y#>P< z$+3e}A?!WzvU_#w-am)R1L31u`#BYd#0;oZa_Mes^$(yORg4joUs*o1TCx z(m)70fX6~#8nPWErvC0sZK$PaWQ%A-W<6$v2x>ja`ZPh()#hp1&ob1`Hg?H2DG<$F3mTA(DUJ));|LHuukQI?VCp&Gq&dG|D~GwZE-dwwo5T%HtwoTIGRdkg``Vej>xX$H-uxKt{8*R#_{jXkg8bws`Kj~y zX@|$`ctNIi!T-mO-#;v%{%>~NrLa1(u(qJE{z+k@O#VIr3NOpGiN#Z_elk% z9=rFUAnHZ+(tie2=Xt<7Sd=+-dA^ukCx@Ajo%?q#CZGWO z_P(x5*|nB3iHx$nq;k9YGUeT}E4<}7+U0DU_g^AQ<-2gQH>uj2*^0?*%5QU3%?s3i z=NTlkNp9vTH&^V2RB9epNG(-*YgcBuR9=^V=t*Vt zI2|=&i|PVUT~w9<3Tk)}6?U_F(zf~o0rSO{l|_f`&hHvFPzi~-mLs~#^GsEye-+Wc zmY-2prDu+F`z^%Q%=!h7nYTrc9}g9X%ms^xayoO{V)YOeH4dOBZPBw7^gHG1cNFwR zSM+7`nsLgpK7pl$hRj<;P>+FU0%{CE&o-ey6Ir=*Y6pMU#N2Eg*{oUjFZnxP@z1|9 z{WoVC-+g$Yz%M*zmX3OSOnVZUTWnEdw&-~*<_n=QsfTr^3A5CMo(9k(0O|n=nMY&p z0vcBV)>FtTt*%BgUqK>YLGth1)Oy@>GEas%_fITlnuuy4A@lJpFKy8u=$IqrY&JXA z&v<~o*hE!EHUg+|B6_unm80j8#L}bKPs^A_d& z%_zwxK)MM9_hOxq0OC_RlTTtv^l-RJ>vg+Ui89Qj?cM0n94hYBQT5#tV zVULX-!&v4DI%+TWIrOhd$ASl*%L{u>a`Gko6MDLO9?v-EYl@G$SF7~SG_Nlq` z!R1-2J^OUJ`=CKs1f}RB1zdONL@>mnwYky8+*C_^H5BgcCOijuI4sHXEQ3K9y z1BoO=J!RmW0E$9KW)qkxSd>T9pkMJ|K=)wK!k}X+B9=H%2OukLkv=G79ev&BfA#SL0eo`{;wdu zaC0@#+8s9$*~h?Xn&a2Ia7=}8^|^$y#< zkc$0uOQ?G^|GYd$zg>kuG(@BaqJzf{tguXD$cO zUu^k4yEP6Cmw$9)`$a@|5|JH5^v+`TMk>$NLg8jg$!m(ZG#1VGi|z1u6LbWKZNHY< zmN_Q!p$gbPw&-#Of#m~50KH8g2x5=nV;{3X<k=JRPD73pG2ZWIt{lz4rK5;? zv$74HE4K=^&rO%H@LTIq?+c8D9o5VbFfR$nF#>CJ$z1Y-Ip6m)8vwe7hNP3`Qrzc> z?j^aw^BF}`;EY*^XR}sTZ2F*SagpgxH|||q)bZ%$ttHk^8NP@ItZkt$n#OLtuR)AF z<}1U0rlSh*Ec4j*Brg%0Dozu3HnXw$3s0s-lW|fy+?7^rP+;zQGwUP?S&K&@mH2{TMS>lEtEI14=3?401py|~QDh2;XoUrYQ zULavlG=ZlUSETB5}8Mj=cz=8eOA<=`OqSOH0BYQ;*RcVi@*6R8%<~z4Wvj zb+qzXp-U-ke6`@iOZu}V>~oX(1?zt``R`ZU&zF}rP7(|-6}G6}+pe-{ljhG?O(s^E zGH}*S(0{gUe~9QtBJ-^Bnw>v?v-Ircho9WLKAXM$q>#q;mkLXu!kgW(W{eL!^8Xh6 zuY9;Ii-lox3>oUz`w{aMJhG~i#m zwkISD!@dKcsh%t!NSnqRLYR@I`(IZ)PSTGR69p9XM;c0r9;MX46jb0*;6u(@^zzh?S15}JX zUuWRMmG`IGK91wc(y)K2ZB)5Zhzjczas86VC+6j^lOE3?2C%lHHG>e=N#dBvzZ}5_ z-~ODs--DSHuwyL?XwmtNTEy>Kz5VuxWp4QJtB?}Fj|HN3IR7%5&<~C^CW{|zH~4*JYHY;)A~KItw-8?Fg?-S6hwY*;K{c9qRWc>SIMrW0VE#D6z`^7F{N&Ev(Ur_wKY z59?zRO1f+_v3dRQ&c6R^T!_+F!)DCDvCfG8_H^AZr}1C68Jtw1uaPsX10)vXt6v4u zSJ>YkG%R3-Nystf9b^AP-1C-#yZ2AAeq)+IwUK^FdL0l{SX-_Ce0iQ%o&Ftez&b+x z-N?v#sPw!^_>Z0JU)5KKEgR?x!r_w(YgeK{pdBXtM|)Nb-oIMBtmDLuJ$&}?Rko9_ z|32ORi`@NofM;IvWbeAl&Tk96{q~3XQEtytc`A*G<-_A+cAQ3tfuV(r^KC_XZqb$1 zpFXxdX2&5Pf7a)#tmvl+!UB%j@l~@-iPP8A3a;UGz)W_My1A*9>Or!m&)W(nCB|a} zS&mb7SQ9{wGjbCZ`I=Yq@&P5L`+%d;wDjx)kAa)teP)v6Z%Cq~>OYJg=QV}YZ-s8j z8ZG{f6h}-gQqY%DuUN_9JX$O#_dluga5fp%pJNg>5nxmBegxcYq zei~3je#-1ljTC%nH$U3TiRbxYUEkpT6oc*zvFU~~o;9nU(GK}C+Xj0}Aq|Gw(%Wyb zXi053Jig-ko$=lJk@4nsZCZDoTc^>_H{t}1ll**PKq|Wsc2qIOS+|{?!I;wTK_{^Ed zJMxv^gk_nV3`D@~<;QOC`r%cch?Z*2lQH!lbnM>KhjW^GlYX+mv z$_fTrFlj2@I1zdZ#3b5ks5ziLz!iQ!;D?ow@MspJK^r|%&6A@GRkhpN=b+l$TaIFm z2e;4@O9OG-hVc zN+1gT3tx?$qj^3Ug2T0Lo6}sr-3%5AG&O&i6B;!j?R-`0fx4-j{|P@n%(uTpJQ3<; zT+a)p_R4;*u1cK$@Ov1Z?Jeqkul&Lbn3mG5bE4tYz-<5aSJ9h@MabRz0WnD5WMk}+ya8XH)HRrfbjcOrxyYo z5nH9>IGtPVdcQ&>vjSxe-LHRoeCbGz{Pl^iJj2n%?;c=c7II&GasBAVXY_->tde1@OojYmCmgN8oBkCfFrxF9dQqLG8R0vPrbs*Cc>)QGjqr?9aPu;B z(=y_DLyuSQUqWBcHxl|vPq=&HOkfn5{XQ{PqWy{Gi9!{e5tIN%OnAD+%<@x-!O0xG z+|tDpmE=lWzc4DYMBuV~OLfTZ}`;o18~qgyk=4Te!}=$$n4o=hC}|JHP)X??vN9@n~&JZ^_NfYooR{ zeyzhI)-}R3V!XVC%c$!=FglV!y`-Ui_H^*IN(c;Le0*<|+{CVMY_21eUOur7Pd=N! z9edde(}H4`2Vk#=C3>>9*qd)ddBJvM7?&qVJt(2zo~4wqXCO{ceVN|q$8qACiog#^Fy?X8IvMU_$W#qrZqg08ws)3?lm~ELcV3<1;E4s` z2GQGXODG^Q9iaVAZw~m5;?*^RQ(&gP=9PSni%uqq<}Do8X`o!`LG^jiqHNu;E5x{y$9b_Ek5BMK3#WRytr+5gJGBplj~8ev zqdgtf1ZZgcQ}?govrqef_6Z2!+i^T%oF$aFD=(gU?03vQqY1)AKAgPp`|G|SlQvBY zO1%fcL)#$3-|qaezy|X~L*QO#csRNjm3e#wSmTMYVhbo6W20W~G@`=IXfMo-xjtcd zNTQP4#K|b5e$h+)qT-GBPI8C<3X~mH&k%3E*||Z@!QG@IWwJz6pTKLvfMkc)vHEO;i6m?Cr*b4A&(__G9`zJ9@)mr_ey3w z>tJfVrVLSUS!TVvXM~ZGjxj)FPicC0m}GYiX`9%ks!P#ZGJ`5gtE6TA$BhcK0&i`x z3YxzsJWXDLm+7n${S^E+3p4#RgOuh`2!z|xtVo8diCyC7t$K)>$xcYB-GRK+Y7xE6 zg*zTS>MnQ#vA9 zw-r}nxoBRI-<)Idjv|1YAvxvJN{4mWwwV*TA@bDNkUGI2O&==y?%MgifIH1k8S)1N ztSs_Zq+)18sHO;@%wwiYoM0|Ht7`sZ-|d+}%{s;SmdMhO@gpi?=hVYN;TYw9W-tLB z`{!Hq&lX#uPWrG~?*Fb8SM?9*-5ut0CCN$a)d|u3PM=Kvu^-$ZIB~<^W>@yVP0F4RUlAqMpiNL= z&_0&WY_ZEqzAEIF%Q7Z4QTH};&LgTEW<_lKFN5dt-s_Cp7SQ>>*S(c+CYB6Msn*`{ zd3suoT@{%++Ac?sWJ6a4(4&29022m-KpLg54T+4gh@7L=i%F)91$2X$Yp>z9#q zj%R`+H7>mNMWINN{sH-jMSs`6KK1RhOa!6LIl*2l-ta_ShVxU%0s()P@VqtY4n^Ou zDZcgx*Ucm}Lri~Qov=B_RmR1JYg8H%{kMx=W)n&JcKP{s{@gj_^tCL~`P znvs_X7H!4_C`0wS)Te7}^@!@>TCj_q&pf>dRX@S>Cc7eqbl-?ssYTb;ll5xSK%37gSKUO@O5vTI>;!DjAeqfTI!1+(So8#S z*+FmQ4dUuL%SAOpGViIYu^Q*IlWQh8J%){$mtwfznOtx%IAD>98LE%=V{*jD8?yHe zo=7_-*Yz^AHNxnnjs43SI{rU|b+N~zAwwSk`>C*XRHQM;ZD~;giMQ!-j-EvqIE2~| zB^Ot9uk@LLNG6m-(L40VJ`ty5s4-m5kdz{$n~g7zGtl>RDgKB!UpM1F$RSIhwn_%V1X(VzcR6wWVc;h?Q@a(ug-4Anj z5u#`YE&OsipJk*zHC=ub8Q~Xq=WkJ#fZ;teW0O^_rcsNWg2b?6YS2&bbWnfe4u6KO zrC!FX;<LD0u9Ar{P;TmN;e)8>t^wWtEFXM*p|+ZhW)je2PORv!x^9FCRo>P zEsh`wERKKePrgk%?p@E>6;FBwHAh++oM5-;u0T|ICjaXm_uLTZbB5^xr@wNH$E_z^ zN*v|Tmd^(0fcogIR;zI}da_@F_hNp)p1`y7RMxTK2IJ%aM4a(Rd**Hux@3%Q+}G4S zh8;`14#c;po#faX+v6 zY+J6|$;Z6kWo7EUksBw167WI}a{BtB+SF-lGiN(FMbwdf>o^j~{>7Udl%MI+oV-t-C zrca(}T2@HeA<$hhM2?SkWB%lW+R53@$<%zfoo%nB!sPL(A-E?=$5{(nA+P$u9C@bI ztdKdaEHR$3`m}!2_r_WTa)TY4@-8SJqSI&Pq(RArd^_$KRn(*W~B& zYDHgfHT8E#M~)$mKk_c|*fWN=?2YRF05Fly*K$wXv}(F?J@m z>*8ns14rZa+Dp&JrB6*d+vrs@)sLp1p7*dyz0-+y+=)--6ffG7Nl<5b%nQCxnoIVC z8WEX1sW4d8{geUr6G`1g?c%djF0)gW_XDcE3acZQ5!8!uArj}kGi%!}ow+Mdc(bd@PE)_8Enla)Mn=KZ=_pU?GWoYT0tLwY|v1*+~u*HsqZh8Dh z{<}6b2;~P&Bie;|yE(soH$Eo$;u-f^^bdj&5m#YO}DLS#e!r{_gVGC z4`kB3`rCbjw`4*LS0|+C00yH0D7I9|o1(MW1WW1Bf@e->j;`k?deWONOs&t|z2~6* z9v|EJVW@y9d*y>F$mJ6b6+n#{kGOXo8}}f#@Zh3xM8(H>{wc}>S4J?bSKM`r>i%Z? z&EaY0n_4iH+nx ztKD@$o$tEeE-_@Pm)Qkvr_?<}uS^E)EKgIGz>b2dr=C8@kGH2yW$3tMQ0?@Zu~$E7 ziF8b);uEw6&+5QeOxS$-X)6cpun&7HFjx}d;rsx8^}MgwdpYE_CYWZ4&-LKdyj!b% ziM|v>Y*JK-RqeT<6dP#&s^y(m$?G+@bP%_fYi{;l1WA)o&H%Pnbr0&y(&3z`m0){k za<+EmzC>Y`<;8o6FS!Va<+urtKf~nwi^RH%$&|VrRYYElOw7Th++--UiF{QVZ1ZlK z*|E?1`Kcn?1lb4h0`-(jgJ%3QNq*yqpi%c&EYtLYCo6b3d2UVo{YNq&*W9Zbqb#Rz ze!V$Ujls*4=s}@`LCL8ze#$&>X|gi<$2x^eV*`)EN?!72ksZb3?t&3(l#CDpdQMBUy~oThX*coDIKGQ|Cj?}^0z=) zYUo8!B>u#W_noI-`QiaW@o7t!5Mo5K!IXW? zb#KcL`lZ;@UQY00rB;xW)t9#XXl$*{M|F;4PTwygNd0+dS2@Ch+!md$7E`Nc`ZSoK zQ%kx`i(mYD%$a_k(qEvVGV!yeryb z7QcFl#ee|P_ZijfZts6+tybz;Irl4B(%T!Hg?c3N#dG2Z)OdBCk4bY(uK4)q=N5<6 ziRAIs*l`woHNr@8y&JK8u_O7w(crcu=f=atlL)|J<=c56eqvk;REhwb`dt=6K_3^h zSf}hiyj({jg2&d%%81Fzu{fe(@*UZxZn1KESm#`6Ib=!-T zu{-W~CgS;(QL{D0D^EDig+e@n_%{-~sW4Rrv&!nO&}>MES7;^2HJTq0Q~DC78my}f ziAT#QKW4VGZw2p$s@a6%9%UL_STYn&6}6tqAWdy6&nUeJl{PrxLUpys{Vt;!%=+Mm zoc`Je<*6AMG1iYR`aMC^Ir`|%-dW9`m;7KGWufzFL97q22`gQZ&%6F9;zDxgPnoh4 zov~q!o#(xrehRmRp@M&EDEex0(+_#(Gan>gHr+qDe_bXT-pv2G3-O&_wBfv(#2YR4y6}%R;EHQ=t=#7Z%y)mM=mtB(Osil# zq{rcpr4sdD&ye%7G7^5q-DThJhizwH;%Y2`^D)!vkWf1Y4G^k zYsYYz|Har{{zVl%-lIRv3|&Jv3?b6pIdmf}DTC4i0-}`2&?(*BB}hw(Lx{A1iiE(B z($XO@m(Mru@7~vaa{q?2pPaqddar8SC<7cnw7T9z;IE-DU>5i({fc7ojc@RUIOay; zj}L>=q$3^<=401YjTo*XTICB_t9(>IqHW;*>sNh`JlkzOUvxy-v_mTP4p;xaioFE$ zqQNhQPlSWtU_oyZ>w~`iz0o5Lk|vIPwiV|}MBIS8a%$m5L&&lJ5Xb6rYE~odP~-Bz z77x2#9|t?y0W`Z!V9H;J49CaZ8gF^p^+(-z$7`LB*aqXF>`&kP;w`14wdS!5X;fz) zN#mh9XUB;zREgwe+6fas;hcyil2#tu{>~}`B6qmUb0)T$%2iDjIlJ1=?t9g#YO~vB z`0!hWWzfNot;Vf*K>uS(&=6^+K$g7M4BxJVqZyXY@>8Pws=#!q5C6pC?qk&Vs6Wp6 z^E35-RWJj=H1#+CL?2PB#Ag@$bTAcolIH$URIOHOW1^>+Jt2}-Z1+!LfONgXzC?rS zi(1Qw(chL1kAF$KyH%-7H6EY|E~aE0#a|7M_c?7wj*9y{-O73?D#!F`&vj-fb2*&9 zarvWh%Y>cjd|uZe1=i%vU9>`{d)>9Ycz>R8$H565)r+rO#y%>lw;J<`Gri*Uq4+$} zMdIK2FJa+i+ET0$RF+cn#-yQ=1pK?!m#opOky&^wKe#Rv!q{rs+2Sr+K;yCEjZ*CI zNL|IyuRu7OMIi(~ql#!K=s_B5_>FaGjKDta6-OFg0Of;p(WRFoVmu?}4>BbV z+MXp~AoEcciEZNPOis6-qEdWuWm>+8WpPj>CLYyw(0V?v>7bG;wGNy1zg&zlbqvhF zMQ2H+XaTOTSHm~$BS|a`b6@HE+^-W!g?-CP?aZiDR+xpqtMqAY9+q&MGvQII){-%F z@pdm`e}yd)z+{mma?bOfz*NRY?UW;RSnOJAe%GvsbKt%r4bz!X+(oXA>xHttFMKKe zMH^AqnlV>x)+sQ^+w}Qd18SNne;P$Q#gr5oMj39J$G!c#C`D!hCT>Dj!<1)5HKI>tXsJN!r{L2d!lfL*3to%FcjP-%# zj)o|rHSe@{T=%o?r}=uh+m=(${zUlXX!nn{OzUvtYo{77Tenu4L4dFs64U-+`JB3d z{YD;1Q;Bw`5~k|;ZvhWq_u}_*J1u*!g^LE9AVt4*QE?lf9vFu`d!cM$&^?VqfJgpV@k@6&*>P8aQ`M=O_;P^y-G-qYp+?Mg~>u%N2T=HS;j_0WB|TU zV<2T?_yZAK^`G+VCMy6;&(*mf>w!R+^!Dmh58fcrO8Dcmp)}F+qg31VB0TpW(V(0N zK}OI{=+In3k2Y5_uex9y?-9E`(9xOZ-e?j|xuole8|&&Uh}5G5aA0sA47bs-dPe-C z;BKr~c7^a%bJYh^MqfW0auUa5E=~8mQ%L&CcEalU2vN?%sTI}S45dZJf@fPjE;U4H zl4K8z_cUl;;6$-*KFvGr6VAM%(n?|zxU zi`ROC2k4v^uOTAl;0EI{)y}8z?E{fqM5)3#vEorw9k>tgIDnQuM?omG)s6@v+TMHF z`c*>8gap?(t8X()Ekd+*h4|%c&pMzcvt$=b@}KVbMcsc-L2aF}mg*hFTJZrFDJ@*9 zZwRH^hROO8(gn1qA@qS86V99QcKB;_@-1^(20aA-?N}xyNkq@E>PI%EEyx;GH<^md ztIk^PXHzi~@_!|lF00tuu4c`hiwZU!7BeR!l71>Y=F|N@qfhLtrA+Px7r&kOug@kV z?z|s9sAQ=f2bwP7Mf~E_+Ns_#o-dB{s}`MUiM6%g;3C82wNLgGx{$3U9R`!H z7ft(SShM~_eCY`m`DaW_q?~I_KY8%c_iDC0^TmPf*q`*4Hv@!ElAi%#YgiG%KZO(D zZV)odx5|B9PS+lEXSB$B@@pIa&=8_H1QNqzyc1?##?oxt8frV7KNem@w~_!&znjt4 zynDZYb1h!nhQl=Pvm+Mgda809W~g|?9Tj=9JE6~>Dt70><&@DR#~99Qi+bo3=a%xw zS;4h9H46lVvsXyPovmDj0dsO#m!^~GaL1N!-CqNu>wYgMGOA^|vC`Zb)4a6{-2;mu zLVMmt68pfJt%uT(tPFSkavY%#ZlVE{a`=7Sc0h%pNz;s#fa=(gm^y}fvluq5iAVgD zW*RK)Z0#Hl2O2`?&qG<&OQN?_V!80dhCqs%t5Id9R1(@H$Qb1x2=sUXcH<9{(3~%M zD!gwH%6NTDW8`WO5DlbH#kvr`9Ic0?BGQg9b0Or?FU~?oa~)G~A52;LKY4k$Y6hhg zfE23{DFH-E{3LeeOf1B913a{$5_zHa{x*=5!CFnq8hjL$H@f(YDYGi&+&eeM^6j=Az_1$U;&^6~HD;oqDnIO~yN1r1Q(3=Db=9 z9Iy{jMwcQUAVfs&Z>o?GynIPF&{2f0tiI~y_yF;auJY@7Zi#iP220+C@2Up9c(VZe zZ+3CBX8`Bd8lNu|oC6O&8qLO+siv)K=h^?GE7ewD>HkC_>YA@2#Kt(wp?|)r%Arh| zr>f?r9%=y5pR**%VL~&NEheY1)Rh^C49a@Psv3lla)g@bJ0$8244CMe9dOJMf8{n< zDr#5{j3}p}T9a^(uvq1gQ>Di$nAGcYaNX-AQdJ^9w^yruBJ-yFZi8dqrl|gbUOVxo zNzJMb8)oxSEr^A0QcFA*m87_Zhh z8rZ{PIOL?9cfWa`8^rANwue)u=J%JYKf&abP!g_T{2vr-&dQ8T*U3(v&~k0s@;_pW zHWJtoca=aiD;-a9Y$$z_y|E!BSVYX(?-=c%?)>kkO>B>|>^i8XyK1Es;p$nnwqA}c zjj8feUVN)f@$7UfuBV@OJ@3aXxvjvTTbpNwwaj7jsVS>fZ$qp41Ma-aO>HjT**?^G}AD{tB=_}c!^ey7ara_# zHw(&MqV{t2Srq%T&56`~l-~co zxvAo(qBIq@M7~{sayQ-@br)foQgHTO1bYdKB4!+#; z8Mk)a>VA~!TH%`9;oFWsc098GaPqC=q*dm*mrFmfi|n(ze{^B>Fg^wIj~OgF4j7T8 z8?vSw;Zq$EpbjNWxoY;L6ZVI)$u}(XHtyUF{W$SvvLC(MvqFV&qBw9|Ay2;iwEp?i z<`dNw0qSzZ+_vY#)S$cdSG!q05LFBBrEY#^vV z6> zu13ah!c4y!nc^A&Sg6GBMw*vkNrZ|Jx^JBcn}w!{{!uTEm{QnmqqubgYvqxs=NkKH zBZVR)zA=mP;lP94pPXGDQ=Gd~C1qfN@f-Ep4NH4Pb2TZSzJq<|n-W!?i!jA*=*5AW zjGOY=7e{q#i!?opbZ&^ClZ8;A_iayoN6&HKq{lNmXXULONs`|{Dz?~c-G8Cl4ud0tckoc*nPt38iJ1DI24!*ITiIPzF!)MMgC^qc$QZIg>ze5g`{ zn@Yojp}{32MNym{j2`)M9gs! z)UOZES$Qwz+GN;z#)P%w|V-Po;t~uJLXx@UNQq zB~uUhKofH`rwN;v&mCgY37h?Rasr^K(>}Z!AOc)z)V3^ai~uoOrb+_ zqM%|W)z+f;Ou|s`#6MWd7{WEebNMtp;@Lf`CM$L-jyZ@oe%%?f2b+_6_m`__u|7et zlnG=P7(5nAgUu4Jq-QiB_B&LZ;mTgoR?ZWq^*(@E^ zkw1%G;v^EbCf3J@=t4`v{AXjYstQhUZ>4ENv@3Q815!VvFKfvomCuzg^9wuFxBSbyhNaB^@6y&>9TX=ed;4n11J&WTT)4 z2?S1F>lgPuV013vw%g~!cH3Q8nbcj6&)NK%-6o@6YSQp?iy4G z@2kx{?x_#_tkFGC8Q9m{m0){gKL8dn=hapvuZ9Vb1HEnDgAxsWO($JeMZ0ymfws9f z^HtYXyp|PRa!$2iyKYN$O#uAkMotz2fuJ(F24jD9^aS%{|LIUA{q&7DVG8_aCUVzO zFikSAkKgZX=9*YdN{P%MY)EfVIy|%?O5Oqp>iB*!f(!k!@W;d{eENlz_}&YFRJjTQ zT=8%efeA!d4Dnq;c8ccJ=m)B~wSnbbjKC~uk4M9ne(t}IC$0b&yaCa-!hYAA()H_c zPq)tX?4wT9(J7YqThHGfrbTyK)>kTH{aR}Sat$Gqrs1L-D(jgyQ-wDL&#%wzdoVa} z^(T8u6p327TKg))A3y-en7qXgmB(?izt*nQqUmSD?vCTgI;`L7CVmF;+tw*PdBYSP z>XfnIsHY}jv#mk3uY)cH3;!7_!ttO|NeHDdY|I0>_9Q!%sO5qOCR>we)mR!~M@FvX zQnh!q%V+6u{i8LQ{TKIlr#_zQEtSHwrR_D*_Kzi2NCsXh? zUw!$Syuw+TC(Gwp(({hy*OPn>uap&+3{FAB)xRINA7lD{ekgOhAZ#8^`JLAVKcx+1 z-&d>}>>_19!TYTv4_**WY6`xr=1jFW|2L$7i@y^^;YClMRDGxUa<^-IkN!~d7j~8T;2}?gT1~)F0nPL!meZ*J1E8Jk1MHtDe(rm zTAQL9^gayZvNJtfccR=*S^ri!T1G!I#Qx=_5f7)R5rs4lVGg-|wU74K48xDxPQp8z z-8fl$18$?T;uMtM;1a^ehvU-qp@&(9fo z^=go&Q2fk44bZ11p;;B-)jxOGfiwNLLsy) zJ(iw#>=G{#kZI3=S$@P!@tHUI5$|xn#8zqRw7W2_S@h!$&0OV_U&N)?&6zSOdXszo z1z&(@eo({HNk{5a4K2yo%7dT8?o)B%O<9{pqMen4jt3#b)6!RS;Y?|!#{L#@mKjHm zAux%{ALY+qQ|?TvPiH^#dt2~5+j>~n;`c#<0GEpxi@Y(i;x^ZRC)w@E0y+ilf?yXR(8>IS}DM0J8S%bMh|^!L@HtM-I@u=!TVUP`SHll5&3Avs*Tq zc26q1V_eIepZcQyMy?+QDCzEKq!oYt5*R5mKnj#eL#K`0cMfxs>6yEH% z^i%J2O+CpF?x0M@P}KQ5EKoDKr95RLN~@=5cp7Q?#K*MN919*aAr*#6D;+E3Fd#(`U5gEof}v zEG1%kPsWB>G_De@GFeYQCBPRY@bNJz*@sEwiZeFk%mfN~v*w0xFhYbmB4)TZj=yDL zli(eaGXH}{yIkYS;0T4_>B3`lfAsSe(W-IlC&!wmv9Uqz)c8G;<7`e>X?khZh1El$ zPsP^grn1zp3Ku{xHY;J+07z9c=At&i|wgxi*q8 z2ADDcY6pVo!tseOH8>txXtAG{iB6rYKMaZ>Hb_WGD;L|~HpJJiEK5nR^V#6lpd&Y* zNXckbbjjtVCCf^^NuW>B_|LNc<*AnYU06+%@qO z&Z@y!12CK!p$Oc*L())s%HqLY`%SrrA2%9#O4fC>HRdVPACW-ZJDZrd6l7#l*W;K+ z8j`;rP$ZIEA>i9-Mwt3X7xZd6Dp#2g^NAKun4hEnTWo@!{)=gwjBGOEV1 zcMzsAPgG?7eM}1VsgZjBXoiSfQkN0@T8j=$G>J$Fv}TKBm6=yXhEBcH)CK0_Z5jcw zsfSoj)mg?2CeIwJYRve20?)QI;S$g{CeJ9^0b_$VP^5ddD&>X9`>{z^)xe=V(EZIEgDu!yVSW z?R)vV3LMENb3V50vATO%1pG`s?PsW?RTK9V%eC@b3s93?dKOocyku7W0dmZz7a3@= z-m}#{WMhb+V@t4d1JP4y6AM)3TGvOs&SjYsu#rA7X$o)aToeBg921BkJC(3!8fk|J zljzVPeApvDe~I?k*5T;rtS!+c{$O*-YYRO7Tlz`Re`_2ENgOGo>Y|=i zw3PC;3`J%Pff9AoehyQzHYG86+j~pveI{}B_Fcqrn9{P~xtbm17Yd1oWNth{EKR(! zOSRvqu1M<}dEX7_LdAm<#w|j=is^gBx)h0V-8idB#>&~tv1@&Ukcrwv``3!%=5*)j zH>%_4roM!MDei+D&zwYvt-3#sl3X0qgBoTjYxDw+{-dhu~Z5_A~5p9l_7Z5**`8XkW!0c0A1IT+gab-?gOg ze!k~IZ?)B55c5?c$1BcQ6GT}D;P5+75t!*JQ-7EG>e2tolhC($EH8w9;FkAA)l`?v zk(7pHA6df7vbAL+J?S{T={<|jH{T+1KEBh@IeFIF$-1@qu9jQZCyK>pRoj;8JKgGO zGG2a(QRRGHvVi6LQi5H=sec-2D2PHSor=RGR=X(AkwQZeX2-295*OX$^O0p^kA6xC zI@5D;t=Wt1?<q$V?jv`uY206UI6M15*PKyyBDB>!99E5N1OIOza7hfr7Bn*tnkZ20|S_YH&(9 zeBE$usf&pBSc#b7FrUNMB%U821J(M8Y>`R0K~OwwWqc_FFag0YR9@uTQ;k0mqUFG{hXIOg!e%K-Lr%8EN17fN^0=h46CN;7lAf^d8 zP`g4T0)KQm88oBzkna%ZTLUXWGATBS6w45LRz^I5tZ?QddoNV?v|joE8gy;|hY3S* z8;R{9$c^dm%WkD0&-vs(ihss>Zj@ zL$rjU47j08?qqb|yr_())JV9KsfS@Ly?AdQ0Xs*@Bwix%$^ihm%D*FKLN=BQuL>VB zIdZV|rkB19Su!Oz3>(C%RZ1*|#9dcn6b@&c(}rPl2ooH`_`G4-MlY$4*<&2ZwED7= zhRMj3iXZ?r6b`eV&b|{~OfsNjTIaMg;&c(AH=bssFl2DqBne7ke=5QnYE-CcKp{BD z9^?H`w(lW68z(j!SED!Q^JAum&z0m-9%z7y&b46kXfhfY$v-80I2<-)#L3EA2My)& zpN20@^GzA?&lz#$y9!_u4Va~;m84b$u+e-|to*-Ha<+;<1y~G>qC&*$IJe}axA%!C z3gL@mp|d7__eMc~qeU(XeK(#8$DJH01eP574FnF>e;bhLPxtieHH| zAw(%y$n~Y3N?-#3dB23=OXyt)9u5GcrB)1hJIKAPyK72C8cRJtkuXh_@@f`+MIoc~ zlIHBMY_F)?mzQ$G&2r->a#N!6KVQnvHOnua$ghYhY`j$1ZdTYoQ8*G+JbS5l)vS1X zqKG91$M%8ax4`emaLL4!sC<;@T9lYhl~~1;ANVM9w==A^2*P~OF(u}+mp0hE+ei+YgHEffn_1#sn1 zEGDNK$tLphNE~W7L4uf8@ejFd1VDnKFA&pi6qB>F1D>L_n@@F41U1)CI=wBr8;_W4 zS#kJ^ScZP+rn13+|F=NK@&6IX?yRJs$bK-rA3{ee$qpN!6ulS74sAbEg8fbxG@Ht_ zQi#UiQ6R|HhBLA0KvjU~rXm)Nc!jl#r_*>LT=XAN&C6mHLUvw(7If0qWDe8+Eszy0 zjcK*;_9Xx$cw9=M5L__8cc?o%{eC9+F+l63)3){5nbP?`0@>Dhwtib@+0ZY}iQXUz z3hLS{n0XX3?GC&SZJg_0%9Ua$+gY)pP#=L(g)sj-e5VKU^5ydnP|{aI?p-(N&k_|gTn!h zvF8IkBmD1f|Ii~quk48d`Yp2vJVH5xQ2JY&A5&`oXoW+tD4|FCQG^jneIT+jPj%PS z4j2F;bVfjA_-|DPKr%i)k@%z>s9uV5j*D;q4~Fc)NRp`r@)EBsNmamyOh!ozzmI|) zd*~ShIQp@Y2FTQr6Zl_-Y~nHDndsA)hZT6pWKDq|8U%ut@Bzv5+h@GfEk1#^#)iN2=9Eya;TC^IyaRCDIa5onjh za8Xyg=Id!ug8}oy%Lx#kdGlnQ;Ld!cGBq6*0K4^3jRw@$IaV7Y`gnNbMPjvUDme^X zs}+olG*qj-k`R!rr=6CYb~#Ta1d6#_HP@>8xTOI?CjKrYK1Y$7YO?RnB%DZ)5dcW! zJU%wyI}0}^QJ*=Wl?m_xxJsKb2!;(1{=Oz9r7ccU2Jfp`?5M?$z~Dgwd~gu4*yl;I zAs||}X_(7)9fSo#B8~_nLH{0c5c?q}bbY4B!oPB-9wLc^;ZZ6^61Sy7{UrUJ-lG^z zrF&(oCnV<}%@KnS8`k;0eetVyB}xJ%Iswpr<$^E)nQbiD zCs=G#M^ZGbs{#W7^V!C3!X!k(OJqv{C;Ps0%m5P4iX}?!cth(wqwI=fbNt6$&_&d% zqJHEN0GRTX;Y3&PL59E(Xv%gz-H)au=HD>{(TK(*B@P(Y+9j^BJ+fNU1lx?z8CxFk3OAy$}5^kkh95dw?J0s&_6tHe1iwhGSzfcZ&&EFxtwqkt$} zY9ZF^q`z$UE?EhtT}5Je>=F1Zm+0;^vkC9*Lvmap6iph0sjIcu-l0jI001InrKf~= zEQhFElD_c27FGf4JfV2do<{Hi8gX;7tO(2^DajE~ZP!PHwwH;t6Ae}xx~sRxf7B#O z8rlEjk~K_`5f9pN`;L_c5{0#bigf|{N#OIkhT=89Z~}%99W)UACBiv5&cO6YFM;z;Sp2N>@g%Bw^72t;c*8>fyVJ@J<+>d?B!240AT17cS9bZZyuG z>!wg#te&`+ilYgqqL}`9R{FgTFW@pCQjD?~i&oduUd?91Arrz%%cd;H7;uwFM~J&O zp0W(&KIV6#pUh!1&K~2iRb$eY?1#cY%~xCEDmhK=2Y*>~ZKC0?Tqr^4G7wb*9KQfr z9o&ugWQiWGo9LfxLCX_?gM7?eXNSw_W|&Vy2T9~an1vLzf*vwDrP+&wWs{Jg%QiFe>m37j#ECR|vXQsa7V(UmOmL0B&vam5Y~zg1~ghg*2jc>Z3W zp?*F<*!KnpHfyQi%Ubd7z=>78XQ6$rRBOgoh0owkVF=g66nc!X>%j&n~7Yz;L zN&L$<3b6xNONHO1;(889@+oXqs@(qEI38k#IP+b&`6rF&a`@+Kduwp&$?2rNh^yU? ze*T98Ajk?Ru~vF*@=k9Z`$*!~2Dr7VKkNCPk3F4hQr0f#wQF;N*=MG0@tV}JQWyXu z`X+?L*N$*^{}z|>T9k(k2d=yj8pyi(L88@b+^vhT#pLu9saP_;W7uWi-u*$WOxUWX z;cgB83*&GP>D^Cq07XJaxT%P2S%pu<3;t#V9N3k@7TmH{?=VaPUtgUZWgI)d-7RPp z@{+9??TPgK_xiO4BZ(K2W?m_wu%vRaG|&|i-W1Ix-4PY&!~DR8pp*GQ%j1Kis+630 znJQ2sS3g#!ul?KV75{;k0^+@$2nV~ZM>B0C07>_p$HH3gYv9PV@mlWBrz?%`{Wix< z_(%X3K2YJyzVuG8XpPxLddZYvCI^Ipz@4{l8&E`3L5T%av|HWCu>8X`M4rB)f5VNuFHg>6l7@)V89Ec#}NCHuugLut?{2yC`JR@CZy-cHp%SEEr&Pmn$!X@r!E86`$m1JOt zviC}vZ(q1RUPPx|=%3WkbIGVWj4BI_%CpBnbf_~UM2dyP(C=$m#KUOn_#xzueH7tJ zq^A_%%Jtx0DLWH(VnhfN!*Q9Cqr}>yg8bgbv_}+VDg2w#?lWTJfUE4idfV%b%`pvp zo+bN>fKUQtGDXBrlK?)FZFrE~VN$>h3tJSV&P5YAR24tA6+h`LLt{rGlZ2H|_9)?t zJa-$^32y!>JiL)a2evlMja(rj2G^y$*WMBf=@ zGq0Pan`ft6cBET#v;6#(-npd@1~Mwo)9w8;oU=1r=V%N%GRmjO&OO!e&>17@nXmmb z{jxLbD>Fa$>XGz<0_HN_{Fgws)eCJcB8Z%${l11Jb4V28PZ86R_5VvCo6GrdmD50% z+a#UaVv+mNKes(Qx3eR+doH)X{*aJ_5*^V1+IN*`F-(g)m1%!&*73_$)O-`M&-I&M_qYu=M%i{1{fA|ZLO?p{EP$q!U_@Sf=k{Ke!+-z5j?rD;;OKHsxWN3$eONbuDS?hP_)Pm zoY56fTT&4H%VVNvfsSO7ccxSBq#d~w(Z?2bS(H#76>rj&Y*iP$-Y&85FVV{`q3bNh zpQjR%$&tvRWv9>fiz(HuE533B z3Pz9xC;V~`j7<_RG!Rct;@34)NxK$5=Yb`;R%Q^?5T(4A7^wyoR~K%-S6!(VuX#V( zNVh5X^v8-s;wHsI%C@+$T+fcRNQ6%CaB;}q2U@M-V z9eG|O+!UtuvzXY%O3ups>Uu@2+5(FPI9bzk{1yf>(qC}G%p$@C15zb2(mXUViFb7Z zJ6&Ig&aHN%BtxqVVF~?i8K$$EeY8^WeTHf-^w5B~$rFEIlK9#HR}_IwxdK)YBE_E~ z?IGv_r0!j{uV~_{Niq{CAS&ePV+q^`WK(2_>x2lq=UG;(i-=a*%m|yASlhD+DFKk#fHOxP&70cEvL^z)g*XXbO?~bP^X&lJwkf(=$-y ziF7q%tgIxuN@=Ys8~h7xte^^A&2|gb&vG+VyGR!SqI;%n0o@SONSuozajr>dy#6F< z*Aph%V-;I(V)ZeTyBNd=?2cyR-Hzz+FAN%AC0;9uH3!GXD^^p!%j*&=S_VmCQ=No_X0{dm3qORRKr6C+ptVDbvN!4WhKj9N$1GVdnpV z*T{w?REJ-3($63m-HSv)lY~d*1bFCFZp35ASOsBnT?cn<^jIHB-cbL)o_Bjge_hD& z;7{+_G;FU?`kGNt10aW>`Yi%Ihl9moKoATRgdh?YLPBJ)IHBXyW8hJP@tHT{vw7q5 z*5egOyoH-_G~>jo+{C)|#O9lct@!b11i|+2iG!PoL&k60a(IKt2@0Y-I)E_R;Mkx*t-%!aBFFY-{HalZ zkVSr)!)BT@Xqqd3n&;Cr-}qER0}(&dcM#~~p06GM5MbfmP2-dPP zUX~nGnIBN)hms-)K(LX(F|eT=GyskZ5+-`!KN2F`r_+h5A0DyoYQ-lSRq7p*b%!Rp zL8V~iat+)d&--sRbK5WjA_J=zg$%)V}% z<=~l7;vG%0fu?+7)ci*g7u5KEzn(y@kBneJ@o2W0A81|7Y~dNQWN5A#FJ9j1`(RzG z$Njt6=J%D?@Amx#aP3I@_D@5CnMus2p{DyuBc;XH0be#(<^!#Uq8A$@Zht$^&2q3V zCh0A`a9RAbPtQxRoW1??Dt5`fdYPVe*+FlaC#P>Xi1CW}HzIfTF8?>6Ff_%qw5o@u zb45#ES9ZoVTM~_4Z7==VU-?~w7Gg!q>aAeAt;7=7(Dmd9jG-Ok7Ok$(luE13ZmWp_ z^K~432^A}LuC+Hd%P@uaWCBa1R-+WW&{iICGyhrU-8II$RuK8ROOArr(vZa4dafny z)tZH|@ufljjbxrxDBntd&<6GM<>nApoHuJvZq^U6)--rFMRhm7yRR!JtflnAbQOlY z3(^(uHi=2LRP@(5>^7kZf8;RUbkCVLgx!h}`cRv^vcxCLVftH#u7A8dmR8^YiTjW{ zDZTxfVB;gx)=!)54E<41&Gy^Mt@-hst=nx0`fa$t+GAcJQOojsKoB*L}!gPWUU#eB^L-K=@*YxSq95UMNfEXvgEwY3|_K zV|P#i&4giLS^m_&vdb_r&y4w7f>*yq@cF3a)3II8ZlC4f_qxY+9v?XWrqc(LbN|g* zPpGy?I1=MME}Z|v)m>EbWRXSo^fKs#Bbg)?Ju3d;BvgM^{_}4>3`#fnSYGxFVR53G zct$xzx&$LEJ;VpW2h9%7lE0ob?42wopd3E0Ke;<~Bsjn!>%B?3SN90!CP}w@aTqNNteEl8f81c8<=)*<4UW?K5Bjk&7j8g3d zK%509+C^-a3Lfg%9{R@qicd|DM*QQ{2p)v>MGw}OJEMA?{1c44x3zB zYaf-T3S43fm+dDJWnw0Y4k!PPecQGmxyd^?O^&*i@t6%>zD`WI17j86Yji~bv2NGl z%8PTYCs&{scY(IY_X1fFfCa|?FM+JjX_;CfoYrtvH3oz+ZIPOSsU`lMtxONgX}?@{UgNHDk80Qhji?43%t#heeA#fAD6&FLvumuUzlDF~J2cixtEb zzkC`AQ>ZKEce^wNgM-83YvE>{StI?R`?6@|pS7v4ZTSlGD}h^LYV3=T`6)lVWcf0Bic2D;a2>^LX=xYL z6XUnLFL${bmRQs>*7c~DfZN+c3fm&*y;SS*0wmLia>Rqn6U2pTIuOa;{7g*sG^yk} zdDDvzbmcl+&7-g%x=4Im$h2g(NZHgUn6${Qa>hXj4uuW5b(Lx{3V$X1Gm+|{=COX~ zR9m_J^AT>`bY&NL{ty!*HZ~`1<53}5T^?p9A+3u1=rWTbC`&ESB&%z=e)NSl<~V6w zP>`MrGqp9y@lqOpPWEM;+B-Lj5^;9DZ9R5}*h)IxoDe5AISOTVB*o2KLq3?I)~8$P zf#qO0wt+ckvAI*7Dd6vHjshDSd`dS94YjG@&J|OWn6vjc`e@-)7$ITlQdvGT7g_T~ z!pgm^{NwjWEB@3R_Qc$wgdX4AYYJUOsv}u^mdnq}ow3oyI4@n%ti=I;#~%atBW~)r zba?YLwxRo9ewkCFf2LVPvP4Qfb*oQre;U_#_A%S9gzDm{-$Jrl#%sBA^C!;OMfY(D z6Me3YV4Py){i6#MMK4dF?Z1&_XhyfmD34%sE*_n%a4t<$mvJeNV;)Q^FN~CNt*)%- z#JIk%AEb9NjvT&Ul>Lm;wfkD3qbv(C*g;QLc8ge}bML_qbm7f0kI4OSpP3_fZiwmn z+fx`*<{AirqjQ6Mv`_+}1d4KASk!)bVEDhQD6at;-!1QOR0A6Oo1!Ee{glSTPd?ut z(J*Cb7ASps^~*L&{`H(w<)_yRT8XOZ3%-9o`7XPYs%NW=E#*UJH2%T>;r6Rfukb;K z&$1VWj|NgrYF!ip_n#}-pZh|j5P88Z(r~ZCFAoc0ARnOzc%=7n+MDBVG_c$8DHV~i zQRXiu6?(4-eyEC^e!k<^Fx2jh5*0`$@+)#>Rsj064#mPqZtQsBS-m_4eTgp4B^df^ zUYNtk_j~SN83>=9Q_}Y9%a=z{f()=hcumTb6O-ZM-L@5I6OOwGC{ots5%5!tWgBlQ zsvn;KN&zB$B+br@Cv6xjC&GhWS4#D{*i zPykIEsJoGRp$9l*uCPGt$RQ|52$Ep$#EgZ93Y_UBunu=kWyP$sg}m)A)>{$D?3^oC z7I;vqg(aHR+o36+Qxot{ih zpF~!2sG=NJB3&R9!8zTXv3a~h@nmV_mw0b!*sqPj!eQ# z&VDzt15erRB~k`glsdOtB6boAf34J@$3)AW2D2IlP}+sq)E`T+YMTuSk}DBwdJn|54Y6f>9$gOGitZ0~Kg?u!wFJezYA473 zB3z6AL*y^{IR8{7ru}@SqxP?>V*kp*sJxgd2;=FRUE1qpPPJ>aiE2dx zCWz;SjELsZDi;5Wvd&K|`g>!|4ygwsGGIXtp^1*@A0yXlXX)i`(`*i^qXChv{@+)Y zJZ>((D-)e*b>FY=(q8=n7T-7g<(q%nWm!GU>@FMK7=vy5y-zz1WNG6<$Tt^2wO}*B6VG)Kwo%iOtIWE~jZGPLnxuV(jCk zm(4e)P^{A=RtUeJ);yEuQ6MH?-fytM^81w+1HWd zN}t)iawvcp!EN%!_79_~8|N+ktNb#&s+6jw%GpJqnZ{p5V@3XJGxK=7WwCAe)|z2d z;HTbke@x;wXcm{Vo_sIq@68VNxxZm0iFx!_OPvd6oH);d(nT}vr`czzxJv+;9tX?=AR_BI>iPo2|^^1rV!*0 zsm}bnG%g4h%1L$AFy0XTO0EP$u)R@x`JE6Gh0Y9I{Zw228c?Bp?gR%!c#u>O1X144 z1|{wANG@|_ASOCgTr;{Gzz%MPuC5UrF-RN}DijAuKu(1Pc;$n@~3y)_t6mZ50H=w$)l*ju)fZg3J^S<=UOVmr1&x$FiqqTT~|BI=+erq!9 z+WowpgYPGL4ZQsqDo|PA~_(S2)K|XI=_2je_mYQMSdR~{j)u- zJOMG}gA}3HW|aAUBq<0^4wr8+0I~TA?FZLB`q^NLhe}h7<5IFnU}dy%TXfaq)zbHY z`IFuR_F`(IkPNzTz$QW_2O4dPDVy_o8k`+HU8&iHb(JTwe0aD5iIZ zzHR#ejTngpz|q*7>NZG{X)>Nx6Ob1;y0%2B@UExRt@r+N5WTE-XFpjBidAQaWa>rw z?XWf+=AcIEPw~psH4`+XWvDb2wFkQ_?qzii34O)8@6%e09EK~!m4PC?j%7;Is7|3o zsj<>w&g0e{c&r^Lx;?Qsc?8MvM0)Kq+W*E&z7%J$84zLQIPStE%N92V0oVu zkN3s%5(IG(IykCe5gN$=;INNJJ?0+`J4=6j&7!jTVZf#&BVzu^EWq=k!nBB!4BZ6@ z=b(wW)P)wPCTPYQgLBpK7*pMqlgHn~MZQF?z4tYPrCB5fpfHWSpRZFPh^x@!kB7sd zPx~Vg+QFwJ9jHd>oF&62;gubGR7gEUd1`=FZKOM)%<>hylk9Ok-r_F(abW|xQQgSshDy| zBs0WbnH8Ot)|!g~**#6*ydb7PI|Bd&v}qu$JBHfZhT6NkY9e)GqaQWk2J!T}aXp$? zpTpip>_P&UKdhKdeD&9S%aIcy5qF_jhZ%?A-W%fs0bM&xL2j6?9CZGKX-_6-rxa+* z)@sYSZuqsHTF! z19akjbo)3o$}@sT|4l$9=bW(C9Nh~z7HUpX3(d55PI_TZ=Et1ukbxouLymkN#yT%A zI{&f?{L}BMHFh zMw^B(UQ8|BC>z}cSP=14P$xeBdP z+<2aB37fb*IolQ88|dQK!D2Y9fL9kCg^^gAx#=#yVG zNLr7{RYvuD7>Gtcj^s9$W)@wtE6&yhzTFfHfNw~+n}5lIV_WJDp9_q6^C}~#A_-guV{I^m0ew-MC^uii+Eg|+BC^(e__!b)&JAi$#rPCu;($e?PXr+sok&0oFb zG53a5akM#uN(E?n~%qv(cTK;4mkgD0XbxC)TPwO5?bfhSUYT}EBamPw!BJhb__s|@jV+k z-azcC3CL-j_a=s2lX&jgHvg#>tM<0wR;Zx^Z;r%040oBu-m5I`NblKq|F&0H98jN3dEzYrT5;q{fRzQp z)bM8AinV|(+dSZ&jrI@QtTDS}O_L2`$`0khuUHCZTl}?&x$agC;*OaGCSDXy-W9e! z&wc`comA%7CTxlM3F<)`PO&Z0Dprmmo_3+vmcKocy{gtY5@pugwGdF7$CI^$pvgWr zJbM8w8zJTWq9dU)lGx`-t@nxYPO{OZ4tR;5_Jb$)Wj6L@PhGmZ$^kpEIwNJtQ7&}N z@Aa+lGOb*%++6JtY^379=?Pe~0=|4|~OgKWnq3;tk{dZ7^+unT{0WNp<1U!9+gdn3h#LwDWth z6jKk)UvZ6(LY$6HStm3Q>Obu8UaP*7nobT8$I?5)dKg-Zjd?!i8Q-_JSwpcopzLmw zSJ5xbdPR==@+SJ=U!s%?8cvrf8kHkit9#Mjo@B;P1m7_d>tuRy>(O=7ZcgaL!VF0o zR}big6A@11QM;`)oB)T(CSz=;v?tcZP*EYRtB%J+r9jdoAUhnRr%&R?JE=WS&;E$h zjUf;Gj+ckpR_d!SHE>R)TQEd!&?{?4cwMv|tJqffb~1Q%j2FZb3@EYI=0d?sanx(e`hpOXIS?L~~c(tWq4mm|d` z>U&mn%J8!_)MYOm%Yo@TI1rQ@-l3M6K)`B!u}|UtyW%AWgZCrn2+BtwK;-8p>-DVjj6>zpF2ht0df-V)$W)9VFa z=}2MM_J0p`ii2{EULYnQ@B{?RtE-16SJ9lQPATenQn@~W89zb+bW zexC;X7W{Ups&ehX4wB0qWT1iIeA^-jac=hR`Wfjc1bq&vv!20Xqs^(M3ay;!aGK*ms_)SyJ6xcF307kRZ!x0i)T`Q)0b}M$-Une`G=%nng=t<0uX`_B*iAM zlnR}y2?)K8lY^tNKyhjQ$R<1{Ri`yJTQz3?iOUHJGQK{i_}(D#3u>_TTYJj(xmUb? zHA^l8ij>;wIT&S&K@t4@%m|92fS{XD>Q*jT*JR`ja5Lu zH6x-%vm;Pb*P2sTQ4t}w5hk&rz*y`TsAwlI@3^@7WfFEdmXP{H(A3cxR=wXAp zL_$?Jjz{jhVqJ_TUHoXq+ecjl{4qG_&ns*Y8W5X=$K?#tAB9UPq_|Ho-xh)Q_|J_4 zK-d22fl&5tF@;Gr5nq96jY6GTHkFG=zfIMbRl$hFcDC*X*g+{v!sFtY6TIG(36hS` z(Dkl@mjG|$_U(CM63exUl*!?SoG<|*5$_YOQsc%ZyDw?HZXG5piZ)X%9!J-_YhAvp zlecXLnN9CQ#+VY?{xojbv~gt$VNo@~9|saffo30W1b0W$(DIpBC=21}I~Xofy1K&7 zQy5yj9I9rJ{YlKel%}2AD^yU6^IU_+U5C3{yZ7bk$=&m_&HnICw*c;E-CJM1zO{7R zzxNJW5P;EQ|LcYyt$3)YfBGkNbGF^+X25Du1jmWO0GH_M%7p$2*$2@rLVNFT|I9Ud zea?&4!D-K!7e=EAM(Gg2=BAVxP6iEBM7GLi`CaByrzPu0`n8du=PLhv^07z1N8Ujz2zI9Qgyq0Nfc6 z1{@l=UF|HVso4a@Uj%{oQPJ10oZqQrUs@IT6w`}?nY5I^jr~$wZ2dP@(k-;et z_FbD4@ybo$R2fIIBxip8_3w&`mVQO&3XAT;Lk&ZH94z?Ty|S|Up=V{NT&@K!u()y3 zd9_YSgQ1R4zQ27PV629kyTjo6_GKr<*5OJ1as@~Id&mO~Pkc&@`Ej~l46bJ(O1bt( zeifcJF1!9Rl&$kuxBvEMAgxG43;ExWhJK064}56@$}he1Gp)WF^x?a@Lb^fi_ITVs zKjxn&pczQdz*<np7WohyJ3*1oAn!no3r}geN5o%E~5X?(T)BVR!`k;`uz{BD1id z43Rmqa|125>9aYJ1tas5R!tMP9?@@>cla68=tJYP4L>K73?{5r$6HrC{MO$JmlW&- z&T7o@9!k_L%}%a|e<*DK9*MUhwgk=o$2Cq+>QYjAq8{d({%6__uL7;6V0xG_p<72d z-vRya50*T9iLb?Y;}^Xwqda1t4iO;tK_Ib4Nc_(@rmM*IhUrLF0>{&?=cQx@e@81q z#U)RGS@~hGDygd5?Yg;wI&slC5Am+x?D}FwiWb$H*<}Ku6x%9nk z$K)7pb5o1X@h7dvJ32pHDT2PI;3Za8irgj|-Hv(cr@R^dus2Co9xoXl$|(Ex+DEJ# zTi?a5iT349my!?en}c9Eyq=%^%-i62LY8%WcB6r#<;HlXgD)bxk`5lUuIPCOc@xi>~0qWc?Ik~oa12`3bgE@Gl|Aj` zR1sA%p=N?d(V2tIgN6f_x(KugFI8ELdfz9i7bGWUSlMM`?+ExbH6cVV2zg%6WK01_;&l%46QOuiS zv)Yrd{!N)u^FiUxILgn@;F|p=Dxk%zZU(4-$c`q3?SCwj^cWd`BCW{ocn%bdX1~a> zU6xY`yT&`HOKMRs7(bt|*RCGX<~~KI3Th)~Q(_|2_V-QEnphxNb>;iPXr!+b;JQ=R zZ9v!mIDmu{Sig_}&LDF5=}dWd>$XFrlf;^htqbR0bc%zQ>iz0TS-!9Z@9XtYV3Y%A zC_m%heuE5WH0omhXkq&>l1y<_`UjVjun`T{r*04ne-j9!X~y8zwYP$4sp8JfKqt8P z>sTFmj_%GrfzQ9pr6O2!{#w)t7QGLlp0tuf2_|Hvx!@~-tvQf~Z**ChS^daF zvL|kSsve55$X}P8!AWEX@ zB3a!k+k~zDtXs=JDbalUM~n;@C`?(fVqNGgk(CP~-|k<7HR*d-EU7c!&ti|dO>%B7 zc5|Neo%Z_lSxvE}*HQE>XM+;&!aUdyF}|#3d3W~J9>qjSHJ0+Vc@LBiyhuxLzR$tR zrNeWvFz90ccwHl}`RC-_@BHpo^;`kyg!^T%1l&Hujcf8nqI*EQYSh0JiCw#cx ze#zTWPa>0mN!ePbfay@QC+P*t4hv_eT)H*XCe2a_U816-l8c+cHDVZ1XJzwK=vY~x zJPO-5nDw!uzPrSF@SQH`Ir^-m5Q~cy-c@oNKZo=Rh z{fVSRW#xwgVQ}qsUxL$87yIT2kUC~OMNLKQ)TmREMAUMbKilLN)0UL!<3H^~?_64% zmb_Tym3L1^FC@9XeB2u2>(X@EZfW=ylYA^b;;J>zpG1yqq1xL z%hBJVDFd9Eh3X^U?=ubl4JndS6#T(2k(XXDqQZpnlo*O*8iJ!_rlADVOh$DvSZ8oH zPbM-`BzpuCM@-4n2MF7KGIKa8O1K*AxNsG?_vJ;JN_Zwqs6_ghYzBDtn7DBV1YP9C z_U$;7`*{G&f)u5K&zObSO8H0-LSm)Dvdkh}I|2|O-(-oj!?05o7OX7B1%J?WT9wUe z$0bAA*aZqMV3t&mBxqok>L``^R0>$K;ho=(*(jC5Lg%JKif)$5t=N!~Me;B0 zU}5yqxeUm$?aFv6uyDwhMV7EMX_xI92~}QxDFH5AQu@N1AvAvAfG;{ zAb3L(ql>dMOy`wTRj2H>|XG-yG@C{Ww4GB&%U^Myn$lGZcru2X$qC7>{CYL@h zuL}8-tORDGxKAEQux0?OlLrVu0jhvi`Vp}J106ugp8zv0EyrO))~~u`UXG4yf(h?H zfFcmQNCdY8oKOtz1E@lZ3@b|T8BY!#%OX>rNbFp#B`81~W-XM+c>E(_8hxY+JsOAY z{A%flQOAJMX^?R{$d>WjE4JH6CxipS@+wMh7Yw7OO}kXe!0q+W4vVmrK@o3xs&)g(Ci$$BufZ429?|+FXfDnNP8CK} z_UZ!?JyQ|t903m`_of_6mK33$F6X%%J(h(>{x09c_tl{ToSS;W z=fw;9o2riASH;{uRvxh=9}1*6&oCyN4GOm-q~9635d_KP44aYJYv1Y=PtH^(qnwDeuB~~9?7|WX zCoee@T1K@Q5CTr?tUsgWg7c*&BaS=u}a1sNZ710KGQR|Up zkr)Es5>npbzITq=IA~1B^FKYfY|;&>p+h}s?9&XL%C&&DY|Pt1dLWWDGfpmtjW09K z7XduY`Q9pDyQ??fqWgFx4O=Vd-A`)J?u=PZ@2_lPQ(PuicwaNZPbD8GI7ma**Zo3K zYFeJVPT~79=SN`mM+6?mRz=7yXV(_D_Oi>KQZ?)hoo~OtHzv`wgiV2?lGwILYoy}v z&B34g(O_HmB6ZT}c4r*4Bj<~#k+izL8zeQLk6u7gYD7M`#a*kbZo!Bh-O@e8j4ps_ zyK#%h@!;5NMR6+29b?@&Lf#`qyROq}F@BmmHf`YwMY)hwxgdY=nFK=)fc{=gFJ=va zHCsH0@c6jmu94y)l$z-oVYae(V3tO!`5Rqu4fr(H6~ApUJR3DTNpGQt@x5Zsa?5y= zu-dD|W9ymccHkqPXcC~1cTl2AeO-)CQ~I=BhPP4E^NaE6S05h3SMHZe)mtlw<}}c= z`95iZs0=}<_4N!Jc#T}rGnEyhzIgGcSTXPks-fwH z$wwj246C=pc{dV%Dycbt;mxuV^-6GR_-r*JxYSTk*NeU6s5L(z7}xJ@5;LUB6RYPB2%!mvaoxR{4+IQZKnuhUV4*b8rF4xr2@F+mBNAiZ~>}M`oQ5#T@ zJZu{l-}cD$;}iGCuimhnaV!J;xmm*()s3&{n_>?g#Nzr9SUvzUC~O>x4b6{D+29QR ziI?bwzuL5ZZUkVr)>As!_|fEb;;qf6_}oQ4e0EUU|2%hJ5TZdmYG3$vp_*QE($k@uDaxf=;H1j^gXBCb zo+}&PAfwMkYDf#y>$A(2a#$JC+ezoC5mvWeD50ap(Abu?R*08`yn?`vV5%Ic!?yJ7PK5e>?C19$i^;MF;04si$q0etIL8ty1f z*GE4R^OU~`p&_x0K%ruu;CD(-0A|@)!Y-U(e4y_ivBjj%*u}50mW@|v!dU#jG?rUC zw}tZw73Ba5f^=ow)b%1*2L8WsF+|#cn6!8dK=iq0VVV!Z3hd+7;rR;RX#c(v zo+rMV#O)PL0)lDr&jJ;6zBKS_aOhl;j_QhbP1hOyVlbx6<6v$A1P`!H7xV>t31$d< zeQ~M%*-swe0;mYPeN;h3Zy!O#Z zAP#YcJ6^yRpe+|*t#YMj>&~4{*W(cQxr6R`6GG>chUFH6wL*vMPuC->z#>KrHx;9l zD+RtT;1ER6BU|+KyY{92y7MGGIahVBv4+3&?E)j_odUIXQyG5ABEEMAIqGzt6;pnl z{tfN}II2yOT( zD~?TyLyb~FAU$k+pu@_e^N+`u)D5G613LWUejB_`o48Il__L*8yDmIjK%7FS>NJvV ziF~BvAh7R`PI`w2vdDy!BpQz|u}+aH#1^)8LzT5fT~Q3!?}7qe8K(f~$sXUQq635H z6}UAO=s9{pWw#hD_{9|uEohns1}Sd91cJ-L75z+!&M(pDvF z5y>)@5IaRl3lXexYsm`d5Prj9M;m*WFlDj8QfL_S^AhE%ba4d>bZ+q)IbEbEepi7% zM4F?EoaXr}&*zGv9$#ce44QXCf2(L5#zJo-Uk_r}a1Tnrf!__I{Fq;?wg4hi$3%{7(jMzhWf%(@NIbS+BK;6pBJ*$v4!?vG$M(>Aqe_ zGVur|?NSm^;2V!x;l0lluqsf#L)!Zexd|nz;2Tv)N3Yzucm?WU5ZyfV<7}FAn=4B1 z%h$g;7;SAC!xj$oG8{Ho9G+{|dV(5rTCnH^IXJ-npF(L=x<1YYPZ$l(jD=}EnU8~F z-NMoXi17do>CjT?1r6hlWgb<>f3}GjBGZW6T>yTaygX)Hpe-;+?|$mhce<6&Ggc@_ z<7&J~=66k$xJ$nY@-5?hxK7xNWPba+f@spt_koX>h9PKPcP`s)Qew7F0GzaP&lI`44ce zdCtuZp2ow31jlp`)Y<}C}3<)2nVdw8J_vYUlIIF&s z!>qEy$>7k9lTGZf7%|u!j}s}vjY}{*)Js%pe%6Ei^--Hl;{{_f2AIo+jUQCg+fOy&=y zvR78qRp{lH?SdoM*?3OXTI^I0>9Y0P)P~=S;ow69tiVTxB5P5 zV03_(k}g$_Bpw$G1?#a0u%W*<{|d#_;8B&%xqig?L3hk%NL0#UD6W{hs>?&dOm1H@ zHA0wLb~?x!YUk6;cAh?4KCfGLIGkO~vK0^R7>I z*pH z8s%(toRSnsL<5@Rh#Gmjeuc8$m5$L3i^tW7iSv-5oR-Y4|CH8-TYM_mhC_4S+qAgc z{DwZ1N3iu(mIoG~VdnVDs(bzJUl7|r zTi1#R^$F7ZLQq@y;Hqx<%{+~@AnE3Dc{oe6U^!o^FY+z_?_;%J)Bc8u*_Z9v6#5Yd zXOeuJw0d=vkazC>eNkB+eAe2Ar@5=oUhhP!NQG7Q3O$d``Q@4JH!3P1C}s=?l6H?M zOS44v{QJ=ug!y;<;o*7uFD)*l5N#3w#38XWw?O{5$Zgwjjp9f@dY{rQ2 z-aoLef&2DYnYa>5_h3vsO{s6oQc->QIllPW_OMMHQs`r|GW|AOtS(pyZFvh**^HSC z(>t1Mx|zd&4hOFWs>&4tLR)NlWEx!AM3eJ8Ped4&>3PPCXuO+Yc@xGmz$Br@2AoaH z4x_;rtya~}8cbK2FNMp$mmXFXk}y&&132`e8C(ozDQ>~>%TOa$$s+(w=&HbaITEMr zE8~i{y{{b@9r3Xj^TV2&Nc=WJ)=EE*naOsn`+)DIS$e?_k)KZjnRY-!df|!xPpK_x zomZ3T@2=W@%ADuwgzu3ujS2Jtb(`?xmr8+z=j_mIn6}2y2>XzP3zS%X8mao*56_ZV z!TRrXly(~si&FuM0sxe+8!ZtQa)=e7nMtNlB%m;bW6pzxI*! zB-9itT4#wji$x7Cqr}^MY0X?hwJ=oKjEv@iP5WS>neO0In{FK}B>)P-n9%@CBbK!# zW~pt9dCR#J`cM}0MZ2;l>;v9y_c7f9R;A9iD-T6iUF4X0rFQ-s9iLaBVD~3q$luh> zh){qK&1DB57{Y7b`eFTaQLNcW7+=1BY<>S(XUPxCaS!XLXGf@xnuFbu2GR`GvE>xQUVvtTmL zEEdwm6rdUSBgI5<*W?-Xh?=9;Le3}^9fV~U|2`EUSOz zee1ctYK)|Jwxoq{?}R zF`?zb!M4d;lP~J@{FiShYXcv@TN!q19*@MzDa#p2y;{%tEH&8aVJ2)dn0K;Ge){bG zk74ffxnKZI**n`~nI9X0q@w#ah|gP5#8M*`h(zH9_jE1M4=DLD))Ij5goK%+@unfL z1B1~G8>@p!A8+z{Gf9|)y;y16K}bs)%V$AHYE@)Foo&e7U@DPaETcpVgN;)+aZFS# z$8cmuH47=0wFH*PjY8@M1E>86__C*cwPduJ+8xwYJ+U0EJb>goAtJ_6KSG{MDr$(~ zL`qD{ZtVNw2(0g>@9DUSu{x%Cg><@D_(_`C`}&AwI?EqM_3IQR#mDN1wb`VNOT-Rm z>^r}uSaPw*TqNT(3z&Uew8!GYyy5c>X)$NVn@O`OfNn6ODy&ce++yuGvXK<(a`biDFf|bRif(b1ODDC06fE zQrAmK%)>p}Z~460$1rB^tifAJbGmR=Op$jOcq5FC72t0{EYS_$#(&Gf?r@>}YcJZ{ zj@$X0&=5ZnM{8m>lLPl;x$V5Ra5mY1_6#;Xf&SbVfcMY|3CJVCAK#JbD6SGWaY%k$z3wO*c-avL$jHJQRxf%Nkpdftz z`gqzCg9)~-l-r=q(SN+qExy_Ynq>hgzRO*rSQd$s50l~3oCo-2f;11H->-cBT9D%M zR+J{)D#bPqb+DMQ_X7bv5oEy70)ROXG(8@*`+9c~f|gI%=`gRmSy zHIBl1J_4iZt4Bic8Q)~-$yK;Ok*LJN2bVuxWHdvsamQ8IR%}^;l5zNGrjc@r`;g!9 z+Y|?z#o$L+a33Shd7SF~7wq(rL5#GfC{+ntEXyjHMvJ#j+=g+dgtPcAVbun~rZ8d} zN>VIO1jV6v#@#W797Qfcf`3}!1BbH`&w4}j8tsUr;`vZRh9X$QQ~^d+g=5(^pysxl ze7NhJFV?T8H2=YXp4s`!=oP;W$QJX?*XUEOmOBBWO&(z5of58zRE_1)W%_sXTv`4k z73917sv|hXZK+Ra)Y_^xEFqma}25EVdW|ddcR1a!+_wd&Bw|0 zzIr4MA!8={wnXMX{g=)uBqrj7$7O;CL8LjolZSzZE!vwp^#+cPB|I`B;o_6v@s!2J zAfIB&&(-yV87Q5J#0lr2&G>unQljbhD)&D{4^o)L8AXdE)y(uOdM-;reRMNX*<%SW z9iACeq08~lzIBh{$gCW#W>*QBPQRXyXjH3KPuFWK(Ld*^5UF_mRFrCo@F-M+?Hj%6 zrmLqYdzRZ&0f=#4NCK0R%?XgH#`kA;GbL8K6&6{`?JOcRce4DhYRvHZ2`%H8XrXTi zt!b4PCU~xEvNKg}aaxGtL54U9V?@apIA>U3IZmZL0?6pD`J*0;7F?H;8? z1j_%_^y;pfEYNs14X^OPZu=5ESd2R&m%nVFY_&h`inSVS@j8a%^%NyX(UmM=yKtiu z*~RsjP8J>?anUkt>YG%8NIYQ)TS+H&dvq;S_2%!~tjf`@KlV8Cs%@v@_?p^R8(e7` zJl9JqMnr$w4c7`kuQeC1?u0C$hF)jCqWNJ5qzU59!KzV!w@@z3*TfrUqz;#WNiFrqb_&Yd&(tNh^C4?j}ut zls3q)1RWB@5Q?G0y5XV%!5INz#1V!HE;rDb#QgEC3n7VmL5hO7qxK}d;L%5XTuAwg zYG4#~T?xyT%P<>cEQ94&TaB~!$s4tP0=Fo8vWcFHz**w&yO={$9QlGt=!M^-#eT93 z*;K2d%^T{H+1EiMMMhb)oYZwfrn@9?WEFi3es>Il-E9U9FACycwi&aOY@DQN)pM}F zjbUFGS1O@RB4NO=Nix(^DJ2%&yDX#TEejND)bVgVn=hyO>Mg2K1xE0MIre@5h-&zT zuUP7sTYS>Kf*R8&lN5`yJv{)kHTWE*iH1UP*d_x@C@zivZu>GDo7xjG5V6rUpOWGU45T;@B8lP^eDEb`nvT?Vx zWaE*3FNXNwYPN=pSxt|Fe6~>`%_aaDhb6?G|Bh4!0PmOsoH#tc8(-A?gfvv3xX%gE za>Fkx( z;L36sL|M|YOh2h-Zi_(-!SVDDy2r)65DWnjE}7zWTW1d!xEBqh%!UHk7k=_H8Izal z@n(@K_9A=gevkVzWxMyMi>>B(&oG7CrKwNXom2l#L#=PO_AwrLzxss#G9MuOuJif! z+tkB#D+BTA+t2qsjkry;Ea-=^qcHFp0ov2v8nf^912+7BAi*XO$OwOY9>j452gd;` zn()a?BPoI-$*6Er;gRGwxEWyl;oe9laRiGgf-M-qF%mfdAjmkw>4zhl;2_2vgor6p zEEp+nibSR$rI(N#aiD7xFtsl7mjIZ2IuPgs$f+d2)&;9`05m!1DA@rzRMGF}Uj5Dh zPebrbO(Ay}MBTkO`DHBdZ*GniHeIAqrb;BFPn&0(P>h)v;8_e1h3(%Yh^ z`#(7v9h*vTcL_>Rc-s_Wj&WSdl&rjEG1ZR-B;vj3|9a6SAz%*(I8{78lj?uQfEPO; zS2e!iXKWxbQNBP7Ynes+wO&m&TOB*!8xZv~0I)qcu_Gt3t1A&A0Pem?{79A5E1uME zn$+uJMtzRYb_RH&2!Ln+VDW#fp8p{Py`-~CN#$Ksmc)d`Ha5CtgvPM}nCA)FB#Ek| zqB%ZT*}=sA;I}~|v3v5#=G#8sgNHo`N~GJSeuYE3MKAU@c2`jk3HSe*jPaI zuw`wqJ`xiapzstPl~UMA(kulW&U}l0N%{>I~yPwfH0N?Yej&V3U4owik zMk}xOEGk|lPE8Hg_@|ER6 zs=@rvYARcgxk@DxPh?F2d4}vCDD$QbsCKjP>@Sg08=>(R!t+-}j8TO*?~CXM3-A9H zZAln$8>*qwWy1I0P=E7jL%p43q5h{!kRw2VUlXT~qn0Vc$NY+?{RQ}eQ{Y3q93~Cw z6Lo>*l2Mri81>u{=LhW>0H4q#SY3>sxV6}if?vg64CrN^b)0 z757yD?kFVXs4EV0Cmokl|NW@QW3K>yTB+ZBsr1X7R^dFHm*C$hoElZ~&o&_W7!nI_ zpdQ@qk1^4xZa5iDX=G=vKr6?>PS!gSV#AvJKr?cSLw#&ULKMKrL=YVWg&mXdGi|K{2Xbk0eEk!A zw~3E}hu9C4F&$8e)TsK)ljfPRhTeKXX#xqi@LN)BSy||{buk>d0J|J`h?mtZE9o@d zwXQj}3h!&zZ`{~J!2h85gVWUjCVCPuphe7X0mV%FCxo|8(wEC4=OuVn{q1}RYVm2l zqM4{=6W^PKUUd_F9$;g?jO#jBM}Am$Rc=hFPJfb@>HVJAl3Kg8*ZIm`NGlU({7QC0 zva(*NRN#x8>#L@^zUrPD4}uxOYVkTj>NU!>etS(N@+>*S-Lq{*ES_eko?od@9M4pSgd)_i`zBb zCMx+dD8a6&ugkQCIJMRWrr%yvRn=t;vDHxj^s(;DM3S>JQynxkG#eZm zWinncV1t6x{#AgDFtN9Nn?M%i?ucoDn^N?smZg~xHSMVuiH7U#e564pi~`s<1$~1w zlO_Zc^rvH9N`m$KKCSjV-1X4(u@YsoO({LC&y7KetbAcYlh;f__nL!=#KTe~8vtC1 zTIFfl+GSL~8bS*8u}q&?L+O}9C5%{2nq*y9YoNt8^>4{9#tb96T1^u67vo%%?r#Za zhM2bu$3mDQItcQ>DIvE3&UDr3FOA%II?dgQz3IM`c$<@-f2u=sb$`rj>8_y&y^nkL zis!Yveq`9&M|08zZ`^GT0R1Lliwl4N1E_jQKBE96;Fmh%Uw|`DoW>U}KgzfGO>d=4 z)9c#*nSac-Af4{TjlHSY;|9k-zLwDe2mzlr)4rzM8;=U){QiyzWXW`^ zZ>Y*TY`Shf8|#EC5HHlDpwDZSBs+g96bzvC*1nepGk^iUkDIl%aEv|&u;B-sDv8XD zTLA*J*|DUz?7=i7{}5QZ(@jmfGittM&KW*Q3sH35G2urK`>L}$+f5)4&Kib(I(DAWG^C= zrqC+;l$vL6>pJB6?8%I1cfHeXc}x9QXB0nR==tBEjR8iXC+N^ zyji`gTV*Q#RxL9&lSK0LG(9*$Htb=)I6nQgXRY+{jk*5%Iw6d(bb9r(N6$pt3J-F= z)zU9yjO?E`ev5909{EOlIPqNyJ|KJ#$$MxI#v*r_)VA{rC1m7p7aZ}V+uERGO zU>iec>pis`vgh9uX*YqB8zYue+XQ6O-nb|YV*<}s)|r}d{Hd1R?~P%>%Ws@cPF|t3 z$Ug~vd8@ZVdA>mB5j=CX;_lwSd%AW|J};?+y#`E}N3>)$T)&WqR8y882C|z5?&V6nOWUuy z&uTpXXpzHT?q7;-$H@#P*0ngI&APfY05^ZO;Iw60RU!!1sKS2aYm@H+Z~=2aQ152R zPRXs0gOKcL1f)wTvfvu4mt=S)4ass%@5muh?*Mtw!zP?>XU9sviRJ~c+|Q1w{fT;e zrBi_g7Ao9>9i-J56WTt)&z&m;eOqB;2P;ViR;nEvfExA!Yd{0B(21Lfw@ zJLE+?=MiBtpKAp| z-J<~_TM@gcn2 z`^&)S>%BSY^+@_Yu`5XOzHdXM{_$6_TF-^fnZ(i;bStF zX`nG`N41%-&Ks{!Zk>wQ<749)fDyV0MPL#<={*8l0{*!4|IvGx`d>e?Sq-|JF~B3J z@$6bFno3mCSaB9hG2I#ZrP0K4MB+TDG-H|Z_;73n82S=q@DO*Hge5w0_Z5y`l?~vW z<(Q#nQLe2A^9cNEt2emhZidMMu!Q+;Bc9K8_1icW2#0r2Swdyq%on~f=)yJxG+$d{ z*=O=4f)+Dy&(}CD|JVo>-nO~gG>g=W#Yl^|?z&EP^>1^g}|rl!xG{+ zmze;RA8eizmG$?2vHnK+_(x)OcY?*PJb_YYui)IrdmCs?`E8BdPj#XS0>qMbG~ihAtJu_fgEJ$tkt@sxGB>wK7g@r_mNVJ0k9NtQi8NluraRr9 z+hWKz(Nt#Nw%sZazPz6~>)Ygw@=u1~3(g8OLv-jy6j(x~T0RqJyLpTzou)?T zVCca6pyk^ylbV_6@daB#{UuoGFXZX;ODglm)zzai{9DTec0%<(lMv+zYa_22_fjQ* zAV@4v#kM|A_2RtWBg#W4a!)93HiJh;Vp*DaQZc?PWAa{gg=k8XpLL|jl`9@S24I6C zsE{XW+s_6MNl6Kd#;~DylEw+a87iW`-KN zyL;${p+P#N;SUIilyr#Tz|h?d4&69(NOud;AUcH73W$h`@^IhJ^L}~1opnB(wa!`R ztbO)x@9X-7@PePD$bNkqsf`(SWyDcs?r{$581LGM<4Zkaw)P&L+>B(h9#52n|1h74 zsGsH>^5Qt(R7~0@q;U<`{lCpfXms`KRO@>xkPLz~#tMX?_h>p-ZJr_D)mY zt1a$W!>j94th{&6VfEXuZG*C3vi;6-x9LrfG&zuDbH7}pDQ-0te8*{|{}dbeL_THg zB2$U;ofVl>_}-=8qUrxm*}|438g{FRd``|AAFyovO)Xj}Ibj$N$NH6GP?*M$VlWxI zXm#+XR|Eq;wb|*oL-y0OltMq}JstS>DuRUeg=KXv0E$+6c{$1R zDcI3ysq&$&m8J6K&rfm65eJY+jfg+rSYA2d@FOkIxO!_7IM6F)91w=J+HweoBAzAJ zh4ViV(?a#BmItWh#1(ox>2entTO#@No>SvHc&yql)%d8Kncy0`R0|y0;}nW|8Z`|9 zvjJ4qQ&`0+9apXq1d&7)IKT}@(pOUma*g8{(nu|V)H0?_g;}?_R&5doOd?$ioc)j6 zM0E54pMaQ-lh#XZ8s8yQ#KnX1?->d)VL2f_QHFy;5Re>v)|8p?b?z?05r?w$u!b+ncQiO^G2ndJ_ zA9i(LYEOz z4Taojc)xgLIO<+Nc3PLtNxrW|2I0Y=pUp=sX~9Tthg4iwAwjk#>R0L{k{oXOFh>dw z(hpyh*fL3-i$~1KA#Su~5bhNAN|y9)_0F%5CF+wmm7FOQN^N!T^4Jfow*h=2c=X(f z-1RKg+WA6QGSgggt@1~w&zuBbkR^{`s!3(zc#D@1x(|FW2=c5;EXR!RM>L-%4xYhV z>lG{`m89E zY~%OR~d?oqao&O2usLuJl-$5`M@o${l3uz{PxXaEUbmh*z=jnXJSvj zgH}XqzIy_ymXMB~E2nBae zkQa0+aP=ei z$CY+dK0hr#J~s7X5wpFruVg^i;?Dw4jBt>nL_XS&H9!6Nr0c{BWkN?GTvws7=Xs@) zcyJ8p3NjuOnk-M+QbG4~5NTyc)Pz@_5HFPGiDmfvl+#KQUKe(~|DxM3D@#ly zqJMk`6Hj7i96+8!@w{L>w_Hmt?BXhzT8#ynUbX(!+PX{1L)2X8d$NQBp4+ngTZ6t{^))Eb!rZULQWU6bC@QN`-XvIhl=fA_xScviuU+8eRn2pwUq0({Wp@DUvY@c z8#%-#?ZNdwA>Ql@@B8QQ>);E;t{di@q&l@~V5*YiMkIViYCbxp;qPu<=C;iAzxa^t zMDKga=>wJ+;R$7esA#|(H^)D75#4VoFnJNrPksD1kKX)c-3t03-7eHs!l{2@=g+5F z0T)xjI^b%2{r$mvr1PcYRU5h`@zX#P_0%>ow{=+YK7ePcRj2vmVphUHHgsf zDyjS|IrwW-Jo@`L>X3Me9xQvs0$(8dBL7%~bCaf|a)3vY@*2itp7DcI@Y#E6oUvz>ep(Tk>ho zo9amItD(iGpnDVZNd4)!7M%`Qg_35v1Fk0H*l%*aKbsYU;lAtQZ7c-JO|x%bquQ@* zl;qx4&TdJW15zNmz3#ZF`Qq^;V5B@|aKf$c`Ed8YeeQUU!45IycnWH_7eY8gB7a+@ z__Bsj*eI^s7%+oG+ASWBn{0HvVrbG^-z>RiUIa{G2@bfdX~ z3WJ%nk-%D9+RCmyxLT$qWzGvx8Rs!I2_YTIW})JCegCmYG=X((4ohD=3=9BoOB(kf z4&vi%uoy$ZF{8d3bzAjf!d$a6i1zhZRartPfPmIkg-arh4i}bDKSENe!G5V>N+hQ2 z+!EK8@OVWT@+3!kTRq=_z#Q3o*h~49p~0SW9H&iF-u5j%nPwfj#~nUV>)-AZo$zuf zr7H{}tui@OsEM`KBKOczo1+NPdy}k9Yqc?|QIvmm}98$QCVd%C4wIJ`B z-2*ge{|sWZ$D@zpj(qTMboo!(A^|?Y@3q>6Q~fG}{r(3-)|sP`cP&vM%~pDy7*5oJ_(Ge1kZBO%~JH})GFvQ9f&A!s$H|jQe{b# zC9Cim$CSl;*)t&JTWoN&7SdaqK7b|4dsi!vgB_1Z}?uO{Ww{+VY zwU)2-;xKc4t?_|wc(K<5$v#oUQy45jzp-0L+VhcpGGAKp+&$NReJPQ61c2Uc@eO4r z&+k@|42!m%XBhtj5@OTPWmo@c6bndHe>hL6r zlY{i-?77-#k>M=^H_rG>B0LwFvYUNeP6Y14MI6d8P58{f3XRA6ee%7n*y$Y48E4b# zTwS~<_@!IyOaJUdT3j9nnZxpADlk%1h6t!wP=V2HF?#59mb1)Z|u+o?ltKa2R~nouJ{A{IVa4K zBEcys<@qx0woQNolC+PY^mD+ocAHYSLUF+>BSTC%RN}*iV!Rtn*){4Zi8-*@hUF)8 zDy^Md=X#J+`6#%79@50fI7P+LjEpP(KO_nPLweSV!b{{HDGKQJi&+tOr%} z_#R8HYGnUxg_sR23y$>XZxdHr%e^wmA6*%^TQUqazP9G9m{yOQ($hoY-{4Y-Rp2YY zL3($chK_1K;G`Zqf;KVYw#0IxJLYu^eD{X)74`yaMpO9lfeUe#xWfs_bk4-j4=kLq z@8ioK(~O(5tgQX)v-lj)Bp#z1PflQ-j`v)bQfw4OvIv>lKsm8*#=(0JimS837jsrs z?RG@^ua-Td5dwaiF06WdkdCORWK9f?r1MNXGOimqTb{DsT)4jSVfA72TvExnUOmB6 zK+H4NEmB#FWXu-2gNwdG>mzh~h<>{Oq#gHwVQoJ`ImFq>!~~zGb%$%m(@*-HiB!ah zRB8w%%nJ|x-Ts6asH3&8z1a4hRMLaw z3{=kTQ)@}8&yl=mHT%hr`sVXs9Xes$3@^`si3M%0RYnGpb_>#WK zdl#)`Ma$}v87?96dAT@qx0vj=U|lSV=0nP!Hi)HLUo<*(Z3Md0FM7hIeab~Ud^Pv` zE_3lD&Wje$ddMnKkVFQIgt4j@V%l&^R{QXp`m1a>8RreC>@Vk5>Net@0b*S9w^E5o zG64O_W0gd7~ORBy!JwO9JB=g0~O(z#&R`nvKpZyXib;G zdzYcjj9^W(G;uZvfN$K5pV|+mU$bbWm4x~dk$tu8*KpFvwms(9jdq)t-EHwtk1_Yz zn=*1D{*b8c9@~{e${S?){# zC{;=!FR~lIqWcBw@A@&U|7q@*S8fD$;24j5$;G$*l9!P%Bn|^0Zsbo4O|k0&L+ghS zg?9pnfz*Aw{)gdA{Vt^nI2in(&ck;}U&6lj2QK1qe34)9hyv#0F#d{D$Ktxz#z*k= zg#xmD)}Bstltrs4+y_Rug$Erj&&u(h?2_tj<>Hym>f7x7HW#?+@=3=thufyPMVZpY z+i0Q;G{LWo06b&w_u_Rp6grI8_-nDx`os@Z&A+HOI}N$;^${MoAF#JZbw?b;1n!;%We_}6v5>-JN-Xmh3QnMfn(ayXUJ!41! z4Ag>-eH`z3AIDm$9{*$}r1$TEM@cR?Z8JZ0I{$zgz!8GuwTMFp10Q_JUr~C$+9|0x zb6BX9+rjmCZ-6Qi840U3X|$ZqO^)AgR@Qn;Y$6{&XCRTEPhXosUsLuR2a8lfKUIXq z|LQDzm4qt?yTD@AS^vdsyA@;Yk-Z1i!c3KxiwAiy~ED%9r(vVE>WnygS0D+ zRI6B(5q*`(Z_XEo^yHQgVp}$x{9xnOuL|>l<(q*`M}ZrutP#|B##(Gog0td365NL< zTi(v={L(Lrx?iT<;fZ;A>$yz9xq%c!9{-W)vG9p|{7FzIw|aeHy=L4ZWt}(h=+Kep zhs^YYLN1aQ&F+JYjI_`6zOWF_)l7WXS{CFSR=IJ_5j+-A?>~gckqR;*`$QVAfrE~H z=rony{BC>J<#Tv6)p2|Cc7&5tEl%#Xy_v@k9rI`k--)GxPiP}_Dk?)GGs3ONeJFar zL$&^xEdHed`C?js27`^GqAJ3njS`$xH)rY~s0;5nOIFK2wBsE*Ka$gCg5d-CHE&w2h<3U8ke#_y5-Y#7Q31AyHM5<4gy z{-3=^q1!cqHTwRaWTV^V-Y^|b`R%9-5z}Z;tLONr+ZE@dWD3((&(Qx#QiaK!+RS~q zW)ftcmac>v^Jv5(?8+G?OkEZ$9_2YnxR8C4(Cgh0b?Iq4(NS`xEx6lAXOS@ah{@Ej z?&Q}i(DL}Gmw0_*mEc43o6@?=WvN?a=j1%;{jo+Z8d>sPH}B2E`nSD6CPS6ye|v5I z91Y2J*l%31poI~?$H6Z93t`KcJ;NY83>LW;%r3*r1~7`Os?3v2uyp$ z#|E~s&LfuoWXQlBuo~{16S5LfqL}As1*onx5Y3lBl_iQBXHAJ@6a*V9uR6C9CtWuk z{TDaVLA94o&1Lb)n1?^7+)su33%l;MgujlcSq>L_fV@+{0^j|EOyhHgGqCHU-W5|d zXPzHdPj;4})a0ik*9CPK-Jg1G5aAfdRqp5ZQsK{8#5}DbC~m{dD`y=J9*Db%^l_wnb?x17o@+(C(j;etub4(%LazM_lWOtH zHe!Kwm-WhKXDZl`f}Q>mxkCG*>bt6@pqqMK_nF?!<}jUYSo16Dq9%=gW~v3D;~eKt zU5|ADDy_^yrzXnFNZ>))wzrO#?pmrPW0SY)Qvs`;@*LrAqJ#!Bd5e?1n#Ul5-(U4k zF~H==4$UMH-QP1@9wmR@Kl@hczh-%1LLd@jC|N$$I$wY9nfbC_Ckj2hsx%+(#9P36 zpWyq5{#(bJDrQom?1c}Bj9k-?3g##So03h4omB^jd>=`H(#KTl>Umt2`Y)3+-{EKQ zUJt5|a{D|d;R#=SZ&^k0M0_z;M$*u@7>=)c`GH+mMKFl?aGfVcXvhHY)UDgzZM5!Y z3)rr2F2CRqMYu3VcS8W;VFbkyhg5*R>nZ-*5Q|Grqwdy0(fsQ&iRXz3s7m>M9b(0s z)+(mVdXu9CU|`Hv2S`48a5lZb*J%;LU>U3zWL8%#g^7jd|dLB)TtMAnlM>R zl+#*Vj<>Uu$NRS*+qDTgEpdon5x1c=ZfW?z)Pi9V!;_K*zD!e=i$pk!#k%ob*-*Qq zNSZ7(miLI8C0bhluD0{ z%U;G36z)}p&=yR&L`lMlOvno!f>?=YO2;i1wT;~o;9{&ZD5{=(zYIKmL%3QB8TA56Wn?y5?4MmHs;qWP&f2J>( z!sq($sBB*1>PbxYG8IPxpU*ib^WsLdU~7iLJ)D10O82v27$n+YUUL|3H-IPX%0Ykq0-`4=rT(9iXm#h} zGjiunt(-om&%RhuV&nEb`X0||dLTT?qctvaS*DUPOqJ|8NjrM4?=?Hw3vM5=_AjJ%^3u~}=JRlky+`ary`CMc*GzY7moVG$1JlPl#n z#>A^KT37KJg#KRk;a{oYVCPX=30N?xzE5d7b9_4b;n#xak3)-gK#cfrO*(^{afYJX zrzCjv=Fx>6jd)b2Ryg$Iq&wqH3}!sW%(C#F!svozX9&%+mXxrGm^b0ia)rL)=tQn@ z6?;%UeKuLQAxRRK=N-`a3R}28p4XNG+1-5UG?1G@!Ui+tf%uhp?SrK(Dr`8CqTepN+beiEr=j8J={ zd;G@nb~m{wCwQnqs76v^RPM%prvE<5%SVlQZoa;@g3fL(mM%1EcPs>#@1fifHvO|`MX`c=++F8f-( zUf=O|UpkPGQw#)_ZkJptIM3W-Xm3})spJAs3h;xuSlLLROv!_m>d7GD#;2U3z$kz& zU}0rh%$Fl2U19R8G#|xmT;u%skp~yX|!T+cpFDQ=#~fgy_;;TZMqpGC-Mvr>**>G@(S}6 z-tmlSgD7F2HZOf#@+(^$;3Y!!-?k=quj65`?k3Oo0d#{n=ed~iw(r`4QI*JU0@Iws zU}y&7a`ZxVRfob{09nm8&ni$>UaRyd_c z5%B1tzFh7IOImz$d41ELa|E&cdHx6}9L=($CWRg0T2z(HE+_z?0VGW8hzwVS58rTJ zFZsM~%&`xoW6?cBNi*W|Vt^8rQEYnl=|i}|z7FX_HkFl+J;==D60o8|4q{X#5N|r@ z$gC_vjjdaSKKg$2*D$_9ysESU>+T}yQ-@fONc*MvPro&`U=v$EGi=muM`6hbx~UN^ zz^J4Ht2tPe62_oesm5KYhE*g(B;-?(Q&PLK!8$1}WwDG`6owb0N(Tmto@%1bBYYCL z6iynHf>SyHC|*yy1qsqDiK6-#H0jACGqW{|<}6D!jJ8}|xpGt@e^4jk&=(p&e{F1_euiU2F@SBoyO$MP|Gc<;vu*!CF;~508w|j>Kuv=jk6mv z%BOH|Pryw6Y-&>E8HcXhE+7{xQm7+S3Q{f}m5{L$kU>dHl&OG6$QxCBTY#B6tS8q= z{$yE{TM5d)ZE;_)?_da&({UvhM>yM6#XZ&d$!A4v)g=9hJpS5iLO*gZVxRR|t#}I8dAO}QFVy6mQQ{jT+;=u&W}{NYxC-ec${5ta zhkRpp^k&~DD`9oh2~Kka7jD!O-d1hJ_)$p-TzGpFw+v8GmQV;VDwG_>nV!M<@qS^>yZRAKG^C!taW^G4Fw0%(UH zz)6xRM6b~Q+NhFoUozv7VFBT5H7f0q1PV3QCPhB6Cc_~JhHj3R3DE!bP66>a#}Ye_ zlAr*B>qvkliW!XLX9W`T((8J|fuhm%M5iGQ7MA$=J002*rzrqB-J_oGStgkfSuRH+|8}U~^*n7PB zYl7-)BKT`#`73iH@mHd1OZn@o>+75OtAGGO41eQ;y=Q`-AUd*cfxr37NloFXiWwq| zehkO5R*Dg!3TgllHK@RlB>Aeamq(3403Yp0lS%-@Or6RMCr&JyL=X9&tw5(aBS8DK z*;Zg$4@ojb-@`l(f<*yfBgxETy`87YO7}?9vs%Cr4%3Pzu6A@ca||IXzuFjr$XP%Q z;Aso?TxtPy6A4at4-rn$k1*qrTp*M$hI*g~2HLSP^Rw{@Bw0Q#84?K?Q^6$y%3+7X z$Qx&x1!rCN#Pf%6(Fh4z5P)`UcH(UAg!kcf0AoCq;lmHb*F<2uS?Z<-8_Rp{ruV`^ z%Ti6tN&HOilB1_ylZU$TnpI<$9-hyj-qx`<;5W&8qyVP zj=Vudo7Bcsn+E2_9!P!NXTOi$SN*Eu`E@Hb$L6f*3kmQ33-3ebu|sCiX9KqwZdzt1 z@392o)8=M?IuN)qEKM6Z1x22}U>6axW;W4G?sZdbAEsMr+-N*fX8o3WbCl*y0uv<47lx#QywO&~pYvE#Mm1 z4h8)Bz3U)p-r%BJx^=7?@J)H{SQ&hQramb%dH%&j6Y%ZX!$}qG3tW`QAnT)jGmNS> ze4bey$WTA5IqiHPg#XM3g=JXr=n#MJBbdpW+XyWB#Ft+Vuai=gyA9TNW-L zEFe-FxShkr7N~`k<2Q(aA)4>NC#Cy>$T*hl{^FNAfOHBM1N9*N{)Xa@Zs%CTTapXi z##7~&q5~%axHKg+PriXzS^$+TFp3s+iByI*UjhboI>I6Nna3ad3*Y%&MqS_W8$s1O zU&8N~e_UrLtUcq{FLgPudNLpA>c)-UVh)ijdfgU)+0{{^K4Y5pzMJ2Ky%+}ri1YQ? zPQCWCK(V_5VNK)}FCl=*Y)IUQSISLroWC`%>PmM}xcfun+?pu-9wqYb?A?QZ+rV#} zSR77>AlJo+Jr~=py%K&iFRtq&{#JMqDzs#sChYIW^2A7TP>hTS5%#YhpwPw=Atzi2)wIHO>bdmhJzK!&30u-hTTu5(jNLMrpS^;IMd2OrG&A68iUBP-uR9E;P zvjm*@lOg0#_`HF+Sv$Dp!(iwuIoHiR)`Mv%-Z!qZCAe#50+szgL5%2eQ-$G);(5!} z&`Kkod*^IV#o-2x+PB8Pn-bm?7_H`iLfO2&(QT(!10jEI)poe@3~$aEpI)SmHV6a= zUHm>iNLyFBU;S5H?{=J8m-Y0x|H;h{{2oHLd%Bl4*OW!0BH*2F{~v!IuPh=#_LGM4 zd(Niw5{ohwdSYWoz+~ZZ&gEqB*LtS&k~`_kBuY3?PL}Ze%{=M|*fC8x;P1|3CZxbu zb8Ipm6!cDN0mhNUotn(9D@vm(J}l;@9T6$dq zmq_68-u>R3)aix)M#Y5&y?Hg{F+H{__mY3Tx_Du7Q~8H2$1L|kJB4Qob(K4r!mgRA zoivsHA)8m;O48gBn7EDRKm1jWo`TiW&SoFS-ag7OQlh&`wtQ7IC=%{I- z#Sni|3v4Eju)7O&l6UYywT563F7rVOZ}*wbQZnhzTNA}y1WK2?(DPJZ@ex(y&aj1~ zZFX|JV`d^<*!B!QNvQdIxkc{y1y3*)C(Cs$z0G-F(+2b(?Z(c7~pEuy;(d!h}CS!>dQR~Zol#M642-Z__)st6#k7Q_)VT-|1< z?!A98@?Tsb{&K%wd6+L?5WAkOB-KKz;1`xZ1D5r6$DAqBG?FORWqg|2AYfKfwkYku z*;(&jN)=}*^16d}s@Shy<8At)`N^4cQYpe_ch4sYeuNyn?=t*|oTprt{v;p^8{(h% zeH~)-w^E!~C=WfpOD>)MeV02NVf88G!z3cUM2!NsVSSlA3I`uc>T|P5?|rdE?2_z6 zF?po<3z{#7YD$%w_CP~_ekZkZMmcH}p!>z9WcS)D=mBHnlCeAh+zI?hIb$sJKCYW3 z#9_potN67$=YG%r*(k#lV4SbmIFXb2JbFfljjZdo$ej@dcd28m=fqW`+p1zY@R{IM z&mek!fQsN&NQU)jPkx#jVQ^?q#BWiXFgU-|JFs zwV16&Vt9>EtiK5>XkRVog*oq2=K(aO5S4PW?n@c9?Mc$!mtqAa>OdUrF%PkXJnp?% z`5#mG!rIa^S&pI#LXQ9O$34sTV6Dhmmro#dy-2cpzi3(%KxtfRnXEfiPLC`8QRJKd zBc~VN`4^F~9TT7d)S0Jbjz$ygFRsYp4)wazX2!8W$xo~l@)Yow;1`) z<*Nlgs|_LJ+LDFF29dX;wIN43)^D#?n$&-=-d*5}s{UGPUy%$}ns0C>&LsYo5LgA> zwJ(AY=OO47u<1$9?m7_b?gRNm1=};`D{FevZiJ zFHvE{vuiZGGvf#V$hV~>uQ zrn|%l=}{bJg1Yk2<5J)wGV(C>VV+V?W#No@0zztze;Yn}}CpA!Rt_K8CdczM?x{yIkoP2gMdaaMwyP`PG-Ck6Lq+ZepJGgIUj?=1mPFhV?K zj^>>v9?QDJIA67jSh87y+D?eRbn{iyd@n{k7ng7lOd0>_RuI z)P{?C%)S*?sEw3$A3{a(M&jbKYEMXi^u;&krSHN&oc;{aDG0r{!N3i6GCu3YH^Vxs-Z8CkLJmC3Jb`l4N z5xTRT9=_eb{^zU+u20%SDw#^@ZG^1nKwtR}gi*MRN9eD?Z(<~G7Jd#q9i<5W^cDa# zyd7Z}xQGv#*rj=QJ0bt?GMNW-z+?DphCzvTW++;~WH`lzb>s?7s(9o<23aanx_AKP z@p(l^am)Y!Pvs#Q%K&5t#RCpY1OD1!{3i+&30A)izetHp*<*OXVQWhz69?lNB^-ZE zrVU)z7>0YYveU2rKOENMHEio*;Qn^fFyh!B#js&HA)&sTV8ROg`}qNfo&J=hJ$L_a z$?$K2IQ-uljWaNs6%f4`fHxcj#6bc#0>Cmz0b}A`IPBE}T?6yRth!j{IY4>XiGu0> zVu_oEAhMHk&K5xnk+=#EMdD~&;1WK_5eamN;;oGm35nwCCjXNTvHU@(fdw^FJ==FR z$fxokXbH6X0qp`n7meILNJMdJGrn^Gk|KditT5rDs0Sj}low#Z8zZ>O8S$CaHzV-p z4^+~yvw8^GcL2$55V>0m33i!?I?G6JBf8sBchN77t{bMAt)I>oD-^`2s_jZvMJWyg z82dOhsFBX6KlJ>%d)-UL1x(Qgh49N##6Li5FJlbTT*0z1Jdb=)XBj%fz*uTWTs#C` zyd~_1gGVojihP3H-?w;<6XDX=yie=#I^Hze)$mUJOM?T$8ewL6Jv3fh=X+`Ey6Z^hacoW3lRI{Y~GU9I|A zynKgSQkp4g!4OH^ZX9(jW2bszz_=^Z2DB!fSg`A{5>JwMR_cc}zc*ExLZZZD=^0|} z8K^Qz=1pqtdo_}7R_N-5W>P>VFNBfYOtYI;B@|5d2MswHVsNUpip7FFSQBgfvQo$W zam%vMaALV&>vUQUW&jy07ROOG*U2i^IW*U`AlI!Y*L^eBQzsXQ&2^ttTQ6<3?bnio08^p}}zUavpvIZjn48~IIA82cA zaee<#=!_+LscD_dqC&1X`x$nA1>4Xg-?nOjZ#mTG35bmBT@C zjD{ROE3w$BSS_n6M&XM);4`-Xap3sL3e+DHyoyV5fIW=lWa0oEV=KD|Ir399VYv@+FTS&WZz%@#NI^w$%|Eh*t7ZX57;l8Y z7-{y9kpWdmT796V7S(!NVg`?j6B6t7$Ve&>)z{_X&A+*HK$UTubpm80jf>D?tJ?l8 zi9vpI`ubWMGit@SA60zoLZ$`sp66F)=mPA~3aOj?L`HQ$n) zeq{N)%`-{7+1R)lZIo z5`wqg9CX=SL-ytrNVgqjY>w0H&+Xsmh@fdGUnr#bfh8(%C~fHxX1&*?XSWed$I&^X zZh4*crr247ex+3g2LmM|ok@qRIy6#~C5`#E^|xTu0_fHkq0zlAw3TSp1|1vg_BH^n z_>kNgfT$evgk!gT5T_$QqpjGF?k@n&U1W<0)3rI}whME>zyNqgm2W~wS{I=WiDYg` z4DJHxkwVx-x-9o8j5kaG=eHpCnOlbgo;iTZ7z>;EP$Uudc9y>XEv+Y^XkR30Ijb)fbzShiE?r|%$NUQ_0~kOYTNP0T zyI3q=_36;X?X9Y(tvS&iCL<}os20T;$gr{5pB3ILfOX1|hCVQ&MwPP}B<(&>J`KLB zB+PXKrt&Rp9znEMEitw2JXCLv)93N#lq}W=z<})oIzp6&Q24vVH9mxj9l{ zO##XGEu_6C1rlR?(gnjX$M$vs7@opNd?0aQI*~@F7^!Ddxo*W^gX%|L5;QDM4 zWM@8vM9E`PNfT|RgDES_e;o+-veCOXFeWr0_8yt4dC5CvQ|@^?%<-9Q@eyI_?MNlr zC{lDZ7{z{xfke($`1O&Kuer-7Ql!o~`P#yi^hTK2FkSNS{5!frB1w-q1SdI3na|kN zZ#O{|;uVL&8rvrmzEkP5woQFxJY;QFo1x)-W9|yWRJ%kkA&H}B6#;$D*n+vf7v!OH zkjItqh?lR2-3PNqNc~*q*YD~#=Y}PQ=TEmEXkW+>#!J*>w$N|(eF5LMo@SsUo;K#G z)i&zFF@Nos%!MbN&@SmdE72+vGLP(CjeHk4JT1Vkb|j}tP7Nm4T|97HEOM#L^vrZ7 zARUK6MGlJhJ;&u7m)M*%C$SFN>9{oa5{qxG93_VFH4qK8-zzB^Bp~`tk^->3A!u%6 zDVaj=mpd}4;`g5deS#R&Fp{j!IUp9C_m=B$mHB4>4bt^=$UMB?@a=nRJqlqa*7z}! z0_?k6XiY@u6mAs0k`aN$&H^G{+eVSansegOp9#3$+Ji%#xQ)2@qFi3QJtM5k^1P`p za~+yX@`|vWf_MXItCjzmA9Nr&!AO-fzrnP-akWCaX*BkG_HDM%u&zG&k!^{T5QhdG z1M_i_Rs!WqB&Z0gr&a>H1z3PW87UP7f6tXY!X^E&wKhBcUVvPD8jB35Pi~{qXI~${+@XLgWBg;=kqlc>F1|Jes8-m zO`j%v4TJHwPV`}ii_rGP5n6ZbQXdtMg&*#vFPk)sM;OL$KQ3-eT5(~d+%SK;Lr=@B zE-|s&<3)CNvADpxvWa;EyCd zaOlVM!>F&H*Dyq=h@<%X)Xx(R#0kxxd%1(%pTdN}$3ku}3K$NB&v8L27y~CP{dbIJ zJ}Fl^skA?NO#-Qa5g{F*)gMoq|D9l%Ps>QaCBmnj5vSb-C)IFp&&SgN@6!wfc+ei2 z<3m_yL^xP_R`yk)qxo#%>sd4mGXL+a4L||Be9JWmd{L>Yek1~k4D1AqNjN^yyX>v`KJrt2C}R`vgAHJ_91`9P_}58y1VVuRIBzEI2<&C`bL6UP0px+h(o z8dp@JSlnKBUAlI>ygnuSaRazm#$0=c|6pj;pYkeW`bc)lO4y3+F^>FcTlVvt|BW&k zY5C%i$MZg}PmM)?p9ndEOKD4*L8&d3G zATz870{4!;EpUEq4gUl^$SeSZ;uAO4dA|_Gf8cOm9?HK&yDbEfq|+FP#KQF;OUHXX ziqR!fK;&sY;D2#gw~J3B(ZmlptQ$X@S`^{E%2>WJ$A}_gf;HRX6g{5Apsyqt`hK_D zh2M^uGx*VZe;$2@)u?vMmxaQm_Dc}GSuLPMjc}ng*oURTT}6mql8>xxp~k3*nMk(f zWHmw4$}gt-omI7m!}BkCkhOZl4zDKam_$l8Mg5P(-hnnoCsWy+-$~}{shYRi5rh9U zYMWPuURbk1n-*MJJQotB*dx zw};qZpw>|`_28Zb7YN?|LHgG$VTG>rySCn$)1E(eSt*_9zN}QG9bR#G*PXrUH*^F@ z3{w1G?eM$G(4k9$a?V(z1=cV8TOz|t|9ZZ?Jx+!$RsP#L0pR-3m&Z|?uh7AGrcCsF z6v%{Z7OU`coZKt8fEYHlVW}-vfD%zTciJs`;qyrb9ZDUJOrO5FhFq8cE0Tucgr`Wa z*zq|Jup(QGjcNI=K`SRhA->s1qI?90#e1{`1^fqhO9q$^9jTRL4w8(T9~Hm9UreS9 zchl$q{TkJdJ8G$-dgm_Z&#xI~lcm2ZH4iq(mt#0lPr+^s5$G^vLQ_e;GG23;3aCjK z*CO<%mJUbeK!swDXR<{MSJizs3}5L&E4)-AYgViX0+-dIy1{5Xm`gbIJG8rofOU4e zo;b6ErR-#tgO>OW`k_5`W;;b)!;Rkj#+SOyvy2j(Ctn&sQ@gTQ7*{AlxYuc8O9jlE z_d@t`zs_3l`igzO=JL}#fhmfn?1>K(yjTq0|vS+5`Uk=s1t6|&Hm_?Ci zU&>)g=*`c)SR{TcALScL{%2K^<9=SKJF6VlTh)ov9lH$4Nxc=<)%T}5qM8(tH49c2Ryue&#fN;J%?0>t=!dbS6X|MErQWc_CI z!PZu|JZG7dx3#t2T_~G>{EqPAo!uVezO&&KclLyy@=n#ttGK?vI6(*iD6mrnt_jBemr5u3$awXGN@XU7=~b+Q8S8+zA*g+XdY*p@B=F_!i{Z}!(svFU@Y~GrsS!HdGYfE&YSZnnd0t+<-3aq3 zg$-wR2GIliNZxo_plTAEg_t#!V)tksmP7k_K`|iOja}_C4!*$X;Go-0WvV+C(4yiitOrPm~%NXILFHKEnuQ}s^Ya?o6M$LdsZTRV+D^~7GPDBWw2)|fNq2) zYUq0ktN51wa4_|mT?J}eFOOMZt0Pjiie(Hif%9{J<^2>JVKSP3nEi!G=k5fNIDAyc z{ipnP`xDViSgqkC{XhjUhNYdA-qMd(6ZZvF*t{v>zD{XlF|J-a^~nzsWwbF(fL8#9 zMzG;=ADFmfFScnSO3;+BjeuWpy7hIA10~*to{OL)I-X3x6W1fhr}Tii243XE;lJfr zMO}6xF=elu$M=$RpHlMe`G0;5+upG^{BdDU&+<@tN7fVF&s*3Hvl+Vmg^1`QS9k*T z-|t-3#pDGoHQRUp(I0#H)0~W9Gh`TF^u<&ZHJq~X#k%gNkG%(s1w&6?j?4V_Ws^pO zV=Fu2KlX>ET|F`B(@ET}T`QcfMvM`JfLFN6JPNjMN+SH&?w7w+ZNT(M{N@K)&B){` zdXL@{7ZDlAOpcc)@ReR$d_u=(ddi=TM&4N%UGw`E==zyA%eah&Y+T@zlP{J4yk;FK zO&m+sd$lQFA^nUJzk_jh&S|P52Wf zvf^)@H~zCli|9X(^(qc-q<-37KH&~=wQjtlQ99)@W`hRwUes>t&mAu+pZh#{P}>z= zSI~A%F+VMMT2S=SJN{m=I{?1uR$qo3&MuqDFE`YG z^A*RkaciTkk}7+SgjS3zh(6}VH?P78N!FaTHTM~a|5g-7-4&1S42F{HVfF8lWpzdFR9^!~X*eK%K2L60}gp-~Yi#pE#c>P5)`f54j zpB6s)@2|w@>-B*o_u-HKb~QorKi@?EyHNS}9uK;q>L;M?cf){z=zdUyic>Wh%&ZcC zObnR=oAD+3`XC8P;vaM(PZo*e3a~Mppjs4ufD=zajfGQVqqYcQs9wfSk#ss#wDd#V z-8zwl6le1i?V=syu;TcF9+sM(j)}~ksh(L?QsylJnk9no5)evi0GEjxK`9OvLgd+` z*1Xf8-kKT&iRaLRxI+M70J~(C6ye%HZCA=2>MS-r{7nG%g=S7_-y+^sG=>-%_H3B8jUrp|7bvZR3ax}*6z9?Nybh40dAJ;sz)Xw8#Nr_MoFs8o6 z{v^U`sX`Kmr1?ssG;}PBJ2x#K-h=~-ga&Z`z9ABJx34k`mB{nt2 z*A4hfj5qHV)^6baS3y7KCmWXdFwA-I9!&yS0*H^W8Dgq=IQzaDtGI%8nPl zhYB`PO_7ck4{N!t>j_Q~KWlq+Qwq`9W0+)-n~7+?JxI6DO@Bx-nF|}EC`&nBL6JPD zr~hpRcK{&vnU3ouy2qTnef{Lq1|p%pP(yLD4wg&<0f>)7(jp3{a-U3tVBKi^g;rc5 zM2vxYHut;e@diTbk8Yx_;n^-!c05)iAEWCapg0>&obGfyYgokTx zXq}L_@i(PoM&m3DPmB;!u$CRN*>Rn?OYz@jZx;)6I`!tqkLQ18VkTCJ^!ttSx90kf z<|G+LhS~MF(|GYX!<%uRx!-7rQr7H(o6%D?V*M?{#}MNt24it>{P);}J(GDeYh&5& zdxSLDr2u}p4-1oSiN;7-(KADW^+idCM9iV_L)Arace3i=bm_+nu?57RJ;kA9%ahf_ zR)B<@VZ7q!LhVWuqeFq;<4dQ_Favcm!@o;kR#|)?SYQ)r6kmebRtur_f+ZNn!<`X? zU4|szLrJA|O)jVpEVEVWtWCyH(ND(%5`h@(XU~+V0wN>Xg;e|H5?@p4vP7c-BE4m! zQpOUintL9gdl?L-ahF&CU)hs@G|$yIf=IkyLxF!?E_| ztOi939QpS2%>tyEHxPn-Ko^t7VCF;g-tFBdQSuz$rmbcJeeO~9A8G#k#(rrg%$!XN z(}iJ~@s3-Gnfi-^a~zrWbL_1Pr5Mxz7K1BTtg|OJvM|Tbtp;pc7_Jdp0}`|VCUGCe z;ry1fa%(%?qK_lfL+s-6)Vt{Sn++mUI2>SK@ov`Jl>)3E%ag67x8F!wY7kt6uAutHd__U@~rerBvPvDOzJ} zf-#^eIgre=&GhH-k_whEInb;w#O9@Joi)aEiiLKXg*K@=!N^{|U5cI=`r-Mw)#K!q zL@nE!Wnm&~S?!e{UHEI}nyr|*iP7W(h;6ISMuo4;nxrQpOhd;SA^X#{nck4e5gh*XxKXfQ>nAVx{6v#Nv@s<90* zb11XlezXj>-%q69%wjO0$|_qkQG)6X0v-jL$6{juO~6iFn~9{(t6qD4M3J+PBO=D} zhF_Z{iY>tmZk~AUf>E!VSNww<}({qGAkr2`OLqd z|Gg`^De3WDt|(m^I9i_ympP-DZl;vV*YYS7zZftGo|<4<~R43h11|2R&S z#xnOi9Yhw0@ni`9bi_f3bcLPcxzHadpL<_!vKeGL4bqq~m)yUlT}y4sNI3PRVG?{m zgLj4ghYPmn8>Ps1e9~-S7dpqE`2sA=8u+JdQ5FG&v{wHl{QzJM+8HBSL_pD-40YkG z)ioj-n0rAiPXXm-zlN(f$tyno2tMav19*IQVv((jL~c=-3uC!xqU)+_lo{hqG?C7v z77>q#S*&zsZnBLP+)cWRBH;zOwi!IX%&lpaEGiS+>-mN7C12IoL}&Z>SsH*(H7=Qi z0*yHM9=qRct|4O;PY2kko@yiSUW7;P|4uI7r@uLxhz7amBb~t zD>f1P*&dBc0KJ>LdF$h%PB@7YB>Iw2ar1+Qbb2kherzX^nU-6D)F#?{CXgN+N(<i43pj&Kw{V!b15(VGB6NMZpX!QfPH z6+lGAE)5BoPE9V0m<~>Hti6e5id~yCh;~4@TOL-Sz%ad_*jH7!&d2M*RO5LV~6QiE%8sV=S-eF=sT97v`AT^_VC4 zm^bm5FWL{?PsHDGEI4*7v~tX&87KV4&$k-nwv`~a1so;C-jE$0OGf*7xT#15pUAi# zt7Ea`TSS5~M8?O@ zxlAkqduB^<=75ZI-8!?U3$jZDqni>OG=oeoa13t1`&)s=_&DeM^M^O5S{U%XDzF{k z+%}r{GZmVk`t`m?KrH0qTMirN7MApFD%o3x5^nq^t=X)!Z`ltms@kMGsUmU^ECu%G zJoe}?SH|wjt@N@#8aXfz03`EW!mo+Zb20H)@C^tP?CElm?0XS}OE5Y#uXCN`|C<|~2*%^0Fu)?JnwRLW zHC_<=St5r#ZMK$TX42ok4@3kZ0D9Rku9l%(fsl~?IEN2V<=!F1w$S9QFhy#t>=qV$ z8;$XYyMN`fy%*koU&_XP$#FIDRY!(ZX?Q!GhS}t;PCMQRn5c0XuXC@m=NXTO0GBI< zNHB z3##VwJg)L~zjk)I`++m$`=OpKLQ5#x}{nS zAiPKj!AzKYzxCQe4|zur^p<;4`T2nAaUQj?E}Uk<(R%WG*8Zi(=6Ia`n6U z^pSS)GFukArl09mX7OqUwj*7Bg-u zSCKxiUdffDA^=L0xX}z7sWj3^w!D`;4t-}RRRpP_$^Gy^ol{*}K*J^2@;MKdLT-9- z2W!Veoi5~R7hk34!dPom)c!<5N8;Ls=1V}w{6yvxDw@CtiD7D7Mg#;~;OdZAj<&a4 zzlFM~o{R8zyQ9+H1yP7JOuJB5jz&%%s1-`*s*^Y$3b>-5CO-yIp5)4Smg+nlhFUdQ z)$Exz>eOY{cRwK1F;@6&#nhh9x+{oM24O(0qckK>@~Ycwi)tVf!0mRKd*Qk5XRNsm z-UmMSrj^Af7Kh=|WFd{YA=!0sDHn_b#G31=vyiLR>mJKq;_c%XuZuW(jbF1+4L5rK zf%{L&i%guT0&YCnE`0|tL`vW^1k>=NEb5C_@S5@mo*1z;{CD3hTe2DW#G+}CzBVD< zwYd7H*;F_kJ)pU|>XKn_A(D>s++TIZ#Q!u>J*N+|u-H5V6FI`33VVrOXgg z$@`vr=I93Ui5;_}*b`Ep^9c^>No7d8eElqYoI-Nr)iUeSqJd?HJAww$4-ap(UdC8= zPe|~8~KZlRW-_^bM7DqCyLGE^Ig^^kOCDiwa+*E~2 zt{l({zqr|aNQ2O;{3aN6`klM84x7f-Agg%|gghPTy6eUAo>&~sp8mt=r~NbjXYMVT zIF+qbS4sl56q{Jp25KL+VxN0JV%e-rmYEnXm?mE~;+DwyCH8MA=G<>6BPRGY?-$%el}bacn% zvKW#flSc`&XDQbz1^N#4ALxszuiwI&MY3>V%6*9vqn+BxaXeqOArB{7hthn7R5qbW z#E9CG#h5z7x`~4Yw9V<*iO9yX>P|xij-nwVD!Y zzJ)e>5Aul$t!(}?A1d2wJX~VSNQl!*{_YBqD7=kwPWrADGP9~A9iv`x9wg`=XXm4UuJLJ#rFB&o@q}7` zNRkXrX__t&u^L-%2G=(YMv{6I4d$6xY<`^yjYDPF<>_5 zNw^$R^cl6Qw+rHU(}|0Z4p}E-;_83ZS5SlXl^qFNMXsc=L=c;x9+iBeofkkPNIAv> z`up(^uk?&)8+lb*91Zb{pQ#N!OH>s4DJS6g$g++5nWbffAtUuL8S7qX`=stBV59+W zvrEOY7N|W-!SkyuRZnkciVOjw8x7f(3Jw^95Y(xRHktYm9BY0VAI6_4+QoJT8%5Jn z$gB~hV%liAio^XwpX&*c-6rI=AV>m%%2A5;A^kA&8qPn{orb}Q#X!qM5wsDRslGF* za3_ECw(*XsLiaMu%P)#%b3hkf$)t;|xD)RWmf>dp16Rj4XUJKH6eH)I&|TxRsekJ` zu8*u*d1_~st;C$Yesx)OYcMxf5qihsQM6U730>t0KgkJ3qb*-Zdp`-xFyrFf>hSJB z%6nBud~^8-W>0+66IdQog)fK6$qqu*3W9tF8OWnU3P?DPB#e5cX=Nb6mSw*BzSml; z_b*CDhHENHP*i%T>HkJlY~Hcb{Aa>+Qy0nH|AzZTdB?XiKip|~e@g+|3 zqUfIFE7c_0H}S+$qMBqO7&y0&Jpd%8@P1h&)6E9}FfbHdn%FRjj;g$~CaW$8AkQzl z`*qLm=E^aoEJ^Q6JP-%(XXC?UN|y}$B=l9>z2Ux#jjCWH&6B|^ow8reGo2i)rd_qa zc$yg%f}$<2PAD^OI7<&aJ|zA#rd%YJ?8i4H2DwZCyw1YnBJ2QfDE=LS?LjQ3<(D7^ zz-hV4EsOO0>fIaV^VY_{Km70i!Q#;uLwElj<-ECG{e}Cz*!b@(ScMX6|K{qxYO-!A z2hDmgMDR`!eS1dwqYK=!_8A!~No)3$0mR2xddMomny@H_wdDI`8p^tJ~c_pt;i_e1A_ z2~MSH-arq)4gs*c+1;K24lCOQ$ACm`*jYd{(5ph|APi;q&; zO($yB5Ha!fx2fyj7SaW$M^(7gC)q*&h2pT}5Hu4Uebnc`JbU{i-}Yr1!^<-Ik6s$e z*S3PW#jev&zbR@CAeL(JC_YKTW`;cJr7ff)4yp)%p>as+`$v`>Jno-Z6PBrdT2a58 zq>e?a1fT><)TEXOx3kg`gdF?G@TFdAwB#VBd!O2uwkDIbr{+ib^FVUcL)>sexe{hA zABVpE2@VcTa~f4*Jw^dL6ptiMkQU_7#Q5p(Q{R)ByR{mk-5})v2420PNFyk-k>0>j zf!;I{fFaN>K?#lz20Pr8x4Lnz`IO)Bwk`xaKBz>A+r)~*5sIHrwuq4f8l0xTqd7JP z?z(|&;$zu4(9*Tm*ZWQ#2Q0YX#r%Lce%yHbc#zHI|vKf zAW_uA@wE*~^;RTO@3nBbj&XnSd!gm8Jn9eIFgV4@^4$X5gCe=HZmeWMU2~0kjL@b07XoOJUJ@7SmRZwZR8~hc~%Fd zN%z{Y`W7!It(4uYy?3nztd%^6#PEZBd?=YzExVv9 z;#NHzlCweC*aC%-sN1or*btTmGn|O$AkV&_ja7RYHYDXz;3DEtNSV^AgJ|of z=?lu}>mD8mLrHPrgs`!>v_q24DA{_HB6FSYzMgXbkX!)HsCkg<+C##bP!8=`?h9dJ zsF`VYl@V|sReLx3+N_vIL#YHMEsGLc1qwRHa(V*SnF%Ft@$O7Qg<+HuR#5E}Cwlwj z$DyQ6P!iOH!X-c+*})JXPQn=_?;~8Pq%N|+ru-DzoBh1^sr`KH%KSSbm41|b2ufNH zB>}(*`2Z($VmW2ihSGss?LgtxSP@Ze!TL{po`c+agP#n5+$A?aVQSo}GfuXCC{nC0 zV%kfBymox!$HTn_>YqPo`y7K$Q7Ye2O2a6HCX{>$N;Ymt`t+w<1))M4q2dyu@|<@x z$9PnQNLI5*QTI#!LGL?(LPFlPZI^7ZXATCO;e}u9X;v(~M*M7t^ z@pF#rQELQ!)i5}*T4a6~3`GN{-lZtJ0j{!dTUpo(#(2gh0JC-s0{`M5N*!)ba9xym zEl&KG$izSR$MCu7sY4o_Rq=K`1+2nfP4BkAg-qN@Ln4el{~jiq<@$3FZz z+C=)ciPTt>?4v087awwxe!zYc#f>OjbC`%&3_<5h8hz7*;BBVVjDy^5rlLB64jodZ z#1j_ZtJy4}R`I1=Z=wx8BD>#2mv}@<(M+Fz#KFFz=2v2kt5Voq-F<>DqxH<-D zBjFa(Pq~0h#znrPKK0pKqZfbafNyrQT_{z@eM$mrHNhZE@+qmQxdjs3Ro z5pl{wNTyX3y&@Kw+4lZy2#5ws+oQnQc->-2ojOTf62SV|A!g%L#gG_7GOS&7szZV{ zqyXtnN$U4l)70e{J{iW4AdSAY{XhDe0Md54_BbF}FVM8{RK>pC%>Qg}csN6MZ= z+JOY{nV{cMc2ni_?6UtxLRIk`c^zm^A?;#vj%0h~DDlcgU)&@-7ZdUdiGAgKfnplR zB2Nc_kT{QEE$^XMZf{?qS6=}N&K+gWMLK+-JLfwO&pk9>xt*Lle|cql_Z>T9@bu;A z5%ig=Jt2S;NyT{Q&>{GLf`9_QM4RAa)A%6&3s!P)*q1Y3rr~h9;jrKf9&&U@MsR3V zP|PKf$Ft!GDs&`OoYGuBg!nQvIyj619a(%YhRP=@rz3PsjN}nfEXgp|=`twzBA!A& z{w`zSNjboC3k=Ic_}t!lSt9Z{{tfA*>dQYRA>maa;Jizhv0&Bykc^2-B)$~Y*$KM{ z#zZ8i)7`{LAId)P08n7J@GFzx9PUYWz=^!k^w7`Q9((rqzoZ`%;l1w@#99W}kjw zNdFELFy!I*Ke2&gvAfB2bRX*KF5>Z|{~NZ6Zb=MFb8VyFiqt3?r6`ueqfawg3MR z>*Gyjw;>W{9g|D%jo}m`PREUL-))&tD0>jI_ClFf(mS16$r|6!!@(bISQYtOU(6H> z`LZt2>bq(@L*`qewWzA+Q-zs|Eo}wPa}h692?pTw36_#P0Mn%>>#IxpwTbl+4GtAMd4pWR=I{okw(U{df;_ z=rH(eUFlgo5~E;{E_Pw^nK+!v*&ss3V}D73wXu-pYW*kq6S|voJIodGFel!rgVoyI z;e0m`Rbu$&_1`P`5&v|Rxd@-jZ~BrOuKNtb6iU0E#`+SI)a6sSmz_XT@j07CGPxh$ z7pbw=H31(J*%B_z?sjk5cEuITPhl@rrynA2{E88Tuk7#a=V8>((>pPAVLD+DH?Bea#8dn3GKbhRo zX-=lfdm(?giWsf`3!%9t)Pvk#+xZ1(GguyXur)ai!!rkM$x_#jv+`NVj?y(fX?>2< zDPqA()LanJHdVSrag(^d0yZJZ&G~c!{p2x-tk%6O>FLc^rtlQUSB#1)@SF+$$pB+R zR2~Qr^McSf8KbhxN2nvX>;@^SY5A8g5Ii>vdtN7E8cv)4{=JR|mSkQcO{f5#L#9YK zW30&vW~jrcZ0`dnC1>|&8r)C%#@@B>=1dUZYZ@&yQ8lx-Zh0$m~aNp zG$x9-r$R|e*?3jyTzi`V=O+DPql~WK8ei+3g;yrA_zB+nP-1oAii>U8N#fg`4|9gd z+Kp3(4Q8*XDWnRF2`Rt`FUbWU-@pI>#2;@fwv(dSNjzbBK>>#+?Q8-pTEaK1($tJW_FlBn6d8_ zcX7YJuDP|4$kge2XQ)DkPxXOdn!Ei+pub9)$J2DqgQrWy_LJhPu8n`sH-dltz1T{; z`|onKICflOx2o~q)%T7YC63z8yEoUT{uz!}xTQvw--Cz85bhZ*b;&{V9y$8*sJ-<& z=dr#d2EC40*!N8ZQa?b7+YSI+Qwk7SRg87Z#9e+hGr0GTDzAQ;%eu9wzxTY*oNtgU z9vf#)G*4WN93-n|198BQa-ncFK-}s&@+Ja;W{35M0@)qmD86S0_)PXywMi%{d$2Pw z&AuiSNyxfYKbj=f04A zA|QYC;3lci?|M5UwBmV}#rXLL&;Dtty(HBu?iI_0m1*nw zbT8_*nA7jVQ~H z6&;D4Gkuj)M(?$62~3{heGGeISHt&=x@bQ8-ZufZGi^;dV5v)j$rCf?7s9@N(m9Tj zrC)aUkz+#(xs2)+UA_A{<3^C(wYG``F*j+J?wlt-dBrZS`Srf=8>_E5vvkwPlV&8F zjGzNihL#5!XxaH9z!{pW526szoa7;zT4x)Hzo+|rF|261N>I)tap5aG1Wn3#7VDwm z%V^vn`}o0|Yj?XUSgSGYjN{CQh=+$~wVX1qHlbZmg60p+DA7W*#0W&?Wpk4AaCwW( zlRB26Fbm-|L}SKLee%7D72M6K6H|HVh&)Dcbt;PXdD;NX(jlB~?TS{UEKp0Z<_nbs+Ag4rg_m6Z};1HJ*K`qW<5m2y?m;aS=k#et1Rgd`#KDDBn}h z3V+CSKW4*>x|?lTtptu`kPYFan)?#pC0(3jQXoFHEi@)gYE{RBX0CSw%Q0ssvP)hL z(-rnd;=aDUxcWANJMrBA(9&7b**k|0d0uqXfTZq|IAltyLl#HQ*4XI`dN z{+&4BVyAeX@N`MH#?p=Sdr<3it{ObbWXI(~^u$Q~7Qkp-Gw~+>xpK()C3bCrsj4&n z>FG2z1|L$KE~#D(38yEfstQk`BeM`1=n749TphRS>}of}{01T^rOwB=JIH zwhd_bc4}zf*`i*dhD4rwgTd3?B})CXN46906f|G!n!O!SS6O5j>YcXEm&vluWqT#E z;8Mizz*lwg#yU534`}CITGkfe%!{9Bl2cz9or@(||AM}YUOM+AS;#=H{n@;n?RfpG zye0C_pN{~F%gQnK!&s*4EqIKkSm_3ZF}Bb@R%BO5wdw<@n{9vGE;8^QAD zd#34{JE+d?zPz&wf>`tcEV8b=2crfDHN;^9A9TXg|8QIvBn(fMWDfYp-Qn!t`uY%& z?(lWx1fNE6gYkbu=UWm>n-YXSlNqG2fUtd_Z+t-Km?hDwUh`h7eZhNm2;;yw9I8L(}j6d zFX)C2Z_1IlCKkqh8#D%x>W?{+Hb>Dn6N&bNWB33D7=ZK~!Uqmc5=A7g8q;l)E|%&9 z;@vYW9!}@$VMcV0?Bgv~BS;34URC`EOD^R@)bRySm60y{=$f7+yo(fI(ey@xh7Y+rwi<6-2~>U?F`Z6_1LHuH>bi;YIO`i9YFJQ z8~$bv7Na=Yzugj)OiXW9NLj#!_k-{=Cbe2Yp8xPqP1sorTt^@L@FhcJfw5K{y}X-D<{+ z-z;6SFgfFVkEBAV7)7dmmO^`VTG&oNgkua>`nh#dm=0serNkRtN^p_yK0&o0da zzCNJ2EF~?<%zI7b*2iFwX({ycpoFxHJo4NiS*}?0@(IlqwT?_E#bk0mG}LassHPCU zTuS=4B9kMzgsaHdiQqP43H{I!jb+FJTv3Z$<&egZaLAR67?p4S4kX>D3gQt9E698j zTy}U`tlJ6y>jQl`W~e<`3OXqL7fPj{6eav1bHp-Kb+U*FW=2-_thx)%Vl2+NBL+lN zG3^ilGOHvp`hnFILXS(7V<={}GTF@Sh-z@&zBVWUBl4Rv4=#2oJqdWG06gbC1qmFw ziY03~v)Y2#@DxVt98mHWx&BQme@mHDvGUwwvY6a~%3PA=yBpB5XS>aX>i>Wp>BKBcR@Rv=f(=o3cpvXVWXC_e6 zI8z*TGT9UW{C`n+B2~ig?_WxalDvaA9?LhLS~Z@BHC`4qUUfHKGd8xup??{hfC^0@ z>!#m~(02PK7!%o|53~nPcKQDHc_zBu47$*P&=xme)dC2bARF*TU}-b>Pa}s%^X4Ih zkc5)KS@pdP{7yyWT@MBld$c+oHYX4y1cmnzHd5zsh zH7%WH4iEw?ftD!Y^o@K$uXO?}hO`l4&hX-a$g6HAa5c+({zPVJ$HNyZMoe{cK)K8^ z`2#$xnWCVnc;A{K>iz2m>jtW_@_L{8!-_s;F~U3c5EX%nos`>S$X|Ip;}u!wdZLqQCk%z8smL}b+gz4l=uOTH~KwU1?h zNN@{8xSgns8U9oJSTv0E5*%PoH*`GQt;bkP+#J-bz~JHoG-1PK(~d^GN0?w7hs7zD z0OXsp0|Gb6@cJ#APnA}s+T}mj-^{>angTi8VL^2V@KjNv@P34zP$sc2c{#T8p69T1 znP#?4|6_LYl2Q_D*posSx2h>W@IvKAaj~OD10}d*ps@9x%PV# z)QGv?^!Y%4*htC&SsDC|2W=V?6@&P+AdaG&!WA*oIWAt<~FWzMS7abG~N zEy6d|wE{wbTYbh%$^B%7S#hD6))F!#%6ULK#FiBQ@rdLN+go#a_*j2JYJ!&^bJR6y zFc3R?^w3C%-5*9ko=9pBh6C_IuLVdc3i=ydg2Z2YI$$R~MHmLZ)l+}gW`y?x(4-5{ z8)3jqX>74N&0Wuht3R%Lg_dMiv*)+5&N-MN^r0B)&8yV8P9eAf=KBsmfwLJ!DQt7O4=aLj|lRR~z8M z^^-K(zjLtnWPt+>_vMtSj^>wp;8fMUaIGd_x9+a`%a4uvizU8fOJ+OI0(bPK`ktvS zg{3_cd&P*|*xDu8lOdoe#Y9MvkF_T56>Psvbz89@edry9;AJCF^4uAJye)DwPtnmo z=d7IQ@)WE3gW=GgMB~F9P}Sng2G6g3@b(kpVc?f10$-$JL|-s_DR`BHMbSqdkfQd! zY(eLWU&8Y;AxrMH`ZHjr(qUZIF6C{v9Z6BhTHKd6Iok04nGr>hW0!=>n3mUez<4YO z0p^wlvSYr1-KqZc!*1xlC;gsoq5iCL#ITK-c{jfI`rv!{D?9BYl4yG|6Fw;u$zgKLEZVLjDZj*}pGz-$^7RAAF><7Jrm@+cO4`HtUfQlmb2@ z4ry4wVIJ-FO(8s*KnZMEdN?5dHNSQSe0dIbv3%OTR8O`_doTLyP9NPhfUFc*22v#h z0|;#2oVYE2_D>Z!)ut4M13J>+ONS)yUXOB>kr!qT`Q0}Sc(m-wnpaM?9W?)+CNp3I z&T_w!@FP}$;R}-kSo&~+E^GRtKfKY-pTS1>E^Ux+)tj|Lze>9*yE_hdqRnmHKddD3 zM$c|ls+Roz7nCszzu1xv5u(YP1&lT$C`4nANFqbFEHbZx%v8cBn_asv5?OfNO~J^#*|?n?0~Lu zmlW*7@ifAAx5WC6dNLEZ;J9F32SCrrsdKt2wyTr!@oBRjy*E{FvVgh3tSYVM9~cCc&RT+)%zjwC zdPo;$%b(kzR_;%6UYEzuWLS0Y!+U+LA4AY+^bOB2tdqy4Es*98b9n1!wdY?(mC=&W z&)adSGLwKm1&gBp_oQKp zSTj<^@6wn>A*#UIt2*DjliiJ&hKOy?ZC*L|XLaEZTCCsRCDD9S6lVB!oB;R5(vYq$ zkZzl;CTHI~1+gTm5l!;C3Z&QAnc4Ymwg-TtdRy*pG2q$_QGq#F>3rXsbl#_>DLNwiA5YoCa*~qUp^9PvaI?m@ONMBsF4GsB4>Cg#yYdMeb49j5}&d39;VPCJudEsw9NL zhr>Z8$h-(AhFSZOhg^AToUim!v?X)ZXW3z{TcrBZ8+T~l49M+%`iGkNLMs6~Bd|Yhe5IL_|)#ktRjHRB@Fb!%kZ7 zknn$pwlXtaHT;W!H`OmB$+BlWHvRJ9!`ycf*|(L5p|p5Lo}c2O!!LXB%th6soz)lg z|Bspd8u~T@X8-I`a$Mz4QYNWIX(_Qf`Yv@hCP8|sj3V9*%`I<~Y-UoHrB$siZYYGV5C;ySi!6QP{(uU@reKxqVBbb7Hd2G0FUus9MKcj=X&HtR zn-DUr3u$?1gBWRLYyynl0CwkGPw)cbmS{kYeoHcem&Y%lO@ds&`fY zX6EXU*7j<-;ZgiI6V90Q&Uec%g98&KG>p=#t;%VG!9wO|Wtsoo_1=G>3JYKL5TR{O zmim6@K(vXS+wSbbv}zKa+V>+v5?-&(V{`261> zH_=0!s*CmdI?TS~)v~ZxjDqDfcCUqCVOFKHgY4WC7Lm&`>t-&F17O&@=YhHk1`Y;s z<2nAxp$Sk{EKr@GpKY6^@%fzYW@5ce?7MOyzf8?;$EH|4(r|C0mC!7%RC}_Ok(X}6 z1h94P;U2;IOrkql{K)}aCC!nk;d|c@VQsPWbN8kgVMzM+-F$9OY(J@Dap8UXPjp$v zPsL=2@;yMhK}{^2?ljCagloeRe*xC%fxS+w7pr3`MB*8N49*@Rk4AV&olKG%!A`LzU)|P&- za!~!A)|W1Ivzn=5V$cT;4U2$?KlzOc+er{DZ4qSG;MeL ze>gFlsF5ioVP~?AB7gndZG-zs@03)yO!U*wXo_M|cMB zX|GZ7d(|Hvr*&wa`=;!*O)&s)q>(*n;Y41$X|ovJQ9{J;)4XcWWP%*?tkA> z?rW#W1lNt{KRk|(?pQcgBx`u2tVE^3weai7*4rT&t|I`Epj~^7YuwG+DO4 zh+d_iFP|ZN*(h0joMYC@Shl`@vG{}ah?DbbGx}wE5x(`uT18H3>oA<0`3H5-M`}q9SGW2RWNHBc z0tc0_0KP0heih7ZgC`mxiO5o4{|tM|_Pv|^8qq%l`61AI!&U={rjMb5^U{Q?tr@fT zgez^p@fb{Y;&0WxE*8m(K8|U;&;HXr$HCBB#+HwiY8u+@#HeVJAEyO#^l6xiY5t>t zQjHT;>&3gTg8F)T;|>$0F7KKbD=1vc!0MF=;P^OpM*1BjXlGawq#8d?oE-jKAiF0a z2A!XUUZMg#g2y{rsJ%L*k+2!C`i|^JJ`T?W+ro$NIb9|jXb(bJy9&i5{B7YD>@Y!Q z$*f}UG%9>LeB1MtmLG6GRX06VjK|`bMG1%9R3^VAhWaN&jFW~g3_lRk99mV0TTRd_ zEwhekjkAxV;Ddhg8UQePRhz%v&cgp|6 z)Sb9P^~V3>KeJ$r8OFYAF!m*ckY$V|d&nL&mTXaDjY4A|TbAtW*!NN-gvP!_W2unr z6{R97ZRR`g&*%I7UB7?eT-UkJxzBZ->wZ0-k3>`gKq1=v8YuwX)iD8U7LJ=OF=6zJ z`_7%Zd(?eLRRR@yP8Y5eW)34{#cNwnB(1>Yh_PB-15e+OaiYeaT*%R#v3%56*^pjY zfbmlRc?-|rr6E}lMJa!m#GP~ zY$3}RD=B#k>6R)9YDx(c0cK6)I1XpCL^>)AW5{=Z=A>%EygO|RNspo?S}hvsiOtk$ zOo_}sqTkR`DO^sP$PY`2E=;nZJfE3QAK$7vuz1Q8Z|sPdR2Y0wqGUC_pDfQ8D^Ieb z*UDs)Q69sI`>N$HrTf6YUsSNvKle+zp@h2?WLOBZzA-7vV3`?8S5r|&TyMsjdbQRI zsd+;Z*rhZRG1I@YFI>{NQ}-*nyOO=f6a2BmpE}a!%r&5It%MM1JfHOW9`i^VT8i4& z2Sg!a8W=5nlWaGqIsZ*C3C~5s(_)m)h~eg@o!UHht&cCh7~7}U=p^FjtY|Q!+3=4! z$Xe^SLFZh$hEF5&g1F}SM~oeyi14<=i@;cO%M10ei>Ib-^(ElG@{G}juyd9vm2#7+ zzZi^nDvLwr9ut#27iS;jYRfU0>t$4S1s__%?|hXVEK z8ZPykf3_l^adoyfr5qezT<5HwWN}X{3y>n%PnN=^rxUzT;_rnPHl9x#*mswWYtR0D zX~g`>eW~_Cv5vt$=*ix&icV_GBBPDTJhu1c2I8ekT#-MFVdHr%B2aJ}oYUyV%vOz5 zhXDi@$1X$~0ngwpJ-c{h7nbLsFv6^Om4QizTbUH6msQ+QZ9<{EroF@`h-E#F8G-fb zLu54+GSSKGZyC#H&C&lv-MH;NoE0vSZ6A^qr8KO|h!8=dWpjeqP|H(uwf|Ul^?gzp zHF0@BIj2nL-pD*!$0^P&CBiq+bA2I|nk3l)Gl z*YI{%z2^Ew7bxeJYsy~bjSD?nfFVZG=@-zVOo+_79E;r*v@G(bKz$31zeG9cK@B?t zFJ+n}KSVNLRAYYpPef;Wsc)J&V*iql#%P&^BaSAPv69;@32v|-aVmbHw4zkWY!MLhM$kPN~pQYKPE+YF}UIvO2}&!>pYs*p8Wks z4ft+(-x78*J@o4F$YbPsyAkQOFN4>P&DV^@ohke0g!QM13osr>5IK1=Z!NF`Kb_Z( zDA!Fp7VMf%fqpS!znsBQH_FLqqI)&jqwpoq$%d8iNHyy6bMVXQ#|!cN3?lECh19j$ zFlr+GkC)ApJpcyZ2Kx(-vW6&^AGTd)XH|R5FCcgkMY9v1Paq3_T49#CjvF+3+1BPk zbDifBXL3a)`ommLt8We(Z7N$`I90cKR$;5mW~;Th_A_)$cJAM@s_yvR%@Oy{L*{hFUq)k-s*=;`p0N7bEqZ^ zU?h>E0V7xGM1M&i5zhC)tSV>a)agBes>aUq1|$yLs`Jg(u^t_Z!W0a%i-Q0lGqM`Jl1&1OOt$WDQY`kO~Ob~^Ut}JouBl13NRrS ziTuX#;4A<^frM)?%5YaF{22O<-|08EJQb=$PWSTF?TjZRUBq5VzweWP2e>wTPhT(3 zypNA3KjMTjU7|u2@0x~&_;%#&ir4M7KJ*KJ>bJQ$=dj~(t3O3_97G^F+byiH#;+v( zO5`pC<&7s_(@3Yg8N zM9olNvlkj@xd(pC$c=$9x%&Ex#rOwC`6BzCV9Ix))6CbaBz@;318l$g*)l-a0jNo= zvo+~5U(%n^8@H*+|K5K+`SF#;xDW8|)AEyD+Zb;0?L!?2w9%xiPX7;ZUi&J&0*T?< zcc(JK{{x%}wEIj?X1pRv`zFWxoaYa?E)W8h7`bmAFkFGf&Pm+{OW&zFi24X&-+_3N z=%>Xbs1tzZ4aOBRIMEa9=f7bb|0l72KG>ej;6j2*(E(@2U_&%i?)5i?{{ZJ;MX3Z6 z>%`Ol0nQ;b@e7F;x}Yx7iKoBDpGiK{CE?l$OjFj zfL@5?MQ0^?wxv6q{%o9?>%^88X3c1UP7+a_b$zY>{ax5uZLXgxutN?YSnuY6$AcJr z9J3RVuPw>DAkiy=)z9bX<#D3nItJ+bBC?Sjn3b6G$?r}JtU&jp)y$;Gmub7?@HjS> z^POF^b*GnNFx<7Zln8vE19kgcf8g7f)8p?W%AO}*l4iVp>1dXj6_Z7j-Z`H(mLflz z;MKquk&pj25_;j)HMVUgS1Np9=K-MIu|Sy z>4C4PC?J=lWmK+_LdV11)_?SVIsQ=QRA1r0uQ*orH4+(fT;U+*xq)bX28-%SazG{e z`MzpUj6l5Kt~*Pvr+KcvH;e%o@r&EO_AI2Yhz(Q%8{x%%AFRtqeYuX|Jw?K(HWUzFS`Qi^Yk?rMYe+dQtS!};V0~lTS z0@q)gZ4}g`Hb9U zDRe?{7ykMJFqi=6RS6j1U(-uwwKQ$@k-!23WLPQ6V}QT<%`-pO>-q39|i1k zY;;`wuHF>IY1)#@Mvq@79TS)*mi&LWpL^OK`WM2TsA?wNEP) z2pL!r51GlAy&mW=uDgCMySfo6#OTC(j+{_kK)P6zzd^ds{_gE1K`6D@P#BuUgnQy% zC3r*Jh2-vumMrif8D8IZcj9q*CFVhwhBK}if9&w^w77q?dEOK+~~W;YaO8mgskb8LYO|EpHRY*i_$otpQDY%WK}ZJ{nK1 z46@a=-tUmP+Tk!^i#IIf+&!XX}pDO`L(Z@IG3+d#K(so84E zFJx+-n{plb)%h#L{7-4HWyk9D&R+JV@Tkp!O-2{v*!{kdd?QdwEx+g*=L{WdO#h|d9nHC@|f5(bdK|$ z^mNw6yaCnvl9u-p%;leq@&)gsd;;_C@@OOhd0AVtINkg5g&2bw{exHiD|`LAY;&KN zA9de0k=XqC$2rQn-uhtwMCiF%hy333^GY7=e|Ms)S+u^F-5Ia^viSPUq&h7*_*6cc z4`cLqw+Yi0k(-I$`DEq1`1A2qd-GVH#>=_)ll#(+AbivNLau+aRY3_aJXXPM3W_%A z*I@?N8O-pXKk^RP^<{>XY>^<-b{P&er>*uwOqde4nr~weoIQ)k01GFjriLuiX)pBW z>k;g*Dp-l(RW1nb9nxWyq8v{tCEQwzYLGH5e& zg*nJyT5F5np7|lq^#sQm8_)GW_KOGfJU;eG^_+7A`&$MXx%5qI9 z=qkTfQ7+P9FGnil5^!l-Z^zw=e)|!Sw zg>db5jng$~a9Rt9F+8DO{@p}l&w{w1QuT;h)EH;hjCl=r@D+`D*!eJ-cClf?sBz2y zqkyOvgK)&Men{$UJ6D`jY z#h&TI<8K;Sk&2;PEbP8Q2K_(!PRATJul-A6k^1}ZG;yoh=BiUWe-A<_?lVgR^i0

    SB}j_pQEUGgp?^_0Wnx=NoNiBi&r9xTz+|zU`c= z&uVXGH1w7F^L}eO$g#;i^~LPA4&rTr>JYzj%zLB5o~)RfEf?MAqZTcyTj-a^31`)7 zZ5{b@w{i=webe+I2L!WOMDb>r8oS{lOb`}b8Xc*{!AX~&>TMRk?rNF7XBH*Ya(ax% z|8!&0CfUbB)9PYq!Le-0+Vcz6Dn8>Oo#WF^c~|dvjCLHkk5Hk=Y00ae(-kjkpR5ZB zo#*{A$uad1M*%-ybY9l}h#JY}EnMo}j~ANpO=OF2dSvwA?75oG^2VSf|LiQU^ufTe z@L~}13R`jWYkZJgX%K$AD6A%!N3x9V+6S>fe${br8mn~FxsTqLyhPT!0*pS+BEiX< zd~Zm>!3`M~&-`019mqe5OiL-f!Nep&R(cV5p%RD`t>e(h#HwOV0>0)9EeBoEG!apS7DIY+51EvuK9tjgjK6@Pi${s^Wdo>iF-yP}vNa1%A`++~#c zFcZwx)0H$N&Ky+md$`v#XFX zJ>yBl)Ra|Crk+~O_MYey@o(RlgGRLk12@CHs`;v@Q04nU_c5*i4xd*4>DzT1Wh=R= z(s8BoGlO*o%OfZRvBUA@<6vfp9fUU*X0)H2xtZU7a(s{%>A%&o<)eLSvGdA#X@MSg zCg?hEe#;-*j~hszfCBF6E@P$Pi_Bb=~VTFLvDO?0Z4z^Bcg=&Y!pGlxfqYTs< z4AP_5ty)%l`SJPV14JgAf50$UdVP>F-`QXvJ@<<| z2NL!CXRv0+ANlxIlaTwbrMJ3^U}aU&3tsv#!&qA~lXe6oFo=#y$I;ET+CGF7}_vYOPcy-ao9n5~qN(ei=9fwP;%kn#&giR*Yzsuq1%OR{_%!2| z5}e3Epa9Z_%J6E-eFHTjSebOmNfj)#__AnyNRuAG-5HdjTgY5P^u_9zwv->7mghkW z>XgUqUVb8avsn$$DOP}p+u71l8RjL%>WkE0|SQ|qsthB;34&IIOTD$gauA&8!VR!QODPqmTznDLFCC8^UfOcevHK^ z#-M5N%y^CED#psA2B2WXwreh&V64lxRa(5Pc_hr1AqHs5SrcQhe1fe?Ee`O)X}>$G z`VN;%WcI3cFdkG1t#yofr@}X+0yU7?!AbbW(L>}iy*MRe?WLGnC8&XH00grar$~(x z*1}0p!Ls`}8ECvy_*HzrggejsOT}O@?Ra-ZNl*1UPhCkbV@a_FoR>r0)yv*j;eZz_ z*gL$=Cx%vcRZPQ z`i}k&8w}QyG>k0wxdjIT;gnldKE@9Xv}z1AR(v!9;?HKq(|cld#@E)CEK}^1o##+9*^3h1a^s*KkMIp2{W+*)9ct&KQY<^{WpLH_1KiY5spQ z_uxOb5}UGscihdTn#G^oE*Yq9-IFv_B@pd?{7-H-7lWhh@x~S1{eG1yzi7X_lGYY=F5s1j z!fS#5CB1=nHVRW_tu-fwr}{=SGg<+d*KIgfuLjF!Qv3gL-MD>)OJRH$BNN~LNZOPg zUSm`=L|oqxxvn<}7}8_7hP2kcRAfk^`F8m5He7K-KymZ8!g_zbK%(NL@nWgr^@&zR zoRi{5G3fu5z|mQsHUk&oOC7q3xWK}!0U>*rt2n+`)}wg4AF;5bSmj|#3mp4RQE}m* z=s$D;E!IACP%Zm_XXj4G+7iqP8Yw34-c2^ssz8)HXJ#u*Px9QZMQI@@8 z!=H*b4rjg|JA4KIuLVBLcc5ba`}%_pNrFt-M6g>zVBIynIHGo!ltJMjc!B=o+V+)k z!;@ht*rE;B5z9a`m@Q6ZOg0hp1=w5(sB(02<*@(BP~f9B2G4z5OB?eQrB8#ih|@|6 zW(1}J0xONS4`%^DJ46|1EEBqIUy?IGlhDp_x-M3zEMMveGn{1gZxK2Z_BH<6@YICCybOVz6uuXO|pBhB6m9=DW+BV ziTwVYg39S(mFD0x;)V#mSWOfNHvHLX?}jwzndS&*ddPisQaa5gRUY5fXj*arlcHMfy`Gq~bu`}lk+Lg@PrFmy@ z=R5SCoiSt~%4Sh0#Zn82hnm%U{0#p;6h?XtrU0Hm;mfnON=616dRHxLkHKn2x!vY?N_MUA_KqCmGYjAO}d<|LjBu z!ECwY(d+WgHJR+3d{_|sS6^;MW){P&L4GUHW*j4oo+4-8N#EvRXW3DjfueVvHdB7M8P;Uejpb>I=Nt)Y0I?O)sK$k!`H^)OqjP-4Qsd*a91#G1W8oYNT4`19ekb3j z7Pyu}EISymMT-UnYS`Sr^CiD2O)2n%8~v1T_X+Q=XYuG z%W^=>E7s6aKt3J12bRnt@bu&+H5ovZd+EJR8XC3y6v@(&1Va~UK`e_51^|#|&KL%O zrEMxcT)JkR4{jymJzJ^Lg{=TsvakjapjXLu1aK`q7!`)BgF$FwTibMOu@n}AjKH&2 zTTtaG!v|pOAVg(&U5M3J;OGVglKd-ZoMxgA09@oO5YW{3i!Fk!hBycY+LRi{(Ct%B zmja$5pRCYSY0>Np>A(J|)?S%PY@ZPbvDh78KE2XrcnQD)%%@386oBY*6hbvP_xLe= z<^eU*HFZf$r_xOLx0{&xncvp`836K=f74QRM41@fM{ajyzr4)f;1$ z*Y!mJqDfe?XKBQX#Pk2=zE)mx5+M9TKt>^eooKdzNb%ek2ozy;Rc#!zg71{~C zzv)OHlTZi%%j8`BqXF%&^v|?dZuuWCJRgVi1<0fDo^NHRqjTZ-n_@u#Bx=KCCi0>n zO+8%pS`7eLk5>YMU4^1^WYT$ys_(^Nr-aQ6<2epaF)n@Rze9Nd;>S?XcZbVaWA;yp z3RRkn*MkoKK~OsvuPn4^j08_qgXqUUhFpBfa;e$rpKYjD812wVU$mvXd$r&OX{h1x z*XV;wr%X#>Mi>Wg5Tl86H)Gt$9ba~$c}um}4e2qdeyptpK-9HLU>N;wN@w5sn2sgU;PiHIR#p%z#f z_Ocy4*;}*0|BP<(8X5lRnwxbTeN?%FcxisJ%N6U81h6X=W4UB4l8lj+s)4oVZ@_2X znA`_ja}ycN_MyR#eIpb2uxKAVjuWzHeXrmSWKa*=G)%;KK=Li_e_d_ zzD$c7@tS)xs(761<{`hQ50Yr#YAgGgglX_ugD)#EGTjS#N%H&Nvov&4-HGWAym;r{ zgLpo41Hbb^@<(5G)u4C1BeRUGNt#5&FdhVfaWH6y zbvl}@^op5%p~N?09MjGjPRa3jTlfqtzTKJgd->v1rrj|pD=?60Xd@fh@FIb|)fd|wDfRdblR`SR2iMohPFFnv_F5rPhsI0aXk0LM#{IhZr7BzBl}yg^g7VMgTx$nX_G6zx1Lm@26wJ%EX^N`GFGu8rSwP=0NXZNmVQP7LAo!PuXNX~Me?;}}`#yqWBZ>w@=e!O~Jg?WzbR(+Xhhdft4pkz1p7lx& zP$uY0;xBNCu}}U0)KCykEXZO5oGr??4sw@YS6$-vEBzUSh5=$GagsY{WJv0a^y0rZ zrO)*)Ed?Te-r&rTJ0*s(=pnV{pa73EoZc7Dq;t4p@G6jfu#9+AuV|v3Zz6|sLT0>o zj6=dPdz`paoK#`_g_{fo5OCfZfQihM3kIKCjMs&TaW^FJkxpG67dX_{=C4eGP?GWw zlN?4ldJcuYB`5Gi@I)Sm-lj>jyTIt>rs&_+kfR_#hyuDh3xq0hc=^Wrz;4S|k|Mfp z9!SP=N{eA|U<~Gt@lLp-k{FVbDt^Ffj0Le)LY4`PNcxNnj_)cKoH+=x20R%Ccsae( zx*9+|<7xeTYVXMqehNRo{WY#^5g&>J9+UbrPNBsK9aqWpzyoB4W=j_XoRq|}f*I~5 zhiE!-?sfs67Vj>Z0B`t&zISCrRi<}$rS%=B&5sFQMT2j0fTZ~(XEicJtTQkh8Lbfk zzs3c!v8NR1i|w4nv?Nc-wg;%TM^&k8`x)P)P_FFRoa~v0PQrofV0s)934rwp@|c0l z=R27%j#F7_rUv|v?rHxz)$;ltcGshhEBDobzhPvqNl~s@cWz3MumyAOGBox=O29?u zJcr0Ur^Z~XqPz)rHiHD9P9yKqM4p#(zISB4pmM&iGq2CcC4-4P|L*)?&4SRz+{a|N zo^ye5EJTD1VU*6h5Lpn}Sdidcm=sw^Dk@CvE=*r4y!)##i@zvGvnbcOC_l2Ou&AiG zyQp-jsQgzEnZLM7v$)2&xGu7|p{Tg2ySQbk`2MfrHvWPBS#w|%5Os4ydi z^*z4iNq13+D(eolsCP-=8?kT)3s9U3x7rX-`Ac&ek*}zwwcVz#$jDKdGA?(-v&h0J zzp`7jU!}9VMGG?J)hT7m6GdaDsMW^O=gz3lzjC*kxekj8Kgd+9q!fMZF2fy^uk%+x zgDT9OE7bML$wd{Ao{EB{ioFRk6NsF|U;cZylnBR@qX17Zis}Ay*HX z$ECciyE2%g>fW!)VpFoXS)s&arMy`M?=7-gYQ;pO~v?zsfje$*Q-i`25Sy z`B&-qqn36n^x3O#X;#ZE-#ezTZc~x3m5}oQa%LSdnS~f5v-AK6k6VZdGQzE?_9X$i zL`7~BSO>D$&KFmiy40AvpezN7#2?m2E!WqPqFF}Mc6_rBw>G7>EvszmztkoVRQZJIU8i~<@~MV-0Se)f;} zX);m^4Pmfp)09Ph&q9u&;g!~iB^28^&4)|}Eb3^exH;-CmG!MPavaN2f@W@^wk;7@ zzbh3<-0sLsdE~X!EI9Bee3Jb%OT!0!P&^ul$ATDU8Cwicq1T>7T;h@PLJsS<4Y=Hg z>a&gzm?;G09xB(i#Ou){-=8ejWHUr7fw>UPGD)DXa%*~IXI*2bjV?g1v+1dItp&y-M)XHkJWw@AEgk zGk{D!!ZXp#)mZpbYxn?-P70sv-@erUUa&Wt2%94G@4e~&@~40Q z8iIskKDhMk$L(kPX|Outv+YZzOl=&?)Nnbt6!hR3EEK@#16p{v{yIopj(y6Rkwbgn zY8&D`VSul6Kp<*hpNuFVvur4_3Th8xTn8ni26=^$O~gU@s6ny4k~ISBQX5MLk-6y4 z!)-EBfsO^N3`qqb9PZaCCHKGj7+)70( zQCY7s_uMo?MQY{M$W>ecRRgrdPU%>P=m10ujd~u(E+GlrU17`GJ7f2YP=%Pd1cJHa&kdl{I;y#P*?c^3ij)U2FPAf)`*}sO!j|=&Am{Q@v(o6z%83 zuFpqXCYK_gPxd~4{&#A1>3Nep@FEK%jY0~XW#2YL&Hn{nT5vRB#nFTjIseh$DU);q zcgY$}ZFw%2J^7y^-`1Rjf~{vw-o``hD9r~{X22gMq!!`vg!>Qp8gsZd-sb?^F{dsXcDErE*=#LHCVr1mY;G?~RQEwAux zr|%TZhWrY9u=G!UnTlq;DSWD4xVTZFM8&1+Cyuqmy3?!sjez^3%MaOB*AcDQl@GwF z2^z9^YI-I1<4Q>fTPYQZ9f0vEflu_`Do%~3#J-)Ozzea6H^AJ(gSQp@tD8Cn#kGhWbTh-bZmA;$bO-b?M@~ zzi8GO0-TIrJO0eWb-na<^u|7Y%65akMyTL6#`UbcFP5`D{A^2PmO?6g2F04Kz@;!# zewua5Kz0jkjd-o}hyw+rleb`ZIp89vBy`sbtr2gnm!*TY2aC4NR##N|H>~AQN=o2o z*mvSq1qdsa)Dq+|iW7fQ<)Qn2OJR%dQ(x=el4DsjE$W~Um^%qbpUWI!wDKaJyB}PO zHXs|wF6sw+#j(_sw<&+tiM{M8GZi;yc7k_zz}d(V^lo5z;Xf?vG?}>`K<;AMOIFEc zBAmo8yI9aiaMr^b-TJ#rY@1X>6#+hD&B}D}@rl4E$pf~jb@2|?+|DnE`K(VGT1Ec| ztTRgRdL?9$B5L?@Q5tLMc>kWh-zR!Q3RUq_`{n%l`-mbmJ+VIb#;WM;{SimjFVgOx zsxE(Fj``xV#I}*u)j>cGQnuFv_wIaIJ}T$yRAg1Vn;)b2>UV$s;%E3hBFh`=?ZfMZ zX?GWyPJP*SLmi>v$JgKO2Qmn+zY1wY4rU?MToD^&u1fR$ZzubLv>TkAt88}(D_58H z!KXNlP=GFe$!h}nik@#*Le`_<)U409rfc+E_IdRVmEAvqDe$+^`C3=r;M|#SQemNu zRUg+8WGu@P@$ir3elzm>d71As*e}pns33*GG4i`$Ymvm%S8O?=Rd?Uw>yhuXT-(#E zQC28*6kr7$naKRSX!-Ml3+KKP@|7-fE@S)lm6;1`KULQbILGOage^Ub>Du)?(u>8^ z%<{kGU1<4@5#3)8|K&4Q6es7>F9i$}kPdpgV~U5dy~oqGY_BQsQYEBZ`R|CHa)DFb zT@Q*LWad7sKvJy#)Rq@1Sh0?gyA)3UO=v0ep{tQeJuKye;W8y`*-aMYI+^v&Hp>;X(3QKT})S@Y5(L3t=$Lc(_`Eh zpIC1irv8_)C9%^>3SV^yKj*XEHp!8&EN^K5Va)R3v+Pb?!S3fQ{{Ci~VZyU4KZsYg&T(&PO|xYS5)G=51?@1eOa>tbvxO=e+`&f)=xqfjV_E{E`4tqWR6-+p~I{ z^ofJW%WrO9_)}NdYQGV8(uFpyDGi@^&vnR^(${%;owc2*n*(RWcXC~9!!_}ijd!MyF6xJ%!LA{KI7A~Af<9*;@QR7BUSw>{0*~5 z1et~Rrbf^eEhfh8zPUES)&ZMY^4S3}JhQZdz&F{LN1BOw0mqz~M)58Q`{rjQa#ZAH zBQf3rss-~lHSe|XME1lJCGn?cCEypEV|uc$(sHkTbGEXaS`<>X-O(uFtPWSHlrm?N z%0UDA5)2{aKZ9aS1(tOK=hc}$xs01ySEOHTHd8Ks&trMb{ByyT_mOG~_jg?C3(bpT zliTe*<2oGA?p818E~soK=LK#~ovCrkvu~jG?)Wj@^Ws^VnoTJV;JoCN((CV#KC@IK z@}p^b$0dY$&fx)vvZmyG_i!y~B|qO8fBD&Vt(jYTvF7`?tU=sPHMf2)`xINGf_^r6 zR$Fu`69r$Tt=A#?eJiY8hC(MpM8uSedF=LQ++l4+8gGpcQX$8q_a+cd(S1G z7Vjut^1k@?x)>bm3rafw7D#jU!9ji^^dTH*-bx5PM_^TO>dow z_by^6ZKtP!oonIezC5`A)+hE<1paW$-sd+mC0m|c7(Dk#X}GD%=$zJW?ZhO%Y{$GJ ziB-!Vm`@W4#F8upDWl>%v-?#na4 z!xLBuqWlJc!+K^(C>pp)g$t;!Lq23@(scHy3{ssoy(|pWD}7@4+*K*!TVXI z{y^$KOXFyc116342RIOBlWm=9#sdZ*aNF9LP5yLwTMQOjzHcwHT><(fR?O#N$UAAW z26-%1d1b$nUD#FF2g3B{m93G2((U=M!YlV9zkF>;WYjrpTtq;4EC6m+0u zdtQE=1B{OsyPI_C<-UV9>bPMksO1j9uxRN$>7G%3O)8)JdC56Z0o}og%y{}x`69jX znk!h9*1$AJJ~&hNkIgRA)l}%VifO6MLx0|$33X!|osrOQky%suA6po!UQny~D!Uk& z-|U!~>a!O}S6&s=OUW_!HstT3DV6hpV9!$$Y&Dy;lI5*7oyLAt z(dm!Y_k45Rg@nD$n+D*ik{AHAZhz5Az^?r{8nBYK>T5yAib~fo&|`NVXf5_&x*75b zpCWkr_XVw2*^To0j7quPu}DmwjQKl1`v!evqG2UOn1nNxx_Ej8r6PIX=e^gED`K<31v(cResbc6%r$t6H0H5!)Ms&eRei|l&|oA z>0nSIoerkgg2jBFx&k^9XK)AF%J4f@k;w|nCShbSF7KlYhS>EWISNntHlr!%i?lVN|e z9yhceq?^$|5QXuuwnUu(=Nro+9|&KyNdFMmP;ZuAB!zbvyiL1da_%*_5D+-%T?_8!wgIc*ujWNJw?VgLXl3phQjQc1eE44&Xq|QvQ36x6n zQ-XV9F8f9g-BJ+RC!f-$g7oDbQG93rZm?e%ucGB#S6%|AxleFvs8eI#$b4c`$CeE- za@=4bZm}g<|1`p{6ZdnK-t)yWDLEbBH71_8!ySE0%H89b$Y=p*<8?a#n_J1NBk<7m zmOSks=TX#I(PO-k8n)c}>vuDf)c#omhIKY`7|&C0XMJECe^`?2B}g_gwwc-ri3JIF zu_Q}ib~(A5*p8(3yBZyO--OS?*dh9UJ4-{jj4Qxwr+edh6=QuBhwtI_K@t-w3fit? zM8l72o994HRuPFULu5z(-bcr6AU)%YnZo{Sf7WPYb`(9j3jOTw zA3~DkBjta3C2Rkw(7$f-()P|jJS<;=9n9+7`faW!SlyL;k_P|8Ndc#)TE%KYg!E#q zDU6|%ZF43E3d1d5-OLCI%P@Ag`3-SK`<|lQ;B!{f0B_@5n6ndn!w82cf z*+6%x1VKlStxY5!3h-5B>GS4@vHikGx<5tNWNr!S*Zl{NCJGFuaP{`;-5z+`t~qCt zAZntSif3}pN{p6;IZh0WLEukWN|{q?(enN4XLL8JS?Hk!4`My-9)56Yt8I0Op35V$ zcfn$(phru%hQlqAX^dvmgo_Y z7pDH!Qhu{>z5pqF*{Kv5U!8BXK%{Q!RTSey=B?ceHz- z(RzJ6xy9Hc3g_oy)asvojSM}vJ6;Mh-EK6=DI9CsVYKu`=TgQJi^rwy^7~1Q0YoO3 z@j;IH5e1jKr7fv}i% z6}q0_p)t^NXvPJZ%3esj#>Ze$YDU@8WvFzs5%r?t(rJ3$a_v7e)G zicTQ2bbUB~92g6BvV-|&5s_J$UoA+lp-DdsE4%($9CS^$IbCqZQd1&coK}YF@;yl7 z%MpVCXtK$F6sdGv_Ax`Gpmm7Kc`J*};a>z0ld!zqnaZQ? zaE(MyB@Nz>w&AWe+n!mBI%zbf4C+$DoLGACt%IQsecO~pCO3RymdBV1vSFR0m`9CS z&F$h3*YvYtwzo?xbidE7w3Dt;p_6hY`Fq9}?1oh>FZ{q?Ol_DgVZNuyP^VQ33)0AQ zw6z{iN9mWb$OO(?zAF^9v6HNQn&8W{SYx#&`*J)NWoP-)+c)uT==>^lQcB+H;=d^; zOV~gFL$BS`C8K%Qz6BsQ=_0`*4*xROufb8`Rf-7|0X!8~b4cu>1M3SRn)B{qcYTmq zei{r{TODE>5f{Ger=b!63LqM0YRt`SQUrex!%Z|5L3W>J)VLitc>wGoaS)&Y5Ki5W>C=Ws; zTdbSqC+K)1T`C{X9ZOGyXt>xS&Dxz9^t-Iz6KdJA0CT>SFcgDrx*Z>MsCmStHZL>h zDCugOqw7^>gf-BC%xO4Yt_YE!OX%X<%yd!O%X)B?UVczU3WYB$2cz2()mw!RJ65ttbt5m+#`9dw7F*rCme(y{F9lZ8aZI#zOJ(|qm*0$C+ytXjz<}~6+CM7$d=9`2C9?9Y%?=Sm17e)b$ zmkJmENsNCX;RANpO8DGd`8EcAmm}Zfclz?c21yRm(|@kct!Zr-J=SjDNfzjL4}u!< z)v+AEWufi74RfPH^Rk7FMLpk*VH{q$?)8n8QBKw7Gu`SX@&;wOq_!n!9al+d z87p}Uh>7qX2Br`IhTE$7px?>5{Z8_X+2mhqDO75cn0=g$*Ug$Gt{GA!Homx>6heKj zb6?o}#L*%jHLJYh-Nku_9LGwIyHH+iEjeHM*}W96dHX6|6kjzx(Q#zV*88G(vGfXF zT2_t~f9TX7xBgCF^lCbg%t@WeDtxD|%92^h<`w>m)qyX4oXM@wmczSc%|rKA_LgS( zQ)b-y!Qq2Aa@jvATT3Z^Ipf2X|3lS#g~RoRecNMZFh-lvyU}~^eRTgsCpsZ|Cu$-X zM(@27ooGSyh~DdnE|KV6f(X*g>v`Yj+xU)S?X8WqHdeXs>$-mDS)yz^5FK-`dj29I zjs)gdLip71qYpQci_PBo!Vz@~LLi$ltwh-xW=Gvo(u#EbrGNY`jVo|LHZO35IOMSS z!Q<{SSlF~15Vi0uZ*K1IV)UKsr#)vp8J=NvtAbIvfI`>w(c`c037#~bD01k=cb$yP zoG^$OM+;ide&}w#U*I2D-|2E%5^%R6es-yRDkm7%?u6+m+5X{zhq5{RUhbYqV}R>o z_98{|HO*`v6+(<-ZVBdr5kGqFMN|@?6*0!hoEPD!9XHwp@j>Bi-f>3txunOf@WkX# zSI5mL#?Q7kL=W)KmN$H&LSaQGP!GsA&&P44VN$IRnc*)?gB(_Fx+gMo?mhaZYhDT8 z?gTa@;}2B?_n!$KiZ-34fDwQ2*t+Qb3tbx5vvj;Dx@IG}As=mdy~Ce*Hp0wWtsDkA zPLT41IG-NC`ER2z-uG@GT11=;ByXD&pn$vpuYx>-WATFizl?3o1+??wh%xWFAP$c; z7l`rQx`0t%!nrPC;W2jHmlUR#l+KqF%rVX`mo%w9s@#$M!m)U7V;;HS(;i+D#Nv7! zUBXslX)If)LRzBIMA(ENA*B&?KJhpc0K&K{p6_Uz=Kr-q|KE)5mC)^#79z?H@I&-_ zG}g8mR}X?G=KMqQ!3r()LkkI(uK6L``9rS8Pc1IWV&I43{Bscqir6JmCNJ6s74ry! zXLj*Jef7DDFs_EPpFa$s0&07>tye0 zEim&P3NR7DuLTarthok^JB>n41qpn1B_DG^Y!2VX5_+8ie{K$Fa*VzaoJlkePd}9W zAL%=6fHyME#8RkU)Y$s3Bw-?2I)1tN1k zo{hz8*aC1y1Gi^h5HPv_S%I!jMMNFNI+RA&U>En&UygMveaMuB_udWVOef?m+ap}p zE>Avsd3kGZSL#80?xI^9JBw3{A5re~X3A=nhtz4>)~9BM0`Sb61DVf4`bqyt{RdW# zQ^RSFpp@QgafV4axa2gLQTO$45BC$k_*)-NW^#`20>M?dcf0-_GO>=r0=CeR11P}J zLJcRe)t^04zDik);FE*n`!jA-wAVaIdh_cqt4#O@iafpP$;nEOE z8jzd5BH`KnE=C`5(f5#wcGAMmuOUx5mA27gt6W2r@z}d}VMJg^aAVy0ALswILVFxt zu#ALnG^jVYT(XWuCB^7Z9*LAmcrt6s_M$6OG+#ATr+dU>@?>(EaWM_%i=}`fN#B#b zU#Zo~{@}20>~24}KUO}<74`NSs{7439XYY&B&FZn+*52FUSYHU*SG;Q6?7xTTKN zRK8>Pn~1_qtE?BE;rDLSiaOcS{!OQ%(SG!_e~dTQ%LqC6LSET#I}Iv*a85LlUz(;L zCOPe`Km2{4Fdzy<4*q3I_c>3ToR*sH-W0l_0`0GGd zo0U?FX=`BpN&aH9A!&)0+Y5@^pva$9>5(xK)i#b{?RqAs4&1fMp7%18lb@FQH1Pl)4dYQd+2}URzjg5q;#Ca0PiJk;zNr8cQ5@JaWxe z)*zm}QEymFMaWhEw!6SZt^t51ZI$`&w};t(cg>I5X|6UJZ6BSp5!&eqgz$Gs@FX_Y z%@#~I1>v195^Z3tKueskba#E-+2VnseYwOsYI4Lfl0=452zQ7J%T*Y(x&*AnTO@gI0A z0(^Q1cKMN0S3hg^dVdaCoz|)z9)2JD?MXhBt%2olT@)us_FGtO=it@(bm!tWW4?(0 zvp@BuJ9U|*P+(w%D~MRw0nzcdwbZfSdJ)F8*TS^1#cOUP+Ig}2bJ=@b;p%f=lT@(b zUum`k>6nubod7N{3U5oxJXdm0{L+t5H156U%?`bkmuP-?40(cBEc4IDWEC>fzDLl* zh_Na--WR?#$@Aey68>B%FDE;m3uLFsPQ4@*ZfNt%V!^RRU50fD{mDnzLo#+|H}O&_ z6bgcO?=H=2nl4VJE(&^vRS4+Tdyvq%#n_Dzi1H>Sy>HTd<`+ituj*Kf+ zo_R1fh!J82+WW%W-?~n%+vv=JlR~0+obY$P0$Z-h1sf2A{shW^E!2nAzjOM#_K&iq zU6h;Enk~t-O>qY)gzhAwnK5f4<6i#VgnfyzEJcqHC;DQa+Aeg3JRXU8u)J3()(xF3 zWcibK+r>J>7qksi7po4It3HPL@wx95lt{B!iGvcY-q^K!L7Es0eIH%We^u~VNI2e4 zO$rd-UB#?%NGLio*C5uqo1I4SMRgP5yo>M%@$4|GVa>_>M^qX}+}XR9a1;?cP)A*> zz70f?{iE_J#j&_dU}8!wn2dD(BMH`gt=vry2SH@AR;2q(Sa@j*#5R-#5!_>WrJKZV zI)amM%wgzj%5TqhI@V%V9?iTsp(a@}1YrjQfIWLKHs`1ZFx^%mpj_p_!8SYp!8OaS zdyEIFqGSK&xl2Ps4qrH0d#qB`LevT>#ZfxfL$shAur@$6P(v==Hb5}OP$^gQ3{7qp z=`%o+Gk6mJE`*iub@6%)mKC2^#~;mOPoqpRLy!|0_WV%-oc$%MEM>U-aY%V4?qkuD z86PKu0-0%=;5lEY^;V-Kzvr8`uRumeXEEYF5A(;aWU2aKcqE+yt!Bvn!fRl=_8*@y z&N=*|isz$Hwuwk3B=k)c5UW`oz%nkn*g55VZxE2OlwR;`szitr?ODgd2akmz+nXe^ zq@LFgKNMyAtDo0=OLY1Hv6NEZW}~f;-ggFAB5>HB5yvC>;eQ;>@FlX_um}y2I%(4q z!;7ZI(|xwr%fvd;=$7P#hR2?GmVPY~Z&E*b8im21{GiFOeb;?5(OSos3hb1;Mc{D> zPt$y^hPUM&HzxMDSl8>b0ieRpJ zd6u&iQn_&hfN}2Ml^TJX4#lg+GM}3wFCvHx;<7UvHjQ2X`+; zWNh=i9fJ10fogPFVz+73MSw|EC#=hsw^cr&g+sFp@~xcznsLQbPR*otgg>Y?Tm<*k z#d~~=9u?pu474ZQE1-!ad{yhK^G$hKDw4*|Kh#n0hvlmOPjc#x&->`q-g;{1>JcA{ zBx&)>{c55vQ`WJi&%*B#T|yd65r~I3sC_<@?Dse80pyQ~z%V0K&QEsf8(Zp1o{9l#+8@@ znYrDds-P^_AU2_y#%qyqZRat+<{_#Sn}j~0#&2^vvJw5~GeQ~|phHCL%EwKzc25`2 z8W!H*97zhLx^x1UJv0yedtH_m#iV8&9-4Ap zSVH0Jhy9gDAI<-i1e^60#JlBfoN1{`y}M-cGi_lb7XW6h5X}7C-{vt$ul`S#=6s;w z?n4zSwrUH@BAe~r#)<(R{i+U|<3E^{|4~=Y&RuZXIu(9()$RICh)m=&?I462BP?+w z!tq;50WV+uyWxl1FQh9VvI{rO#FpaHEY3r>uO{7^jW0@qrG#v}rq>R?4_A_yHxJP- znAzPtk=WktbcB#i2pa;9K-oF@*0Q;M=>OYy7-+w#Md|G6g&!RE-)pY_D^MG)jCz`T z{h)7+6x5>cRVcB#BmA|DN1Fxv1K%_iM+*+Tj=Vq;=cy833>a|Z;1i)9N^$rvO92mM zuKTAy)sq2|q#({wF>Vlt@h}A(5p_8Qs-ECwk1WoV1Qg6Acli7rf)3F9W4AyD$IC0^yO)^KEqOw9i{{j2Y6WOl`1}qwTgYh4&)+&?? zOPCix!bwAt1Dl#-1SR?#gu0Km+lN(3aR1kwjZvdt8&QKIwdWjkPAauOR%$4kw4X(5 zmQ+?2q50c@GDVe%5mBSRDjKxW{6xdoB4c8C1E5l*I7UtPVDE|3z6o@|)Xh=cjwDDvU=agES1Q-*kCxSmHp5-n}GM)MWJlQMxH7tJbj+_mP z+p35S(wE8FpoJTB&P3XJJ%t8RP(>TXzZHss2f;A(IrHpl%ce$8fj zhXPhoDEyAe7jRw-7{db(WUgB%wGDk*UkoWRKazGSaW#|p=d8D9FmsyDw&03$Xof$HfK{Z$#5^M56U%1eU;6w2Rxj@GNV zR*)b;%uyPX#&gz~7!?{U{~Ow>nDl5>zP3o;lLTcSWkB1&JKN*0t~@$>!#r6O3gsDk zH1T>guFq^sw265CgCNS7c*{BKRJBJ+TRFHeDze;lm7F8Ic{t2%YDir-b;uC(L1q}{ zrZO<{;0)(n0@ePW)O+PxcYUnP@TRonq=t^SVUD+v7hFMB7wQHSX;W>yaZ`1ud&{K8 z*r49bSy#)XCdL42Sh0Ss7;6`tQ7>4U`#d_ogJzM3(;kmUZQr(k`zYz}5RLw(-MXvJ znJPDbmFuNz9T{%@y;|FxbGEEldg&pa!Cbv>WsOjxYTyQ34oJ6zt7lm`6P?e=phDYw3n8CdlPK zZoyucq@gu0YyQlWC4)9q&W80B_`&9A#w0W)s*+!)0WBD(BB9?ft;;Y|;yShh7Keen zcRWlD7Uy`=>hC;siiW3#YTbPJ$O(=-IRzf>`=fdO;t-96n!tg6qfQz~U~AON=5rCF zz=61tVG+#&@0Yblc@FvKUrNsnYR`GHj)KSNK7UL8%!w5_^?pqf|KmHE3(B5AY1y0V%XUR?3Y z6CBCg6)-8j@GCx$MDCgsPdQsM+3+9ZlPSqeE3J(L62e1gu4aE&N8@^8HaEOhfYdi1YmTeqHg?o&^DL`~eO6qW z4Aaou`nBIezk&3uz($9r43ulWcrpzh5-8zw*XBi^W%-IAMqoYD$Bu zMhl{bqIl_75Aun)u+dI#^<^{P|Hwm*S)BKw#{_!K-f-*CN{}$5g-~o%=s~^~sSYRGs3K~JSEz;SRM02tY9i?>MI3Csr795x6cEpIu@*H>X)!bgtpq&( z*+JsBbv5?TffmM7av0|6vi|GjLlfk3MwJoG{exJ^n?g1E-)|zLRvYnfJnYmEcbm^x zo9JBcb3-dES|C`A4*jDk+3yq0K7Ea)^kS6sRwSpkDx>Aq{sFf<=^(yw>yeeo(ejmp zW2_k8%(Tc=aKkWzlq&mc14-v&NiKClFp6MVO%kJ`D&z-G#uv2rxjFkm^5)unVE6-- z>O9O}XRR7eFQ!AI!g!r>&N8450R%^ zdf|Rr+vobb?}pYzy8u*%UkR{HjYy@R8mq3Fdg}c6&vS{M4<$G2s9pD8`#|e8WM_Ou z8NT=+e@0%J1X0K@ybo zfjxWJ2c`v(tNF(Y*^ddtAQ6oUQ))wMfx4LVu!Cg)IiFThwz>f!yfRc`?pjrP3&@Q` zlVR=6PodB^Y04JM<`@vChi}5n+s9~ikN#1Q`H6NH&z?54sI7{Kwm0a$qb^UG!e`n? zYQ=mD*w;8IKliiF<>#ru*{)2iXSkt)@h~?#`}5rxm$&S?a_ZPG1OUO?veHg2g&<}T zFleVk&{jos<~eFb%C%vTDC%0ISi0C=Z9Dxb$+k;Byj4v<${j?e&2RWVJ;T3in0nonxO{U-eFyfX;BK*%t=0)cgNS={QQU3*z zqD$ZY+WGr&YMQ(V}#Zf_P9rMqhrh9zya>6j~qO z+osh}3y}W$-OVy8TMB$&Z^V6_l$XY_8F~pU#1#~7&iN$k7W;UY@~R1);xB|PuI=;< zkRSdN87WpPp~)9w<^Wo3lITHG6zRz&6&AJ=rnvfmbehp(s7QV*bf3xZu2@{TxX8j! zJr=mH%2)j|`rc2EzE=(>^r9Z-$O@SrYb?-kt zegBllSm>qs=g5*T6E6n4o8H^T`}G=x{I&0dDQFKrusX!A0}G}-*!;;YkRbQ^ze(?2 zO?QUmp?;gOC@>Qm%8H|(Ijg3>-MmB%FO{iFw{=&)?ZS}$qY4NOp{HE4zcM@@mRwWe zO$6DS7Wc)DDmVa5ufJN;_5o&w2*n3L6UfGq2s{J|Z$#O=?{6chc)A8F$KWpMKk--p z8MQq33a9w6%wGjfpsd+7nk`G-u(Xt5CF+zAMF7T;O+u4w0d(Y%G`+*rYRG-}Fw1a@ z1N;0D+R#_C-TNQt6u7BqwtI(=H^wO75?eHd2D^^25=YFw=v^Pc0YJfzrZ5}$POfx? zKYqbgxcWH$(60#ZElAvF$akw9Sf*&!JftnB&XrKEvlq^p06<;@OA_Ma-~g`y`n89) zs{SCu<~ZqejA$aYh|^M6y1iy9vqGH;IK$z;OfG|Js z7_s2ZCkr&)8vF3k-OBoX(B;AM`&{p*{h_bl{Fck}u^Wzsb1_MI zO3c6g-8YVIZw~bUO5UT~u8swPSBc+KBnGxg-`_5YjWM`MLU2Ct16|6bEQa8u_)NdI zm1EHx(k{a!N=Ynu?%J1#B(yw2g`Pv+Wv=uKOdyx6Rr zzSaPcn~rV-1eT{!(_n7@V=#Rkm^814@Fr^QRVs5x)l;Lj&X|rVQEPkcUn--X<<#ua z#v-O02kg~c{6RLZv$b$7dzf-YZfrD4NYSTEDl2ZHYUlVwLEY#<-J*OxJa7C+k3c=& zr&Ucn9^i53uV_H%@9^6CQ-Lp^nftP_$+uo||7AVmXvzPqYBpCs`EH&Dmt7E(55iawfw>-$gGID%gL6t#%wdzNIU zsu1?q-}I#HyQ>$aRVBX|%<&a}(VMjplImFPm_mABUT>4<^px7hna)CRaKFHCxgv&C zL)>Pi2)I2N#au~kEqnT*?c#{n-uvA0&a&CQObCTSK z?mL@htdQSHHD0m7dlaZGgodcFx~nPY)}0=D?=UCfC!Fn)Y|_hDj}f{NBXqoRZf zn=iB-Lje#T&XJJC8aY$cS!Jwnvccq%{KIL<-(-7wLxY$0> z!FVVk1yZg_naBVIq*<08KRK&Lt~LrN{*~6?`*zv?pf;3KDfpBEHIu<7;fdh8roOTY zP74kmrfp5j6YGT!oyX|`)X4P|QOblPv_z<7QI@QfuHkV18cWwimK2LSHTEI>1pGlw z=~6pY6ZT!Y!-?_Uo!#N{C^Y5hfNezN$on5!=geL&vM?EWmC|(!52Gvyg8Ev;sr~c- zH0S!l{Ymgr&5?4FWQJLc4DRQy0B zJzx8nUp0T$|3IvaR>z@LvtYUHK%#}V@{dDi;U+()(nsH9r!^Id7%-lAt1rnb@kQma zUQJ1qFM)-XeesHMj!?)XM`%Yn!29|@DfS6j-l!hqQXD~rW`Waas4K9}j3!%l@5LK(oD7U09fu`0O%_6Fb zKRs{W_&?9;dv-(7%&bMSFPB*g#Jq1yjNWxN1<2oZY09molRS^ApxA_I%5LDKhM<-$ zIMoa}93R!%UClWlzLRKb<$OaC4a& z!Qj9`nm?f~d6k}Cm49ZK|;R7UI#?06;v@S#16imH)-R#{TEA zernHBO_Qz?6^y_GE6@45Va|`tdiL0S(qgGH1q?j9AZDY{1PsRfgi?A={>WcnFTo3F z!Sy+F5V8bxtw=~VJ$F6TN9v)sl2zvr0QVvmkcaCq?NP&|Iju>92zw`BhM3*IXq)-e zs}t~r7dE;31V;mY%@1Nwj2+*l4WF>opG(TQ-UF#|i@6{Y_K3$d zq^w71k!M?xp}%vtRbKy6@=*L9jwmKMXu&7$czoT!WpT8)A}jn>@utxylUv?SkmweX^by z0O{UfcD>e@-D3rcS`@*HIq&ET;uiUXkj%SoC48wKnOkMpB@50#qzv(;OlJY)8b_%4 z=Ro|EvkKKexf+_J)~33kmpVVYW$qDOzs9|0K!3wA_soo}{+TbaFY!ggHQSm2sb@1uc2vS92-wyaZ(#B;P(&Yu zCA;LO0*TGcYL()K02)!FGWu)*ejZmnqunySvcn5{|Lk)0R!JKCcq}o!;@ZPQ) z!wJ#XDQAPY>+8hLJQ_NpTE=0R~9Qhaq%ZjM{KY#|L!)0KaDz z_+agJ_N89OK$wusWY1v!>D2KHxNsc64gg<%fH|gxrdZ@a9)(ARgo+nj(l+`|<=FyA z2I%T8={_t>+S&o0mD2aOFl3+6?4lTEeHml5nHpH|_yLu9X^e|(2mpZP7Z_I*00i)} z0GI(BKvSImA4rOv*J`49TiKlie*cHMrF=AzhTLs2S7du61)=Kn_eR%YIF-|=TFqH^ zUp-6EeyWJ}BZXF;xLK50&x2e7SOqvYOik_hOB{z{c5;c-@l-`B1}N zXn@N?os|ynK2);7yw*r8M}c0ve!AVm=p`{!%4@X6^mJphUQ|Hi!>cDfPY9%&N4t@P z^ont-bvt>}+Wg3t2HU;KY}{bLKzCSt;N4ZrC+GC08dtWe|H%QKYc~~-q(18 z=f#q+DOyu`vp4kC5=KDZ;S1CTD@*C(ldKUKSdI{XuyfB`swd4V7JF~^N&f>HTPdtH zfPmso7HYnQ;^2dMoCuIGovl{L2Jxe}+=~5!r>sBm8H2@?wM}U>b2G5qk~|h;?4AVkd#W<7g*Qc@~;^02v8OX-XZ$$y(@=ycdN8&y( za+m5!F#kr|@j;=_7|&sm|6IIQaqz*L!;)7w$IivN_wk20kyLI+WnLDUk9arzjiw}e zjX|@5@7ax#1e>;Y68IkCs@h`j#X-d4y=pI$rS>4hIz>^eCnxpZb68QrhPIVQH3~o- zWE>!>R5Puqx4Z_Q5lC$BBye);XgPMw=#4pojOV6pi$RwE2!Rk1q@$j<&XF<5%)_lxgg&3D1@Ps9&eg zteCvQbV$9)5s=@usvr_5XMY717?Bp!k=$FdQ1k}Wn%-cRq%qpB zZT(6+d%pU-VonkR8=m4Q#FWpho$tNVUlJW`o0r`*u1FH7&|-xOOj@bVDK3}&qukq8 zuuOXgp7qE&ceO8s?{F=I$$cB%B`Vx?BbcX>-;_r8ur~leI+BN5e()m;o)JAcWwymB z_9B>=j4xXjZC}V`w^7u`+2j7I5FG_Eitx*r@6mss-YT`HN-qM&IFS*FuE7U>GUUWvpxP&`vw@g=s7QlS{_ z!js#92ykCrriy}C@JV+Dm7CsL_9YTroUJPTdczs+c}xIGA4+litP+d4(D;?miX0NZ zVm+VG5Yb2{ur;n=)J|u#Ry0R^dEt}zeX-m!!hFha7 z$;(WLx44Kyb!7`At$)sX0Xg8*SV-~-*5#_xCgKY?p87nPkt`x)qLBiEOrnoJ=qq`{mPtqBrSNtJU zayv=)Uu14y92r@z3}L+7uSNanfr^w|+i0;7JIRhCqap}g?ZH=uqNLa+;iUz$f7yyr zA|YzhZP{Hd+_Ri7r~i~0v9`!Nw~MwK6b39IF1up*g$+nKbgYlzrKx8G;`oJiM|8}xF9cR6d zz{C>tV+3Gei5*ReR3htI8H-8rf$-F5mYhtKaEP)55Ho39)R|g2fC8Iw&USf4(J;tR zOKtS5K?JLLWwl8f%jbM{1#@^Wc4LQZ#rz1w)QfhR!MoL7SyBE-X!#H+Gg3SvtpCc zCgf5Iepx`ya@U2&CoPg(FKhhad(m4I2t>X;#olMiaB(rlT~ZM@+&c=>bizm-V1mfwp1)E2xY%4X`QO$GyT_FpLpBGc*j+kr0Qgl}TQ^cKF>-q}OQnupTk zKc=%L4dm~JwieLR656Nq^H?4+bKl!vFK0T@_AsLbAGjq1;JlJj>G<)WF`w|0ca+fQJ zAaH0#PyKLz+p7He%uC9A8AElUv8bG+jogi-o|QC|Ek!Lp&zRXThDa;=069Y}KTa^! zRf!aN<6K`cbikr(XlXx{+9Ckq$f*wdB$ykx6mYB29uu&0s{UQ<>x6wQWBvB3IJG?2 zQt6mH1&Oy2{Rs1OY^~}DhnMe8jGXen19Q1JoP>x&x=-Y9y(Zr;US*TsamnOfO@AUp zykuY_Uo35U*T3%9#4kUq_*4diCdo(`e$fH!iWL*yP9lFA)XL0+nX{w~c)cik#?$h< zisQ}C$LyfZHAXg$irIm|Y@d zeMv`zp z-89u``~{MZ0cbE4oZ<-mLL^9J0evMAW8~uQ9QR6nfppc@i%iS(@m&CYWemhFmLMk9 z#FsY9jy40k5LfUpPq0M`gyGYn0CX^X8!cb%2?OOWl12oflo{MNIQFko9BxFMadn(2 z4#S5_`uCR!!v+lFEHF|S-uDaKI|K8E<@k^m(z!H(wlQP$gu91wETSyIdo01AjOj3) zY5y|m{F3RC1x5?NokrkNU6=`X#n!_~wv8ey&604&s3+p!Qxk486BKY!7Vts}sUZt> z1`DtZKcg0(^%?MYS1PA4Wcnf%K$`}XNducd_-xbegVUhqw1n$vB)`%KX^BRW1XZ>~ zu>aDc^a-iE(;3#&nSQ0m*+Q9RGU$(u4D)cPWjHK`IKV9#W~@<9TUj3XFS1CW3Mb4K zo0cg{fHy2mqWCKlNt>l2lci>!r4|p-$j_Q6%hF!Y(tVTlNuQt=K>GFK;S_^Oezrw- zw$*xeb2E`OZI1aHsC^!eNj%@fqWXg&%#G&(OAZ)gg+Y)x!zcjq$>Y8W%1acX*Ba@~ z3cM;WuG%++C_RODB7tpJ1i>cCP?5)p7UgAwF(JVlrC_E3zu-6Mm~G-x05RjL?w*<5 zvT`1QU7jO^GS?NxG=ReZ05WYAH2*4Sr7dieDeN#WoGCA0Kos(uNCmOMo`WR%;-y}` z1B9}{&|5f=Eu4MdT(RwBj~3E#Vdx$z1_aNm&ttB1g;f(+xs~GK`GTpjr9kN_a{r4Q zP+7be}EfmBWLzc501YyTOnOH>e^pSogZP^=% zG7(=OjxFA$5pg+^^nBf)`NWzSk9_^173Y(=@+OR=PV8`^ymr4_@RBeGKys^EAqjN> z7gU`2`2w4B8-){gJ1M#AQrtLf`(t}d0_mcm3#6j}BB_Ev zJUa42Vd!{sjf`?_+wKFKtrk2cmt1F(TBl8%PTC3}&OQk-aiLrWKndw6OWa^4K0qss z84?^_%UebZ_JjM9Rx}fzyOM>Sko~chImV}KpR$=VtWyf8YhQ((0ifPpPPS&H1?Ci| z0|b);Z_?ST2Y!+&w>=u*Xgs5ae}O@5VjCYa$IgqPGj6*y>B%95CC=j?NFcHlA8eE)b|_9Q}4nWytOseO5i1n+iot8Z}rQA&mrIN zXvs;Zd;Wr2_LILOrl?&#i8p$b1dRZz3qQZ5ZFV1JRD9p8N!Rks4E{^MMV-D~($Zco zv7Kq6jRc3Z6-9VH)x3sBHem$70gx!wdj>eSMy|K>6v7Xi3ASWyj7+u6Dmz(tDJNA+ z@!=$80Al1zD*GsyDgbOkSX1kWCoGJojVEhKAO4EIjnVE=#Xdz;q4AWM3aU-TCaWiL zkrab~?hN!K?%K6lzUMLq;|PQ2pTF(+^j=_3v+upiX(_>fk1{xNraE=yS)AL zc)*IVnvTJnRfKplE%uiD0c=d#fFg=mdyRMx^MK*nE|0F^+PcJ!2$qd}vVdQs2;5(_ zT#}FOrMc*vIDTjY;t1pA$c7V zMbNcU1NWbpx^ zRD3YzQ2eWuu784{-57|b=|?~^ieE^c z)&?bSa@rB*W6%6}{O3*)(8YnEJ{{Br(O7dpN8o0sy)aM%k8A*d;X70x<%jJ7pj3s{ zAOBfC?b*=s{XCrm#z_M)^nU%RGZHHR`1Nn|Z|Il4SJTOj=uu)yAjz|&0ldUyc-z(% zT#6E|Ew=-JGJUflUjF)axt6lz(I>`Mnn41ym)@=|LuteL)5)*7NVcDIlj*{M-90q( z!nn)`r!@K24d3lWezHvAff~tO<5=<{^G_JxkkZhXGBChx!)&5OtV-JZ6UOGVO}N(m z9E$;Iu1`>y?@Qqp;(WwDsf}@iF{QCH#Aj1AKr~%7`4u zSP$1=_2Ef*w4j!w44(Kb?)Z!&{aTiJ%NF7SpY;XFIK3u$U78&oYT}8O!DTDB%fn8? zc3U8bgzEXyv5J1^`4_P;3EbPpY7~dofa&W%Gqqu!IGg@tT z)V~RzK)!_nsU-70w(o3%du~)+1uN1HnL?Tar za4SLIU@j?M^9$y4m|SHfQD*|}z!GUNU!Q9&X8e^4678?oy4Y)d=AVX2KMk1)j*vgi zl!)o+eqL>Xh4t~jp?*G7x^Z}VHZW;Or|8=&K9JXfY@7B|2x zt+0UfFm0CzbuJe2KvzV%nBkMu>o4CHKMUA2tN#u+7Y6ZmQeUKe0b(&gHsOE7ERtt4 z#lr+een$5%#Bj#U=>(Br_b0k-;>0yRq|zd!@wSIMH|HUIu%4M|01I*p8Hr2Gq!xVf zbts&Gk@MBf`L0&X!sr6Jo^PscSc=F2zSf0R?r>((I2TQVBM@A+lK z>~RUwjmx%y-5i4t7L=9}ZEzJUUr7J&v73WzOG+d;u98ORaht=3$A6o{aNjRDuDDkm z5fIUtG-?$C!*Oi^#-|(c`rd+13UA(6_xJ##nxPp@${$$Y?Vm`QwQRIdc1AywYQA_j zh5HGb=j@dHc`ExdrkH{3&CZLZTHJ5inN^LRZ>&2<)^rwSGs>_}N&8+c-kit2Vh+Q5 z|GvU|%2bZ9212^1_+?f`GK@x${892mvF5Dj;_raT5jYUr!&q@UIL4Q#CoMo5bVE|c z#hx2)6?App@_i)!{$(h7tL58)9?L%;(NxjBn1NF6D6{-|MST31-w^>w0xpr?cn-V+ zf0BkSl;hZ^+yx`W*^|_&p;koQw7@uEnZH^KM)eOXzYC*&FI-;@B&W?ImlK@Tg20vo zVZ#elssNRk(QL_l_7^1nj%wGwEfdNR`Fw?D80ouhg9rTh;%pS7y~FkY(5JS+C2aF z9-Q?t3eP%mJWQ7W-{70eXU!b$5cdgPgZCqPQre~p6NaX8%M>iSs{F2nCbj{BLt!YE zv4v`kXu4@6`{uM+k^^oQ=Go&O$~IGSH(X7}r-{w97FT85+)v&HK+MzKJX6;N7Tet8 zDYt}qH@2!3Cg@F~aD!TI>tw1*8Z=(znEI-tP0juK{d3r9fX(IBgL8yk2=nHKPO&2< zIYJiYuDgo&k$pO|%wQnR~WNZ+g=hTI;42X#?;Vqx8hqH2Y7W6 zyT(Ai0V3fVF5p4|UphT{N@(@@QwwnoX0f5T$$d$7b zL~)^3#xI%CjZsQ5$JZupX~@CL`|DYsg3>@;*M1?ciDL($=+3Y4tjw7eu0G0}HdZMz z(%Xxt*U7uJCIk;G(|--th~>e2me{KQ<|ouv86%5>lXfO6XLpW2;!=l&{pWBLYQXWA zWh+{0>U#dIX>kF7!tBd@OeiVO%MKCVvHa8Hx@z)QCit&k{F%YpoEuA#avgnp)fw?M zpUNbPau3IvMn;o6&#%8Z3PkZn`tw99S>Gt28Ebj}n1ILxkdk4B15`CL*{xkE0zVs( z=YpVUnY7Zw+RD8tMxYAfEF{vQ7;i*x3jQf@B<-%^;djlXne*^%alo+D@foBSEvh8s z9g^6ajS_KX5Sz~s#Y(P^^E9!bm`HqIFjytR43=rdlkAu{%JA62(uXqbpvkX68GoH5 z(nCC08J~_kQt~$-iom!~TGgUy=eeueWPA~B6iBLutqHj=cnS36x*Spy@(R4)SbCb7 z5f!4zCO(Nt_{ypP-7PI`pmwG@5fVTKoMg*r&K`YViPx<;{jxX z$wHVd^ug*WXW5J`IAA9fOluB+*MZ$zMVC0ko|^3@``D8Tk$#-?lL0f8A}57?Ka%`{ zRVKMJtV$ja#q{fo`R=!+$`iCkv~Kgh2C;Gtl6*|H)K)E)CfKFf{M9Ba8%Gx+9Hp=; zlk0q+#=*!v!1VW*UIy;914%a?-vy`4P9-jngv>)ZZkY((n;FDIPRaiGk(%P0G%u!? zIhwQyX@RytXXDf2|1|v!3&L>eT4{Jhf8Dl~2da_iLew-J=!~!b12e2;6(uE9Emo0L zGPl;^eZC&bP0XUKVr6x+Sne_D=xC=e@6xo;Sup8YS#Am%<+Cx}i|V~sI z>($s3AVPRNqkM1H8y3})T8xJk_i2>L`PcM+fQYX%A_m5&sx{7a})=MQXif$7D3OF`l!Uh5a{*u zZjYzZ>%V26R=WuPq*0f0siGSKNIjXxO%(Im9yJPV*VZ96_ftxETmZ>^6E}SfttRpzxjia>-|O0{Gnyh$p_2+6h#T9YtuS;e<8>EFD$n|;n=EZMtngbj_7mp;D1$chrOc1MR^NnwjWQfPwyx@1 z4~s!|Rsfl;;}2fhY5DQBfsp?af;czrQjLSy%c56kWl<+FbFkh- z&e2l;#A)j)PR9`CmhMes`>x)H+*Fqw*{pkCjR03E=7Ca#uR%<+AWRao{ zsKnv@e8@mhH~?@oL}S-WJPJ49QU)N#m6bY>C3?o_jqZu z)MAACTJs$3*g3suT{sTSDh{8Y$OyB;5Fl`qUMXl_v^Jc~9f6;?@=+_)T*3d{6&1CK zcdNI~&D;=Bx;Ub20769wVFf>$V0C#f03!^<|4kBrqooM63@ZR8PKf}wz<}#??w#{) zjhK1%;pgK-t*zUilILbCei8`rJE5;47k`}rV9OD$y?C9wt6Nd%dhw|LilkI3(b@1Q zsz~bIw+rW(k{bW*U)4>%GA;ObR3#CMB!mR;5;31Su)i5RQfT0DfV!+9S`+(NclzVM zSk6SP!&mqJ{rY%zHv1}!2n_?s;H6h4vSg?&8QLBVP+2;fin~2F@)Kk0bOY^r{|E+8^ zEjHR04F_Z^^eqfP8?>TD1ezpJuQd&`1AxZsjuB}sWR=uHlxGP7=Qv|EUG(@RIma+B zydM-k46o2I0Y3>$qAFCp9Mr;Ys5r|u<`wBjNW$-P#xTJFIH0DfHYjI4IOt#)p2B%0 zq+9?_5X2})k>fqk>{r+Fvr3z5U$B|mZ`u5xwIIs{Ssoa7j(=hl=N!YGITO`S+W4228oztMWmvAgsS z#$jP+@qdjUyjH58q%%^D7VT>&7DB}-w%zz0Z1l6y|RX zJzjxGP{ivGWXq{Ho(x=MHkB7JO@VT-f-d;t;!70AiiF{gBMI4;6$zen<=><8xMa(T zFa=y;){ERb4m6r&N!58B-iL~xBpBEvO&fTV0*W|FJ4aK*!EnOU6lw~bGuGn-bNH@b z??vu^dd54I#g>Ggu$E?xz--8EPd#7XL&u+cV){T4elBTfm@cnp+Bka-Lfc56vY(lM z`1%G{-q(4UWmZ?5r+G91=0Q&GtcClLpu)B}fddw|*3#d`<&6uYAM=!F%q3Xv8=r+* zOsMw84W?P7*QN>*K>C!|lU3s18!biuK8azq{IG4AHUe8YQR#ptxW1s9wMa+936GX) zbz%!QSo1vu%!_OboaM4_pyQ`JjXK&(3*!)LE~!eS7%3-Vaf|0cOIETrZ;zZzmtQ3N zPNI+V-u_M-jl$7*{oXGNl4P@$ zCO6zymF6kqlxOa{$Bpl{a1cfE1A(>-MUiSHugNS2!vpkmK7lV`BhecdADKmAnqZHgHnnTe$hSRbiQrTP`T1I%3L0Alm~Dcq z^bqO#c67I+Q|^&zT+pI+Y;`7!-8r|t>u!8D+tu@=1Hc4gD_vR#oXp7w$FDq%L z`_9u=fyItR-;U4ylpn9(fSr5I?9n3cf$q!uIbZ3TL~JPxa-BQ=G!fqjvw^=6mzY=T zPBh1vHPP7Led>hoby~Dd({-G_+-XCam}e`6c@i1&rTJgwB-W2P)u}Et%bi2N(b^o>JS8u#s@X>`KY69KNPY@yq1u>K6Ry%!4)BTI%8D-mxs;6Brk5|Z z)HpUc(AtE{sVWUibjN4&!6gXM!qQWu!K&9;c4ZTn#zLLWuAN735{mu}OiEl6`^%fe zmJAM^Xq!wgT56P9nkaob$o-=;!P-R3S<(#?4AYZ>YmUSubuC9qQ?({Eg+j}b3(GxT zbl>WVA3E6DCpo7se2D#)XnAZfTt3Z<$F94k+F`*Yff0J4kG@`u`S`0(mJ*#iCK;NL?+?&;c6$aqZ1Z!-OmrB@;Jb=4;!`TQW?Ii>Ym_Iq z9=Bqkne)ZfraHdV5Y9;^l*gG%_OPQbvt4GVa|_Fj%%X9@<8HC6346Z1u$pMv=`G0a zH9|uX|3ixx2ltG9dXu$2A6H_=-{3#vtwK{968>5r`E?<=Bc2rJewY|?#3*Al#5c*b zXYB>wX@9Wj&D)i5ZG_vPXEo3Y?zay*yB@cm;ouYUT&ib;)=M@1#1Iiz;PWA?Gm!3I0%0tRo?Q?9uk6edz0%ZEE@Fo1^Ww9oyQ#&SU}&2(vR~v@>nL^Zv*mOVFN4 z*qJNXnYRznBWo`V?JUjg*oH&ToRXk+sykbdo6DlRtGnC#kxAeG(*C@RIQqf$bvM%| zYj?AQ_8w_>%lq@z%0f+J1q1o`p%ZI<@1KeXc<(_ZC@RFt1uPLp99PfR1vC8lA zZ-1B@a#@0rcn2^b8zdkFG3G-IYPymUM~3N_X#P`H@Y0pM5cUb{v=RJ57b(zHs$%C)LJC z6Ix_dO8I>;{y1a*cQWmr`{(|+KN4CV2+J3@^ud0}Py3Vq`Oe=?ST`HtYA58o*Ee5| zKZV0)-g^<*owPXBc$Kr1*5Ua!pG<#@Fjb!n_=19NM>Z!$THQ~7{>##u09%{*YdJgJ zG@OK2Wd-44k^9GmH}5$7{*}DY?t_C$Vj*^K0}BY$uc8x@iavs6QH604L`3toPodM_pzqu-a0`{EbBa5vUI~Z1rmt!T)sK z_xhK@(`U4B5SW%(%6EU|)qPqHdH*?C0fR(lG5YYMbitu`I;!K#I5l5ALr}!yiSj{h zZ#p+ywg2WN&!^rOY)br^f<)hxvECS+I=@nXF$EnBYYA`l)vXr$>)Nl_a_(K4NR64T zx~$;)X4d}6cVi?`vxjcOW^0?5rRFR3Yn%=vf&+#^T0C3L7x534A4*+WpWs2Uyy^jy zD-0y(9yy+sCyXLp@3ytfJaZ7+y-|OjXS&~yZFT2Hc-wk&OCO!6=DWa+=H%dN{>AVM zRwIrg{b3uHwylv(DrZ||x8*jLbsNr020ZD&w>=E(@Lp1F@UPT%a$ue-!*x41m@s5+ zEXwR}jVg3N^5-92&&E1qI~CkQFAk1$_lI(6HRv#cz>bw4v#u%?V_D`R!S@OauJy7V zGfS===JOk4al)>BuFR?A`-v^cnZb8w9TjjMW7BY7Ng zT%ex}LM!Br%Lx}=j#R~PE+^XF_$mBkR9S-_PYhVR%Mtysfgg$yomjan)sj6Qv6WF&ZS3Ew zir`^?K=Yu>y6u2#Z9=@WJvX2>(bZTw?Rk*OOoLr$s*L_3yYk~_ADLNYs-Sg3ufq=O z7X=>-(`#luweyJFH$AFIczn_7ct!FVAN|0EV5#LP3(@!1#R2V4LSH{hIW2pa-nS&b zl+%CqO}F_nEod!U&X@DX@kQ+^-0Jufssz+7Jd$f%R*kr^ZubJ2op$pzQ%_p1jy-Fy zNR`9Gxs z{ae;HF$_&dlev8_ya+W4xcd7j#xreYz&qLKJyNd3g{AXt&cB2Ua}4#lbefDU?lkYE z>n5zf_DZ}FTZKw95fJ4WzY!mKmp_lcIj*hX{$LQ)^EaF_7xUbz;m3P*+FRb%pT7Q$a5v4)#$NBT>JNKi+g7Ih8_M}0JZ5LkKsCunmEN8r z0Je3e{qc0Ev;5X)C=${DX}f5KgKsO$^twnM`# zJgJ&(6>#5jnS0s~BJq^^5-$dIK0BxPAW@1@;1yCF9XJxhCeDL7RU8%&1@Cj$klk2E zJN2U-TJPRypTE&3ka~I@p91guNEQv{m0IGI zH}(;4k}|DYKmNNAPeWF`(x*6c&7-=gG5H1)G(P*5FjYX#1{l*&XqgUsIpy%t*fe5n z)bWl=vpZ*4i5NMwH6Xrv`^DfhuN5iH1Teow-- zM#8QR31-qs9}treNWEn7^r73SpB0@h+>Y?H*?X`_0kvWgP3IXLy4nN>!iL_~aq>8zF&daGwZmqG1GM9*_6 z;53pc6xZ5IN8kP8XIr54X?~rGZ!4YebZq3=@Au<@w0&3m+rnR-5)wpnJU>Mre{RiM z!|OTE>)yp)V{My*Mc=*R;+yw47zwOqb&t#U(`^HSPS%j`YPj++@v8pY8rSN= zbtOCeQ?nT{AewmrtAgf~+O+ka+8WM@YGXmfpAuKWFRx$!6v>kgPlZ{ojfW&;mz?<* z-t(+sE9)F8NxSs$pnUGN;mu2Rj3r+K;=o){u1S?uyc;vEHC#keyhSGnhel$ys<{rsGRGxvTv`J`DBF4@;=%dGZw_rGm_rkocsE%pPKOi5yN$c)dU{09#)6TJJIf?}j_OXMVp_-?*G!kg-?@aO^4_%s zmqjlbp4*1cU;36jmsb6x&DwK27)c2ItU2L!tD9ye7CGW>{9_O*t7n-Vp^@HsLo~Uk z&dzZr+F5|dhHm8k%ToMYkR|Q2fW9ke0F!r9^A|M`Y$S(Jq)(nba?TrRV)nlj$&GbR{at@FgQW$8$>hHJbdAiw|yP`p+lnDKw*<=ax1Nng6I6 z0IR4um!+}oQ8mh}v?oK#f80?A$A+hwkVOuwq%Pu#usVXK&>B zM0#}tWEy#17GpK7uc8Q%gu5$kEVz$+I*^7>x(bS9qdNiw#S#p4Y9Wg4eLMvY%5@(4 z7I0n{rk`;TMM~eQuD)umv)@WJN|$blZ{W?TVBvRuS=hDX$$q7{aw+T2ZB3{@YrWhj zF$x|A+DQ<_kv?I{8CWqZR!Njrx#x3+|7YRN>qe~UZO3ZL3rH&Jt4OW%Y6|Nv#i~#xM4o-3 zK)<4cCuzGzlHTGPi4Xh193}W>R1T_B)~~n%7WD_qSj4I{)_xPecFZNLW($!^>r)Ja zuzv6~I$G-O%n|`ly!KyVhkY?d;WDr^D@4&HR;9T=K(JbV zU0)+fU)cg8?>j8w(w8jWuNb1Q0WA(*7z~uK4T}26%I7+Wu;z=Y)y0Zk+J zt{2TjLq@VFPTSS0;A7N5L$jP1!y|}V2vy70D39)!=HwPtjS;H#5l`zAXJwM4fTico zVq^eF&X}I0B6Idly$CbCtROwHIk21}MA24XIUJ%!($~~nPpS8{FAzn|PRHkZ##$@nxD;@KqKP{NK%2UCdL zKE-;ARSROjq`w_2K2TTp(hak&8uBT(`BvcQXM5}e*Yev6p&lX8R3nLv>v7t?K)pPQ z-m~Ct?E~BjmdjdjRWq6?@AAVxaaxSnX2FXzhahHqG=r^f%bcG*8iYLl_ITZZguJoE zy44D{Zj+HbP?c;q+On{?!QPeg)K9og;$ge2q#gdog$PM2lW0=40b7w|qS6__bZqeA z5fkkQfz@~LrQk*SEVBEdWcMnRq1}LS0LXhzW;h<`eU#l7Vc0L2$w17*88o{dMi(KQ zhi*y@hcypJNsS~lk7P)V7Br7mNR8Duk3Eul-O>E|n}OK%9Njs68nnT9)FtuscfMvr z_aeTTE^Uv`Na<3VCp>b-4~+IKVb%k_SAhUs^bUo-1-m8%gv^>9m+rgMOkIkfGLqKK z)1@MeaEjk-iTAsNvY8mK3a%+xwm4=yxtkukD3~iRm#d&8wlCeX;5W3?CB4KvusGBL z97?}Cl3G~Z$w2R7p)xD~cC_9HD2Pb-w_l{VyW5CA!pc6v8i2ubXT2(%Aoxgt>{IEz z%^fG}-5K^$jh4&0RLS1j`)_@@nv=O&6K^-awN&YuZg=c%F~@E7-BfRtp;$ipJyA}n zz3H_5Xzyqjd$Nlin9_XD0{?WA;^h`3e(Q()E!R;3_7Ln!2OJHdf4<{;SH0DH*Vcr~ zz^&?*ak{N(d7gpgBfj6;CZs)G?A)K5w#JBCC%cH%zNFI!j{%0bza^}L2l1CeOcvH3 z;h=b3Y>^fPi-5;LQZEFFlfFC2Si(JXs!lU0EQ258kv0z$c)9`XT06c0O_F z^?<2&Z}#YF23S;DZ-?4@%e6B2Tx5&=&Sq}FK1%}HZGF@2uYZ#L?)~9d)R-Ea6Z}q| z3;OOe&$ElX@K&BwV$Ts`I?IlVJ9qU;SiqIrYRF(~LiW~dOy?!~+djJLl; z8XSbEwb5QH3=1q=bE2irl~4?TC~X@+(WTLZD7ZsH)n?BX%IwDn?O&J8;hQ6{6`j9g zKv-^zkt>RgZWD$C|Mp6iW|`yqDlcRFR)$A`jQC-9@;HSxSpMP@(T`IxN)AIx!JkqN zI3*QgY=X_1dI4fVwDgac*&mhP9_&J)|1S#*p|Y^)|33?h`sb{QCiFwN!*S-SS?)9d ztAgKB=l<1KtdQ`-MU%E#(;UW$bQT=b=g~qME^s5Du&x8*P^x#ij`x|U#47w@d=Olv z&mbfz)4r0mK`G(ed69&}ff6x8#1G@9?Kk=|03=*oHwH=z0i^a%y585#7V6G z_D_O>a{2NBU!u{+K6h2X;EV*DB^?|@$JXpZfWhCt_HASo<#Erhu0M7 zZ6gaDKx6RY2eo}Ni-d)qFN@~JQ2SZPU~bN6EAumSD*?$@?%oHX!|%swX-S7nY8Y6v zftZefOWuQon zg-LC;$-gOMdKo9|fXdP7}Kb<;x+eQR^&SsgBCPHbA&#mPX|Gj)-U zVyQBH;@6A=F=u{ch-kZReX;L@WG5ZL9ACi{z~Mn`V{#}f1aKf8y#d1=o>(`_yjw`n zW9JfZ)Zt?iBrvI+ZaySF>^SyFt8l76PnTu(;9{O37z?d`n}ZuD)T&k&Z7K}wMn5L} zdr)<0Q!8u;km6(@gGI9l>`VqTP5KbI7kB_rC3bN2i4q3~^qi&(qZ!T%0{~*~UvM@n z?c2Z93#`i0gY4+iJst%x60yL~=Olnmk$j?O%m>*I91$wKn@yFO0eu71(#x-U*@`RC zY6_!t3M@QR7JU%;fqh=2>HOi_R=DK0OtJU{*~hF<01Kk$0!U6}4Dr9P^x{$gz>rsQ zRwnE!lz7Bxm; zeGE0HDys?)<*@XPKBtEE_}9_p0;t+E_p!f2LShnqjlm z)%ILp8wEpWLRS6P%gSXf!E7fm1zy0OR|l{#$VsBI8$b|C+7T3{4C#?q(1N%dXov&W zm_D2gooNEyBeM&L0t988IS`9Rbbt61O=B^l{jtUome7hmQpEUY23Eq(R(_$dBbiZ( z&cxe-fdJ&Lfa%*RXC9+^i5s;5)#sGUoXyf4Z;=hNd*Q*(16BRxYLIMx2S;bgq0D@)L9+k<)pE zKu{$n&;i&>QrGPh{uvNc&l)N1>UvNV0@-?h$jMu6Kd&>6Y8H7%1127;P6iLy}2q>sE3d7hvb;} z?H`4`{*6;}Y!zZ=Xb_8dv5Dy)RPGoWZ})`V>}<08cHKzb%eYOQz3byL>$27K`HSvw zG-&?hTFun9_{1Z}SNC7ESM~~@bAS_a>21kik#KO`zfaYnUN-<~zI8)yP%{%ZHe$Oi zfv*T}=;`K(ZY%~IX*_1=233eHn^GD$+XY0b|3gQ9wfzo;Y*ZsK4&Xpe z<;;GJ1oK4e&NP|Hw?1s+I9mN8i;tb+cFiepXcn2DyXRs#y{3i7GPD=?XI=hbk_o|x z<%wezTb5ZuGrSG&SoZW|o?2WJSP={Bb%OX)6?=)CAizI((VWT4@PsL z^Ze@#`pb4-s)zWY4%adVyAC+0Ctk4)Fm~V(16h-&Q4Bx1JJAPRExyaqCH?D$qrjiXNyaY@2S>NGk)7FS2K0&!KORu&fh+@^@-v@h!vv#* zK963y^ZV$X-Mdo$pI7R+=sEP@^Z+JAC0PK+9hwdQb2=}-cTU>wB+~>#PPSJ3$f`w2 zwMhYhi;61k8uF*#&ic7$pItxuK5uuDo!N89p!QPV_UxGZ0+4*hS;VkA68Z7h;KA$R zKgV`WASeL`GC4wV??;)+16s_cAwmS!6|Tzo`$e=S!^Waahp1(rdvn7wQ>}n|R^$wt zpJ|_w!98*_G4jjMov~kpr?moqs?1KYx?ZvD5>vN~VA=wnV7Qk6L-b9QHAGGp#7btR zwy+Efs7~vGQ=h0DC|zzca#J6P)rQAK+-Aby01O7qG9}~>mQ82&6(wp8568$jXv&%R zospFlKq>%Mm(Ik6TI6;faKAwCSWt;QBPZO1Ct`-<*%TBa!~+b!YFZt~0_ZrVPV|+1 zH4H(6mPi{aA8&US9{-#v!CN6=_6QZxXm+S87Z;KQ$x5ntk`y}2Gy~?Vd>=EQkSwHP zajz2{cANk~CvI1xl&sGM4S`sufDj6krxNz%@<3pw!EHHFC8{tLo-V3}#zt3^Cl zWCam~G`{ahBP?jeYz1ela#(-qOeYca8bCn z2ORvFWK9Jf0uSS*<|I*sv^>SQ-$Ih?MCbuU+(A|_JBa4FO5*yJECzhmbB_B*;>td_ z%qZWC_u=XDo#~~Tc6W;dWnDYY8+?E z3))=b*&5TIk<2C&H_7=NzTPb49j$;BFfRc>0AO7#|DQqnl9hPjh;XVu99lCl3K@-`a30!#U&4(mo(3pJo;Ti;wo)ZD{Xfy?YL9gSzOxny!6F^jFE!nMk#vLkZ&U~zfy z8Q8#nvno0wg*KU%}$RE>?OhM7^bZMD)1Rdw^VT=ezI67{Db)k|ZQ{~YVUV+9-~ z)v3MJ<(t)4|J1shHC!`mkdshWFvD3bG(`PrAaFOzeXERdYD|b|Oe$&A3cW)u6=}@) z(-`%wB1^p~Z=vyrV^dK{6Ct9qWTB}%!baY&fdHwq;I6s*ttro}v9aqxUP(psp9h%| zO(gopzi8A>7IJk3v4}@Z0f;yI4=1u1`^*@-teeT!&4ZZciT#IDl;+ti#3wv*2agg7 zZh8{Yk}%dZ*VPh5{~&bXT!mhJl^^hJFbOe_BfXbJfL9)ZiPS}vp+%OyXa!z~ zp>JNH8=x@0Cn3J#Q7RHeZVzhjba`EiXpp&454Cx8MXeg}tHYiJ65ZzOm6%YQD~Q<@ zDpdZscm-aBr*ES+F#-r79^@7l^^;S_=8D`;mAYzW{}L~k)NlAzdo?{_ZAE>fAl|Pq4qzB+R^Y{C`c5L_6wtDT zMx6kSEmfR&3G`nw@)I6Gv1V+cv_4y5TqGisAJ%cE)Lt+v!*D;-;x5sNcv9A#AGTO| zh(YFw7u5k05 zkdTWjjGeOdxfJ?gYlKS~Q^46mi-9|wejnt0Qh(h7ZM6bPBQ}UcqZYA@#T5D}67pu` zFgUxG|8D)d#ItvjeYaXsYk0&kncnRo1BHUvArHU=9#Ti#$|uaKygl6(=o1WbLYBUU z!uT!gb$s%09q*Hl@m?#&lDdbld@PuMTK5g$>Ep{7XYt4m4em3->nUEISN_Z|T^@Y) zN7oVIH}_$U06b~`&7MEUcPVt-{$;b1USIVt3gh4hUe;eL2tbOykT^I`LZ0BdK8n^V z@Vr^m9A(fXhBY&_9RaM;XeRvR$eqIDyJLS&iYIvoMSI8IV;PV97>b-<$J*3f<$aYS zb*?*@`5$`fAFlrES=ppaz?j0{asG+78&yo&Wrz_nef$#RJQ+D5b*}2gyR4y3Wcsu+ zqOhv;t-#VS4HIga*prK=AGD_auPE`!<6z?S>(|p45j7D~@9+9|K_^k$c*G#FwG;p1 z=ROBx8rq{JhS8Pzi_1(J*Lz;A_w|uI?}-dWM7l0(#3p|F!;7|*X3Cf1S>e{%yOu>! z~vI5ILEN2g1_U62#y@ntCjd<^KI(r>~!rrB8CVZgL&UA}j z(fR)2D`-{e(;^Fh;op}v{V(7C#xFG!=mxS7-&Zj2PdVQ#&pC2WihP(BLoTsBTBw~z zzQ-~^D&{aR=hXRG10>+sEE9?ik!z7yO(pW$FG0FtY6H~cJMpD%Nj z4t21oo%Rclcv!)>N;qJxI!HBN<*xqz-SUUhSwUUTxr~43PSMB#Jl((w!fl65@0MM! zTfWibN#4ps)_>nm_zw0#sG|?`vjkL1;LmlL{gl?9d80>Afp2a)+xXO(wI7FZ<%~>w zoPKX*zPfSWyfAiScQ-h5XW-_qvtHyIfZqG;+rs$|oycFQOvixWZ?M3xc%22@<5jgi z&c9g*kv+ygk9hB0G;z%Al7IZ$weojr)DQQMzwd)kZwPdq*q{58zsw_c@z&6A+22jC z7ERv%@pyiiIe!?MjT|IUr4vZ*>LcR4U2QaAg4-(p_xG>+??cPuzPIn@&oX{In?!xU zGStW-g3HnONiaWk{tbLZcy%cD4=#}R_+qU|oUm?%LGc0crK5yvkFYPZsPUbr-X8{v zFMqYF&&dMXB`e$CVgJr?xGB)ou`=Q1y z67%F+9OpE(BYy@=8(e*xz^@e+u+bU1yL;;VhrB9aITg_3NGsm;+mn`$ zO9;P`qr<`O60sLicVB-y=31P-K;GC@cq0s^QI!?_A>O^yRy+;z&hG9zvn5ZP1qrJ3W0y26)}Y`e2GknBbwbmf!Ai4Tf3>cJUR$aSLCM(uZD>?|dQH zGy<{lf2`Ym=|KaRwTJD6OhBD;cZi?n2dazja`!>qxmakfw2-sHfu6ACiLtoitmhL; zl|{{Omf3$sVR;_A*$Nl6er=m&A-(r~ge89qw_EFf^xQnNHsr8t7d6^*79BrS#7uXy zjxxR_GtJumu(@cQ@?#>{>H3$lix&f?DzP;2G<5fWo3zR*E%E96rU0 zxpjJ^T)0_8OqK57Y!Dj#`F@;%&0tn5l;Oae)n$P$*z=Bi^)I=|s%r0wds@33B0S2S zLMzcsT`Mv28%g>E)df|3K)s+IQm^^}UxO$r@pd|^E4^bYw=BXCGt6#3kR9R)avPHU zI_DiFwVvCve4d_`5bj@rRzEhhv-|knQ0)Ht2u)=h{aVQ4Z7ygHf6A9xifUf#Qn-;?)9pL=ReR1GeG#Mj~ z%hG`bWj(+GwCF7Gze6D!_c@PI&)^Ijj1Y5;2KDh7GsK&m9CowJoQCDn@GO&XlBpV1 z9CN2cy9)~Xh$gErz+$vf^aYnz|}X5g%Qkp9?Ze$daSp6{&Nd&<*DMg zaZphVC{XId>kLn=Z8xz2z?5lx~dbXogXvb9fyysVq?oB$| z5ti~R!X`9&s#y>h8y;F&6CIlUi?Kx>Ah0h4z9s;;vqOPD8^#7A^u|q3tm>xfSF9}uotoj+%`T~hgza45Qh8@NznHq3AIGsEvXOva(4 z;@3poxheFZ9n+!XW}JPy;=qH;v#WZXAMzjHJFNn&irK07H20HbtANEzna-3L5>2tB zucYcix~GzKeYq(+W+nE$XnbwzA}?<0U4}*HqlAV0HETzz>BznCnZ|Dj|Cp~)3&4S2 z{wZTY?q;`%iDdwUM()HOEFEuHW-BYvlGucCO%Z zZF{Uj`}ZF^c_}QqLdNfIn94h%r2#_~^Ebf)2@2wAbr(}pU%R^-i$7}hle_Wgy~6g# z;?Z|8EZei4&4w~z7k3IGeXFB-pUPFtGH<<+5S^;xRl0rRtn8X-2m05$Ny4G%g2qWcoFAW^_vyc7V8yvM{r@cB$ zP!k)g&lL=E|ERS7Ku&FDK+7y&GV4o16|Lx8_Tl|&OJbVO@j!rq?CSan7^c%y{*->FRVzWm__+K1)V}G|scP6+IL(inMNuPyukT;@ z`|e)Qm*~eYSD;~$4viH{hqBt=#1mgMil7SF#0dyjpV#VG8&u8}tse?|raFW`#!RlW z4{tKLv`FlgKcAmdnG^hO33~|II`xS8tt-`XVu3qhCaXg7u#(mpHVyqIkytiA_V^ttb}7x-@E+iC^n4>JYGv} zr*Bsol6aO2sBFh3>ky&^i^xCpU*zuVoWQl>926?&viPT;LlhO?=c>+-dN^2nRwJ=R z;>v6#@5fQ8LNculT;~NZIey|Op7QKO&#SXNV1X=&lMsaK49OtWrROD4w z6xv_I{jf^sg+?5K)`F-Na7|A?j?RN@Ao92Q+>*|Bp!E(GqMX&^4;^w`8@efE6lR`u zZ9^qUkt}LJcVsrO?QBr=Fq1(u=_(wcDH`6P7)c){+oe6a+sqh!IDCeKj^v6bgxC(p zxaj@_4y#tpAcC8c=O85JMCFxhk%9j4R2rZww2D!IQn6{T#?BR(~xIEl%3uYI+Co8P`OSw^Vabegu z)}P+|I!XKzcTvwV8hsqUQ5OIE?!~R?i{DrYZX0h^p2KkAtltM%_cRoL7>viEY3*^S zjvM@Q?q>P>gVQIEMw-W8GLAI}>dRRq-NRU3T-1Spig)s?&wS0}d|?@RX64iUj8M~V zi=mzA=k_TRv4m*woEcC$9u|^n-~iD#Fh8>%$o?U#9*U&T61s=gmJ_@d3FblJo*MN_1Eeq4pZ zYyPtlmJw-F7kMco>5_5&>z|-Pb+4&BlC9qqWtQu$f@Nl8C$!As{RJ;^k+{p3mPaq= zPopCZkf&pxHO%HI@lrL@0gRTh)-ZOZ2}8{plfg?PP<0D7^;dD}c;9$xL8!A~aufx6 z{!|q~l@ac!MU>gg)>+=zF@L;4Yt#6|>8YJcIy{W?|4?<-QBB70!(I@hM>mY_?j9Wi zg3=+abeH5{#Ar}J+R;cTAPp+rAl)Ec0*+8nP+s2O_x+yVdH>zn**V+U^K9pH-`91; z+II=1gEQvmUJ1muF#VJr>!-U!;Jlz&^xZR|afFL()kSldev%*XDK)XfUTPOhyMF*O zgHsl%{c)aqEIe^qip$dTi#78P7_k%RGq8PJYGo9Sj{RY@6n$%!{!=OgdjX{mf1Q=$ zn67P5r=5;a4?PtLBO(hoCXOKDnIm`#Gc;v7$Fay6&Z0#45%2^gEYHC#h(s)MATcbM znP>!3qN?@x$K}r!7J?)3j}VWF6wFc&ah5?A4{B=R_LYw#D{mgKCzv+U76C92=$T6> z!IEVy)Ut*5<()34AmXa#=9Sgox5pAaqKsiZw1{?&A{~~TVOxIP+1xnaA32OeC%4$V z4zW6nduRQsx_tIoz>_>Zg21lPFM2Ed3ZD|zMa_wHam9yFOIRVo)=>t$_j3b1m`!$7 z8nAM`u?yq!CCYk!)vBO;DJnhI8)E&^7^MvUIphPgX&L{3ap=C~sz!rObLG~DJb8U(Y&`Vv4epi^wan@nwu){LfOI5+148-l?J!|#J+=aKmYO$d3<4GSra&q_qKMrB>1?aHK6uEVrIJ%Yu48GR_(}p9ucNVYtxt;E6}rM zR|A{hfwba~t1In64g~>M@O?+G1z0 z_l)`Cdh4dweI2#8-cue*a7QdDN)C(1Z0Y{9A$-t~)^D@_vbC*u+9$%R9x!XE=gZ(m z0BF=b_Sjl!zNO?uksn&(m~5EoKNsJDKm~UUI8l}``Q^R6HRrvs=Fto@a0vNx4xHu= z4*UaoJI{R^ztnBvREW99b8<^_Ypqu6qWxZT+s%)U^q%D3WB=PnnSsSH&C%FvKIChY z3V6C&tC8c@F4^%xj-aGIjT*y~=;rzYmNxM_}l3CoZ+RW@#)bk@1 zMLaP~6dsihkK*&Nf}_$?CTGP%w&0X$uz4rD^Pzz18z(w-1Y zvg#Ak4?~iwoE=hK8b8^d=_MF0ByicYay=<&&t~OqWVHzadQ1UnF}5-l;~#QHp+~7k z?ng10cnNNhA`Pm^vznFNUuJLwTBjD5fU>+~DW*(TN5)_aeahaTG+XS*hz zyAim?W@iU+p6ik^6a=3Bh}gryvlC8FzZ~q-U!L2ZmRtKMi&q>L(d8F|9M;?AQDy)p zGXOClh7yRtM*sNp44{&OZ8qg)#*J;h^y3}}^T5IanZ1nxSjI36mMI4N1qLSw^H&lZ z9*n`O#NbzAAg!2(GjY&0nC1}p)C}Xhf+6KP$4!e-=Jp}btRRfU)*t?XErpAmsvIN( zM6p&y*ZUxNAxJt1XbSig0wPKG!vBuzvnf|kmE2SD0(art?m8smVQK8>8;bt0-Fs34 z{U)R>rV#xuM-(O4%2P1&E-D!C^al4{?P4>)Hnu|2n2FCg6OF@5gXCD;;S}0I2ricq z6X03>Wz~nu(xGz1chb-4U@X`6 z*nxT-1zRWD`zb|2kcdt}=b!f{>?YFSF50*3W+O9L~Q4PU*uC>gjesB$mwl=O=KM%Rhwlq2CE z83>%RCHC}tarxUm;s!mmQaqGU^0kW=5f$>`lS!P>!*ORNHDZDGWwhV*pukIt$v?hd zZA#wyUMr_uJ{c3tJwQp{G)5}hPwnYc{Aqrh#JYrtcudfknruvIVa9Z=S2$)mS*^a$ z)+?XUoIHgs0Qsc_oF)-ToM5wlMH8;|_o!WUQ=zCH69c9@aN8R0bZNq3xoMnAT zK~2b~1}sH*$o;h2t(VeoxyLUJT6Oslz-noiw^MfvTY8-H6ga7WqtLi|htI!~-&LvH zg}gjURyx*g)=i#*_{g;Few#Qy(Odl1dkdMAYOgx-{|a!@|LuRj-GsZC7HPiq_0L<% zNs$b>dXOpr75N_)7S<>&xihwvlBmV>`Kw4-5b;oK-h9c6-QI|5 zgGTqGi#>RFz3t3{C~&(rUp8nZ9WiL5^0GOQOdtefEmW#QO*Izi>!6upD56q0I&H6> z!cy)#f0$xo`VQRp>Mu9kX}QU@FV*_{uR1`k_sH`?x9j&Bp&v09)|S^ENdWUv{8P7^ z`qledEz;S)V`kd|Ufv4&Ytjqoy)UV)9qU0ZHY+VbVkP13A@7|VeM#gLC(J&$Etqco z6IDy`u3PFj=RIqdYyNI>z)9YfBg3|z+AVdBeDuh7XE{*2X2rw0I)xiZMxVR5@jB7)j`R+56hb7Dbn8=_dI-PNndar zIcLT>X#lt!Lk1grBa-?jv2RpEAoP)DTsI(@Tja}+DB^)jR``jEs_lb6}}>E{?@ z+|6rrMT4;%TYY;9gqSYiPNUY#Pv?3JPxvr!Tw+vbpw@DIIC{R>zK7TI%fqdqsQyW8 z65A_aJY{W26c(bVqqt?Y@?|y_Aj-3rF#fo)x?|ugr-sJB-WQ1GqmAx8$^z;S_rE#@ zy+e|dg;o2>C|8+M4jW17m0lwT&p$DB?j?(j=1QK95~Z$Mx1c!%x_j7o*C@vy-wp^4 z;8pwSO)(xZq5o?#+HcO-9Ov-JxOrLUk^9NWdnZ-h#dq5rkEA?JO)S=? zdb3)Z0!)`hr-bt9+eRfHC;P<^;jOo91UVs-wq~*?q*wIlJ0-XCv*~YUc4ZY^_A5tN zCwECh{w^rybR&263p9^^*P}0wTGhP|3V+AQX)Jx^xZYj&spFU?ZaWPmEiyYMZ9EOR z^8Ede8)HVmY$wOe#Oz;plsprX)GTGQaB2EI^~Fy&>&OVqRO`K&WJi74UFv;pj33?1 z!Pl(M7Qxi{MgFi%q@S#(YB;L}ZKk8iwaj2srxq`3KKrq)@;R_7BOFl@iwM~w6##YfFKrUfRUu&(1N{_}X|@e7 zS$CpwiCxD_ji35IQi8L*<ypUlWg2FOF}%`q&u1o zrFsaI0fB=bbBn~LiJL>eNsrjgli7A$X|hEwS3Gr3P6J^| z#X6(YbWePgMy)t!_pfyS8EU^eyrYDi4p#=cgJLuLzJX-0Qyd_TNhv?NNJ|TrIj{7GkLZBH?LqZLQrayt7xx8FCsrpl?=e>61BWoV^c~K(#xT+Ft za6AiLPZlK>g3v195tBuFOuYsq-$kY-rdqq%<@0L=ck5Tu(sqyE^<-7LYz^_C`|{se zc%%kk9Uj={K58}C0-Mw`IZQ9-&!j+TeunTVzM(Nqh;g9!jds>m=N-)NFhr}ApIF90 z5v=}m+3&3PT`4>1Lu|KS@TQ!)pGwnP>4IB3oH)Jc4_2q&$C3urW4V6lT&X1WXzWfw zyO;7I0&Sz2@|*bvGTm~LELv<)93+M$i5dCxF3h{SbWipEP&s3fNfZp^hTS&OEi9Ot zU6-3ghXz?0QN?`m$V0#U8rrMW>%?3FjW^nQ)G8pbWPD#B{(y*6+9j-sdQuAVyfw*5 zt;Ejhp*tGnxe+M@ht~I>%K6wlaWB04_fdfA*{g@Sz|JV^m0)ZAwqx*#(jUnHCzbc+ zxbw2vY-13n+?@4S#cr})O>E@n!u2Ra?L868->uhe*q8K`y^-r!+X% zP+yE?acx)9k6PC!!tG6)JgYCNx80ZO68)nw&Cq#4=!xQ6w5E=;*XaIK->w$Lo4GU- z`7w7AM$_hDV4@h;{>;SK)o{z0OMh@)xGCPxltvZ;dHTc=VmfMZZ$m28xh?8Jpg)Zr zk>h8pXbXH%6`*vZ4A4(+zBkH%Ct)uRvY*PzYzw_QMSGu%Flxu5Q8iuN2 zr8+oy6i@};z2W;uqk_8tJNr(>-RbK0#&asAzUhyU?rG|jtmxJ=cU6lGmv@8j!H2G^ zS@Z_PHc8#f+8Baghnsk#xO_Sj-dByZB7fV|1KOiU3V)@2^EnR^$9~whHE_V@Y9sQ& z$~iAp=v>IGNhf|YN7w;!m!T>lEEHcK8aXFsLLXMBKg?@oPC}*B5m78!gqP7ej$q&t z5(GkA=5#(kuw9XES>HMT9ivLY;omYXw3D%`_9tK0MkJL{0MKV*E%oHvQ3|hM219K( z)E(aU;*DcqQtA3!74e^>vj#k6=ay z%3KJ(GEH=+lXhyXu-#dbsjolxg*nF6c&0?>6C`qire23QG+O3YwHL0-RdRy4Q-Ik~C6!dh$G6f@25TZABZV9edhfn~Rmav(|;S|F8`Px|21#qf@ zqK^_ABqI1Hry5F7)u`!bmMHXE2JAZHer>;9L$OI^G#9&((U71*9RVl`;V+W4-W+w@ zWagohUIS|4MZ+*K8@MVTH@ZoAabQ_pK1QYd??l^?31#+xJOW8;5l`hxKpnAi7hJ$1 zpR7ay2Oz+IlR-5v(-#YtZnU=;5{(!yMwoCYzOz`+zqDfWhwFI&aMp@J(g-`0s?Mij z(VT7&x?5CBou|m27ym(B0N|fNsP+FRfDI%EElU(c`_;kPJ=SsGZT!L%ko>avf>o?x zpbFrIGgV`MI!#N)z=?8Hi7*HwEj9@Y2PJ+uyDeBU8L9T)3btULr5OWQ7%M?&B^6eH zAQ9ggqaDOgz6VI4cO1%csP%P3{#i+|IEbbe(kDg_e}Z5WMgs^z*jfY1oVzO3Adoiz zRMuVi-#qpw07x^C9oB_Zh$+)bW!KIw(=KAy?f_GymdUGubeNc=(Pg@m?0O51+PzW6 z)4Osx(RwA0OMg`!N>Ox>)2!=6vN2&>6GELbo98ppH!@@HopHox|s zRj6=ef*u~>2SnS5!T~ouwtqMrBr6;gpFjH(MT3gsol~*t?RESGbo{gDnAiI};-1r4 zrGkg%xpQ`fOHqYQUM~#I>DKbxMWffXWB++CNFY7hX>{Kq4{2ls;MeH~B1$D05JqULS*t3iqeie+AitrdgaPA6sRAef!rAIdsD4?O zrJ}9auPHjwz%silu;@~Bs>cWxG#UWyRdH1d-#Ab?20o0ZgvAkRux=efFsQ&G#$AUUDT)!UARU)@l<|g!v)$Os?lupU7}DT`Gha16RTzh_%${wfa%nhY5qq zU_y}WCW60%mDCwY77U2i7?yz9BlUA*d~?FrZGjVUaXMy2wCSPS_v%U%VAREkSWY(> z4Hv)4P?LAb)OS%5?!n@R6Ph8_2%~Xf2wd219G-p*9LzV@$HrvDzA(ZbXOeA50_J#U zjR6a(^&1AtfphX>N^Ue5YQL+N0nj;z#NmlK;&9Cs1xJEn^qO8 zRI5ztc!KssYuxn;8M&I4A-Ttk#sa?0NSLuFpp?o~Is5I*FxHA5{LB|MA`$K_PsrcK zJ?$wPlyp>)l0L!CwVjs4-z-CN^4GN})>$;U@?Io2xXXVOD*!>z|Zr!I~b zYgB=`DcEK0PP3f_lzctr_j3hV1{I-5es=qD&u3JHr}!a|)#~MPI**~mR69&C8@275UyA?(r9R=16J|Bh(>6$uuA%%5WTtQ4E6&aR-3Q*CP_ zo8e&ODKLvrAsLj3Cpd)TQoJ6k6mxdy+8?rC6c;66&R#d!@_ziYXI7Na^0?WAEz2#XZCI!xo7DMb=I{H zH~HSxaIXv254lCIr~P0)iWDjiqJs^{+CpL*oO$}0&|O!nF{1t|n&Rie=<=Y|uMjXd9Jx<*Z{A`pgl(y&xLJ3uWvSsTY<>flXmefui8-Qk z-Ab=d?D4WVQ58e=Ha7@YO!9B>X0{;=mEfvj@N@Zp?pwbslq?89Lv^4xv3D~IJ*JKFZrFS8Vit^?`JBhn zc~*(24|EYpn-eMUrIjfF3D#nm-uN&xUwC1bWV`sAD!jP4eB&k?Zi!!0yQwLN_i@U5 z^R)`&+coz8uxLGq4~*ejTo*X7qV}tk`(US{ zEXrvF7Ms1K{o;G@Gx5+E%pC*fC>>XlVqx_XQQTh?bU+iAU+{{FFXx`eG|q*(G+Lti zIB9&uY_866u4)_no>x&VOo2sEp!r09h1X3p0BeD$ON%w6z*O``#Hh?862Svr?%5Rs z|E46;N5axzPH9z{@8WeA{*UwhQN>r5wGA|@^#U)%ot$FX--%6OR3)5ML@1h#{lrXO z{7g?MGV;DC#2YjGk!XDfVxuYPT(gM5iviXcE4lY^PpR-4`SanL5m~;ndW5ae1QIrC z{`!RVY*O7e)40Q&!PfL%h_DdJ-=rd)<88_J%U+1YbX8qZ9LyDLn7<~`ws}FQ1^@Is zFw6;ScmYrDFq+%(jIs5nv7G;7C3*wPRPbVg+bynmnmF{ufQJyC0=p`wZeLYmi}CAU zs+|w*>H*mTkjUJJWQOZ7_G^8%r7s)9LhK+3em9GzJ`r1x_*&olnU4WBL866{HYZ3i zca?KdNbn20CnQ(CLJO}T)ILAe<=Fc;r2AF}t|h-ph4&c+r}uGFAa^bN%{q@FXE%JW zwfw%RlW8HytE5b8RYfQog2Zlwg0JG?7b5S3x1DYcJf^Q2(2-^kC9QfwhJ~ z!~@olCpvCbH;HfWn?jnbMU8GehoxUy(LOt(6p5Rf*_3`+g%m{eipOv#hKi><6gkrr z6pcJ4ZI-s51B-Y+jS+qsY(=XdhZr;$dS%cKjYA5Y1eSWf%)vvy!Tp`ij0FH#DRB%- zIzPO_?8qt^l51=xTSS+d4E0 z3}81e53k!m?bVMXY9s;TjcS>+hPl`jTb-d>XrMT@0)-`~)SF6GhOv6n47@sW0Fb zOkFoOhANmo?3o~<`5lqPUw)4(g{yjX&2c5HSmG*bHH*nNSnR?9gbOx?Er0$vqzn1F zpQuVcxKOyIRgHiV%ThPX;LferFQfaBqHRI31ktqVZo7Rh3@@tE@9RS_NGWI^$EJ$Z zT{xaY=O$9f{*g>2;WbKLDx2>mi*@kALU`q`_B}QYS#dBow}R!5h#&WoTh#061fjvZ zf!s#Ov-`A68W0`3`)rNeFR=CHCAM7sIS*X*K-EmhH1f;iAHL2?FKdwx>P$U6gf|fo z4uMLi+bSdP|Ir$?rQ4~-6P-?kNKdn1@5N9S(jlpuxW(+}ka9c=O)Ka3 z4n`qtA{^vF{@*p~1jZ_i35>pX=eu#)pZ+HIwD79ac-Zt7c?XF6XWt?aD)M~3POf-R zk716@AaK^gPIh0wX1$hf+G3&0yx11#B_q^-EY>vdKOiiDlxp~)`_%-mPkfxpXLM19 ze#i>44Kp7eC~Q=Hzmf zA?Jwf7g?+D+k)ZQR?S1dhS2ouil`3C)Z(ArKkfQFOP1X)&tw5F@V!dHJ7jQPn^f2h zDaK8*diD}bSn$hS?`daaDQUtAmaUBoQTS)q7^hOzkX~S2lwgpv5J|>A&(Bk!0(mSfrs?&P? zQhA~U6cwA*y%8*MLsQQip%|UjT*~u8uuzR~2}=s1NkGr{M08+v@gA8)g*KPI(z2zv zmL!+|(`q(G0Ti}&c7mD(&_$HUbzl>gi;p)JpEiqy!~Z2Iop5$WbZZly0oko7T^ z`hw)Ghkv_Twrh+rAxECnKU@bia>uMVVxhev=c!NjQ_!;ZBNVQ?7iE;6+;!X zPoBuvT<=l;?C*V|ROls3hm-h1_f#1tG7I#1oPGRNMc$9kNyxd+NRs5m&%H!CxOC>6 z8Q63_bc^^2v}AY!JN=y3t26%ZT`IC3Y4B9g1(Z~9Uu9`>eG;FQxhG`sozHRzXKC{& zD9akSo~}Xyj;q{)utHzFeCyZfg7fQXV(y?{PPS6}%YzsHZvBtu>6E0uGp-ELzp!X% zcR_)f9ld*n@~|mfX&w?APazEW!l3BPG_gBdO{ofH!ii>9+C^#29Y;segNd|=yr_-V z7EVQ6i?~RyTjmoDV6saL8`Ha6O)3xo9BHe~;tqjBIB$3+PgEIK5jeu)LwL5*Z1mr? zo*8X(36o_T#F~Sx@V{4nscV{gv1vafS)fdy>kguxI@I_&nJprw1;b@HACliERU5;U zGHwmWiFu3QYuBq#Pc03~J~TH=%h?m}^H?dV8~&cslV9PWHbDT$x5-io=u&MJg0qAXOyA zvuP(GbybI@H9$*^E(TXZSd%E&ApNMkbIcOtz?W z7NzJ+p-P3$!Q%7YN_LBJV0_C*AVBS#77*h=Kkuy};_id5>8wIk+Z88`I$|}~$I4xL zvM-AF-*^N{jmOmx=#3@;)yFYmu}()C&2f65klKc>sX?`w84<~C9=X5<{{ z`Q$w)76mTZsb7M$vr4w)_|vJ8~v`sc~JcQR*G*JxF%rWSW4H<^wXK~hm~PI8z8+| z?r|v#jkRIK9PmYIak(#How2 zB>^0r-CP%N>Sp(S#hj3}r8(R~z+2A33~Pt7d=s19pqM~izJx4OtD23$Cqd7sguF04 zmP^Zrz#>?MYCda#EpIGA-@Uni)6E``yP&w`Vp`G zhlQPI$EvvDA*voxHpI-vIgGkCBnfF!Wjuo7Dz$EvpuK{|v^kcFCARO?{#X%Gue zAw)aKk$vZX&4~5O6W&yC!em=wR)p=OM}*iLLmGYFXmja)vXZdzwRG06Iup?F|2hyK zK4||kE^8+;egM{^7V$C;qC?g#l9Cw3{7PZ==jr@^j8il&xYbYP+;nf|n>WR3Gbr%L z?#pDS30Y$BpzkQ*Wt;Q7jm#wir)KQ=B|w$W$$8Loz_UthsQyO1#tAygp7~%&U1wM< zlgRM7TxXJ2;;*K$C#SX!maD78d6c*~XZC6Ii^{UCt1Ts-ysjLpXT)^&09Y)ZaWOu~ zHX4{%7sK~8X46%)7bL8PiS~+x5WyY$u*tAoZbOApq&KnlFesIK=&o3T^6Hg7xjCVnM;C;Ye!rk^9`HyU!^vG!7hE0*l21P@m+t~9mVlKBO&0CkmN<$ z{ess$Ry1HpsEpI~AC&0dJ_*Y&FAkVD2ejn&GYPQQ3)K8Wl^?_?ZCi5x2affpo5mi# zFBsDxTx03%4RbVT_}A0;+*^jY_n(mmo2LQGLfQ;rFOxGG2g?@Q5`!(bCqV_iv1fz0 zrNc_}@vNaZ<>^-MPa1nC%oLF)yc1wU18j2){v%m`VPjZul0!Hwu4h{iYqTYqbn!9e*5i?;@fEChxHbE@JiV0nQ=EkH zxUwEFt!WCwbGd?aD$;sR?+nWD1`6y=iU$5sMITVI6D6Nd_dNtm&cQ{2y-oc_ghnC5 zYVM&(%SudV3!MVuGJRD%Jo&nmhQA}sxOKw3Hch~1NHRM}#l_0BXh+ zzzP8|DPhjB1yR9pYJsYP0(1N#oC)5rXTCH4iaGbDVGm*K-}NwWQO@`&vIJWI6^Ydo zUk=O0GgtecsA;(f-@nnK#|BS0%%8v_URk+5VSC}jX4=oHGvl4w$gAngKhnrQalt<= zDlqRWu-quHej%_WD!At>c+@C(dLei&D)iG==y#(~VWLZ6QZW%q zKM~rGB8-m$0*GNebsy!;Pr}3&`~U*LachS`F71_e9<^=rB}0UhPk!!BrVYkyUa@GF zjC2239Zlf1@jZE=S22+)(;%IdM~P~2HhS;z*53NjqPtbH?f0UTo2J@lz#yAyYxT4XZTfbGA>2^h)IC_s(1L6-lHZfQwfa;J8R^X zyRoFsbeUh}?)WU1%PN8SEcO{x(rUxfM#dMl^&A)f!M&cLo+$QW!eE)X)^zXM@a69#Cn2Za~bQDCTiA4T8 zYIZ_$(MoJWd`fypR}=&-B@piLuX-d3<8&yFC4cr&Px_#q{HvnH`~gjr$zJQX{K)RH6~BoruHVLA1$yr%Q|mid3T{3fqn! zABi-1Z$r524rd6(IpbavEBI%daI5`Zo1K)|f-dWdGBm**;m;uM=?FI zwgS-v?k4W1DN?7HkLk5CTO;X3Z7PcgDer#L&3u?uG^$GjoqwE^oC1g?ve!bzh}!o# zo999g*7@K{r!i0U#9Hpg@B}BUR8yM{x695{PFiYKJKMLkfB0UrIvXf`xAG(8OD!lN z5MQr^Wv_%V=qu2EYidwo486e&WW_ovFcl0=n+V~k^Y4<3BMi`ZlBV}l<;3d#={V1u zshM92)+rQ$!5fT_*@}mtg+9;Z8c2t;&B$+ZQR7?6>ova*l`^XOFQkk&ri~wE1zx*9 zP3A83{xqp6bs5kWo`5vrR{j^}Fb>D~&l2)QsrvcsC;M#tej6a9AZy5%)n%Z2S0

  • Oka`s0HWWYIqOhA`Fe$F!S; zOgW@#FnegYaIvaRF-oef7@7{i(l8pPQSf&9AA+q+1x0)#x% zG$9Yu9Tl|551D>ube9fz)r3||Nvj8hBT_7=$4wG? zbMdB|utGRqd)%JxGG`d8LdGa#{JHF9?o@IG&lKr|>%R+z3FrV1IwREvzdLWBDVj3X zh0qOgSulY$B!^xmc#?{fS4sf^SzV-HQ8*TXswx3$-S@~B;~-otDC&XcGoYt(Oo3Rl zvD%6x#mQb3LsP2MxOAoyEv`z4B?e%^qtmG&SEVrQ7#_IJjBQv6dDcxopDU>$F#W2W zh(nE?2LEaLF8~e-gRSRAXQ;wIUKlyjtvSJhz=s;aaB1QJO+JWd_JDVK>JNV#g@GL6 za2V@U6pueVI#_Wi;WD2tIxe~>BBqq)%~Y%uD2J~u?409Y`oq!FR$3`A;4wLdhs8)c zy$j#=1LzQ27K;oQIxNQ52ZxihnWwATzY5Q1U02%_Au@d6$YR{^9q2C>-k9~^%>l-r z|KL?-z@VAsr=s91Fz9TFNwWwlN$*7Rg67DANB4$52yLID;@y8mjn)KM@3iTBLLj zzXnd$$Klp)9MHB!upGtzk8r#;jm^1ukP(X|2XfHQ>;~_XzYE>EcfA>;I!RgoMP}8d z?!$W9HppXK-4N&98BKdy`lVn zBc$>&c7*M!xV}^N2Nu8YCrkz}BA4i^n1y1PM!RFgHnO2y6o`qj*!uh}-9y5$TvN-z zgt^1>z32U z?JUv9O+~5-&01nkGeQj_)jaZu=_2A3ZA^0!mj0+dq6|n+ckE2eH^3H& zp*%J?i-<6oeBkn}$lu zs~!zWYA6!~pgfn$@2TjOj{#slTdN)6uMN5;)|)Qh2zR%f)%kjR_>|wu@56u8zXzq- z>wPQWIdz_s?E16hUCH31oc3ohp4ck?aToWkHx7p)OB#P^*whn}TXYqZTus_7*9J6J zaMO@LZtQO1aiz5eO;4;m>hGCmC2U&3J<$IkhOxyKTgHDkP_0Aa467eS37S&xlKb4v zaL_Qs%6t zy|%uf|Cl0c!9wu5wH2fHHnCs1P zC3l3!H0ls1v5S;AAC>^=!O71|WOI(!IZRAlq$)r`8xMneIH9-cdfRAdvH_NPchd0e z%P)}RAStS(D(FC!`$;!`H{8w9Fd+fgYM>`^Tgzc?IHnmKTj(tH*P96KO_Yz5x?mbm zpq{!sL_ZK@3EKqTE~VYwr2V5w2gs!VPy5{p^+4ljDdY0<0Q@&!322k?)4rx9#dR`(dfunw z_;jniUaY`dOm(9)3!x&4abw$43z_BD!UsMF)?cMFdRNjq{|8Q9mKZI7n)jl(+;C5v-Zi$dV~EOX}k4YxUT*kvaC(WtV{6hj$@N&wK8Eq?%D+mJwc6)IwTOnL1dwxgA-=mmYe4!8a zBT#EW;%n#n-(1_Ih2u`SHRgrX{)GixfH@3-*h1lr`YZPl$}Jbf&QbK93-lI~Mch^( z*XH!<-Lq3XTB`(#kzu?tRJ2S~=JruiVJ<`I?^tk$Ahs)XFbmDuj_#IB{tK7j?I_`2 zDdDY-7Njf1YfR}zkcftq;;EQOca+K}mcnOB;dEt2i+Io*E*4klmN&jeyL2wC`-9fK?x-lt z$5X0@SXim_)QH>#g#}!Hn$0E6xz~VzD)kGeqa84=uOwX_FLKKlo%L6+h)pK zMQ(%z>>p170KaN$I8)270;ho(jUZu^s!X6G)flQGHY#ZyqS&s-o5kc%RXhJWLYN%q zleAC)SE4UbP~WG7v*|wJnw71F4`1UftQUngye4gVK^7uds+%O8bg^vW%)YOQOE$d< zv}#!zNV>c6uco4Yw%6ht;#$??m(SKtlTu}}*A=YPu=wD5L-P_dp#^>T!^iG@H-d*f z#FYkw1XY#Ue+uzga-1=~J2!6o!<6a8w!ynF@31)ncTM+>oTjmO!>9f`u=ej;?B8u~A~ENpCDi z(ha&Xh2M!2YxEuZFOSeo=c8q3u7h@-HbKL@P7B#INlAL896hz$*u&Gpy6Dn&|B!3& zH9ZHmfLL%%(jkxr9IkXMtw(YN=ZX&kv+M=5M+kY~GRYJS-<~Q~(H6Y_f}DmI9TeJT zu}Z7+9V!e3m?P>z20qkMH9`+e5q)*(RBOI-2pos75#x+=2mm79H(9i$as#UKYipCp z3<2O^1T-6g6Di!DDF^*AOOgZY@>(d0427QFd*gfNXTFVf9O7#{de@bkSDf$KnoXm8 zNlB*Iq>5ulLOG=>qxJsLh)_2yQwW|*t-}Z@@@ECnP4(fQVQZmC|PZ$4)!$8 z3xqXTq%W+z4~G;-@vhGfL9`>>uV&S+5%xckx~_iRwSM(vqKwUct#P7(DZCTdfLXzS zMRI=zn#l5Qz?Na~2_eBCZ18#5;PX4eYQ&)X+TfErB9tw$IRnY-%>jM)7dK^(aiaPz z)E@t02fVx+!ZHNKSPgSP@y61J6Ysl*lh=k*?}pPEMqbH}Bv}!}z(-OT2phc#J|aen z?ncme!!c6?#a5#gVWT<8kP5_T?b>K4lHAebO*%M{T(6kcu`wl@(L z@M-y=6PJ`2olaD!({^Y{F?Q?IvGV0QmvNwC7qeVAX53VrWizl=f!!Ugy z{}tP4`t7Lr-6q6qRfdEPF+L96BAD=fm*yiAW0Vf=sub&R7jrqz1BaY zj3x@tH`g`KVunDO_{VTBejW55008TbMA(EtSU_}l+>-3 z?n6lmHcEfKK2D+g4#PkEyZ$kpd{cNS*5gy$*xXD(+hpAuXbTIvS>N2diRH5aFW>kc z9?3#Vd)(!36}l;zv5DQ?6*;md9rev69I6EcDAsR^vd|gaaMDj&X%^GH>pfy=?*Aw8bm8q-dL_8iKD+Nk*(l5tU+=*#7NI9qx>+uiGas>pw&D zYY~37UcXsn{|a2bEn!Bp{j+hnoKY) zkdoA*2|w05pE2GD<4q?&J7pka*@)xRBb$Rk zoIiE2Prm(4v@s~SajCyS_1$L|(SrGSaFI*~k?x&|fSN-A0_nSIpPD?^D>Wik8$Zij zzh~rSQz}Dqg~1VkFgenPd+)iuP}UIOus`Sgr~aw(zay3}nCsIcUU|xYQ}x;{57!88m`zd> z`XcHr>76hqFzLLOsnwH&%$uZ9Ec`}GL_3Qe;3$k8A)G+-OPJSd1@C;e+cp#U;RfY( z$!GYdk_}*p0BRYWG`%HfF#rSu>cBlD?eyeUVz-7Lps)1_b>nfJF$Cy)wUWp64);@_ zuaMck2tReePQaJb)WiDnGvdZ8eI54_`W{ zdRI4(PICe4<7S#8zF ze3DhXp(?W)L>+9@jhp-kQ}9D;PhVJ`9{S$11lZka zkQ>vfohy*yM%CiPBB1p6Exr&W+(PNq$D@PK@89j6JaR?>;)1Ir;uuDWzQnXa(6JW` zSf^|~khMewTy}&|apWIhY|%Yu7gXu*^NTb^Le*Z+W=f*bK0JA{t^^@$iS0fdKCN-W zPwmhAtD8{vbQwdNRM9UoU2ph!296PHRRiN__8JWwFWt1>rZB4{ozj??VcNDt_K~ra z;}Xr0yaEP;vC^`u@d>1@GYdzmKj=gMe4FmrcwV;^irHW#OoLQz#@HCA;P?q0i zmM!$k-*iny?=ah4C*`$CJ;p`7L*pGispuPhJ!caI>{*F1{ggW5CFEw0BeOlvKnptD z(M5yD)H=rG36MEJ%p~<6#%{M_qWF~d$`oLgo-)K_wtHbD`|SKm(p3gkZq5Xd`fQg zzZp;^aiDr#2GEhfU*7woO6)i^^98DHOJfV+&Gk7cDxicFnwsDD<8Q;M{`?=R?mQl< zH|_)enFV7uL-uv-yX^ZiW6MwWB&3o(NrTFgG>kn&$iB-?wuDq;-}hZ%EJYJX-a$Dr)2!$f)61O_2*g+O9x%@BlJ&A%EuaxFS)hoyqWK5UspObVpvO6 z9!}Zq)h0nVb{U^0DxLk`yQ9#>iO=a|xZ-kh8LQp1gk&gLMSj}SN zhY^r)PH^>ouD@aAJ0RL^bMt1O;h|g6N5G_HPm4GIB$n0+2zX!H=zQT>2H!W-bdRD!Hu{Iz-Xc1pg zz>R5o9d&1(PSW;a$9PizgA!v014j%|YRfgUzcLH;KB_Z(-TA_|e9QN_uhOK0O!3#l zSqF}8BZkjV5lmH-iNy4#r$^4Ta7x&P=hrxXsfmVTK~v~Om1LQ)*Gi820->5B%8t8` z;7j5iNOqq@=A|*^AM&JKOqxDoA?fyPn3Eg1i@`G6`T2v}MGpAm_T5?n9N8L#9FULQBb zS22UBUOt>HRMl4s(}k&)^?P=qQ^v}r<%3>?Ro=B=R*u45#Pu0)&Q6>N3s@HN)IvY~ zo@P7z+!zYs^~*SeddL@WScLtm&y(H}V z9d+Zn2)G@DRzOrCl~af(6O-fW8I&yaukQJiq1fZY@mPK{C>UhxV#@YwvWQkG{we=A z8)$T*dZDo@S}=a(gdcI?YsB+qZltQ9@zplB)SzCdxxsG~nI8F&$H|ny!dYZBIq`v#b zljtz+XQ+O8lUjgzZj6^jHQGDyZh^duBM6J_x{=D1U`mGY2U2tehSJ9oB{Ly$u0NeO zq8FCgm5Li!07WK`hK&C^H^&r0(MSsRtHJ9a!B9XWxD$r8sIi<&iuokqLi@Y%3iM3O zs=S1zn59w(b=EArBfuW@nTav*^8ck+a7J7s0Fh)d*TL>hLc%AW(Fldp;Z=QNqe4-v zZ|Ax%M*76vkU|P~H`DuG5087;=FFo5VbnaA;vzI%1RxxY<6^!qQmJk0LRn6%CXv1= zuZC7{>N^cw>#0wy4uxIY5*Uhie;fOfwJ!EvmKoN zJ$|_dZSL9|^Q>i?4NB}7q8fBzENbbuJSNn`P-S8KdE|aB<6fN6wS|c^?*~F|p?A#u zGbi6fhnE^?d0x^xPo{_{<#sxNfa2r-&5{tmlG@Z~8f1*P6v-snKaC>O9ufR(R#0{$ zwvs6=j!+r`rC01P_Ks_OL+>ob?ebs#gRyYcNabXDp)?G;nNcQU;vOhi!&wtodJ23F_7q4(Ss5 z$V0i$MzrBBU${0>>0p+PHm`P*|kU6XCP5QW5zCAMc8{k6!`W# zU{JjCTknM*Ke3Bk;eSe8ht~ePds2NtXKk+!%KG@@>Gz`|#)q~-`+LJ2vsN!p4wueW zCF!1mKCgw+u7vEx==_ZWAe`c(>c0k=lI0~6?p7a=q>m-@R%&Tn>9w~$>HNC_yH5#U ze_Vd65By7(>#Jm57Jb{+iw~of{GYBryOT(BTLHOpr3IFP3omQ^7yC{NMnsjthZ~wJ zTHmo$yfPRcz8OjcXajxS&54P9ltMvR(WgJrB)qfU* zp~>dd{o;)8#YCBw(ZxeFj2Y1fzuS3D+MrNfYNBJf4n;hAlg`njoS9jYRkMwht}0`# zGW$c5r%FcBMF*N9MblVRq#6p0k)r@*X3gl+!A{r%Hh0JO+RS9PW86ji&PHO>ac6Pg zd1`PDP$R;QGI%10U96u!Hd)YFjPbk$s|yZvMKkFuRdwq!Ysq(M1+zzZ2Si&}Y14J; z*feY2XzOzM)V#^nrPyUKi06n+@AN%35ZIT}?0VsqNMkOgXJTTgtN+Z*0e7?C;BwX5 zJ021Bcmq!;zaVqZLKxomv!TnnCS<=&xeD`G5&qRzM$Njn|8GZDdL&uBD*)Q&?b37K zOXm_NUdkH&2%s^Kg&84xSS#p06zNiRiZ9_#J6%8Pw>4{DtcneygnI#GnKrzp3!gin zeXq;NwecAbw7VAQ4TWk&cEyA=)3}TMm)s?tvY%}d9VO`X-~FmsahLv}#{S19#+e?p z*9rO|n*ZgwJaZ!8O3NTvTYb?K1JagJhKW(WeP4QUj8|VycAaXuN%TV?qO1Zg1S7su z?+MGkl(ydWTB@=(SUS6`?Ab!}X;$Bx=7_s<{h7@q0Y^v}6fYj$-==R=Se1CoHi8{I zSVWAHM$&(D>1|Y{v!q1P#Hx5(!w7vKXkc=;HGe{z!E=X5y9G#(R7~}EiH3ciM$Kra z^hh7>4+Sng=cE~}1-uB^OND6mwd_VS5&><(@L*R&*mzpVlur42mYmSb(UeQcII!rE z>7;cZrmJ`R`$)V8t$o12hX*55djEL<+Mlal*rvR#y>gy;`>&Y!GVNWS1F7gcsx(bq zMZa9c7MKD2%Ai$&SxXmhtYf$kJ0yW<9>6?OV?FS^ZuA~3;)xXf`p<&y)4LiBolpslzUOz$sm zI~ea|vw|%L{i`h4hlgshQI?xhf8%uh0z0OpjQJMZXj3QXOh=;2hP>HL-iw=y(s18! zWR8>X;i4G^7Z3Jun^C2-OcTnYuCPyLolXcHz(0(eo4Sml7yHt(izi-;O0i5FJ4E}G zcV^UT$kJqbjnU}58Al<@WhI#ZI*bWa^;|$ryjAGZ{1Tmb+pOAWg#7^SP}cl#%KB1- z?)I-sH1^fefghporkIDPn97lixJ75D$&YV0SmV2` znU&&P@@WvKFGBRKiQj1L*=GzRtQ3NyIba|?Laa($XG($9Z6SIg+fWTyOoq@jOV^+> zD%plG<1Q`Rs2Qm`Ea0m+&3N0ilsy!%C3(=#My1ms=YX;+vxy$9r4afDEUjT@?blcU zcSo9=@7W*5*--UBNmt^oCAQ57^g~pSY>F`5>buuUfha%>fFbEM*&##5w(sHw4m8Cd zU4@+n8&u7u#R^~Wb&Qyg)9Cse*{=WHBzJMbCa+|$9wzh);3iZmV>6z_vWAGWV|~DvZu^QSJ07iWNpw?O3*nnV8L?U-@Y#`O2|0dJ(9iJ>)?{dZru8 zXzyglXv&hVj-g^}!?=$~XpURIQAY6OA1Fbo(L%N$Rje(E_|-?|OQS8FW%_gW ztL2w_5Z4Jy#~Ph>+AxAGh~3EDwT6DnV$^Mh$^2%t@Iq3Qt-FxTa0@2NWVc%hoj|qj z(z`))bvB!JRfGLJ-jKWLR?@;rPr*1S!?k5ehQ#OywDUXEGw(j=y=N4J{N~?$k4#L> zl5zAhyk@cE4heudNXGEhG{xP#kem@E2UF9Ofq9BaIi)(0YN32&vzBijkssFn4LiRs zi%*Yebv73(DL^=aeo||?<|U=tA^Mghq(C+ruYpdq<>n~H z8^S7!pjO03>$S4ZHrVSiGx}Ec6uMIc{BINjfit72i{OUn}0t1*Et(Q|YT`4Ji{LSZ2>wK6esf9a?SYXZYHu%*L$ zAXzZa=J~4>%_JN8#ckWjHgY3m+c6)yS+f28yvy{Q@tWEG`E}bK3*DyO*=61NnM*=% zf}Gj!Z;6E8G}<|QwDZUNzP>EYQOV9p)6RwsjehgacXXuL7|r3*4p8dt%nk*;-S&4> zy2cgtH1W+cZQ?cOUC2?CG5`uZqFXnNz6g-cn<4J9M=|h4-KWt0N1?^2>|MCD$9!#% z#eI+UzK>Tllr3$Kqtu6$8p-wAhxIx1Uf&+WEgCsT(*4aneom$6UqaV@2~&67 zEoekk_Wa7iZ`k^Pi04;m^<|?ZFYQf!JKu*Y)A7YzWcZCeKhX-yCxv55udYHLiIovs zU#X=1wq*hy%Zh!-{q1v7s%b8)+81_ft~7+R%mYqmJQu07@!PiECBR86La;g319JXP zmqd8LVh`nDi0${4vO4+8@pymWijOlvA@b=&po z`>}g3@>|j>VLtB&K>vY9^8@4^=Mr77OyD61165P~8BQTF;0~lR4O*%_H4fpahaCbQ zAiT%sMW4tkSV#M(Q^U;%<;L9a1%#{MG2UZi|4nQZsm>)tk^mSe-C%M6pfhw7jqU>r z899{J9vaw02PT@#DaSqmXzdc`oO87o+5JBjO89-0pqi(_ZoHrLyz5`Y9>zd~MCa40 zd91{Jxv~KJd4Z6Kh5>#De=NQ4#hinISOZkTJ&*^TjcVjx@I=I|=*UZ2mIhfg>W|1h z3qv@P00B&&FB)xo{>A!HbmTuD5seWerrlc2#L$@nPKnQzd&dIXu1w{=U64swnLfHG z8ldv{ZqO!*@}im6f_SHK2S+y_RK3P^745Hcd~Cfu_WUMF0Ra2msB9P=ez+JNtV-Ki za`^Wsu6b6yd-FJME&JVbb8FPO=@(?kx>c53_%t-i21{#P;-4$6D{Xl?ni-i|b-@1* zdFlAI*rrkTRhLq>HO>#0E>plMJLcioDAPFxYNgHe*q;fn85kYd%{C<d|27)79^_mL}!fpQ&*#BjTZft$z{x|g1CfZ|1Jmj}avCH9RKf{-bfPbT-Z#6tX z<$2j8`vGhaQhzFS&E(p&Z}uTX8wvx_5QI$MeTriKgp`(2qLF5e<;~(S`h} zpL)&C1+70T*j`_aJk5_0pxb}lLw(JAYxQ36goxe8yXH*~rIb8#!Tc{|8sji^S3V?( zB4~c7?cxLKJ-QKa`-*RIaaxm)=6-rD%)NSet;!*5*>~Uz#(wl0zmHBm6v< zPoL7IBSk0)*$Y7=4Lu-K1&vWG*3BRS;Sj(Ck z8QZVuNP2THIiN&QDyHZmmBk8ifvTZ&5h}SV7g#_;7HJ0TXOYe(V=))t59J>fubN0T z8C}=Ns3omFS5$Tp3^g*FS~8~I962g7`MA~I7iBmjQgSJDZ_PyP?8{;C%Y_&vVgK3M zj^|HZbk!KszSPaHrMnC$Zt7#zBRvdl>N?@FfA(F)@J|f`MRPx{ObA)F+qHf%&yWwo zq|;9Kv%JEIFU*xOho+!JrfW05m!`QbENW#%ld!Me@G^V&SF>7w&nzD)6}i`;J(VDx z+t}dox-?hlOZCeLL1V2PPRVM3>|5%k%R+ls%CvHoMn-SNBg|Nv|KwX`^|WuPiQIz7 zVdmRQFCH`1^>0fiw0Kmq<49_*N%HumcVAFq*G5tb!_41ty>Whu4UH^U z$AjczUmVou#(}p!19Q`yi>n}9%YAUsAMdF*_{fAJm z@FD*3>`%%p4#az8I~zBVc`Zs%J8>2MF4e~%U?^2qFYt&=^X29EqUhDXszotfbb%up zeljH{t*&FW0_Daxb>~l7DxTUkTzYC$+oAt&>_hTC$Ip?w*6Zgv+TR^f>oRTL@d=t& zhx_Wye=kllOZ5Zwm81DQv! zKnaT9?wWv5%_;wb^}AiiLU`uh)P25>G{BrA1oGriYl0K5fKJwM zMILRqL&9q2!g!KV7F)aW3s(HgWxgNJwSRxf@Zrz)Sa#Fx`a6O+141nODS<9OG4uBsUY z700G~^oS{iWm2zXn&7iEjYPHRnM0UKEZNuBtt9jYg$%!h)c6f?&mLX$sSRTlZ4~;$ zYpt2AB$n0+9Z*!Z{Lhi8TcvZINAT65(G!kv1Q)L35ITW&ie7#C--7cb&hIkG_IIYL zTCZ3vjg*GMfay3##jd-=+6mFKkFCxE6DcWt1;ED1}gg(?x9Oso^GgwfuilhyY@>476k zo=A#YvgysXD%0{dCPr8voLCmjDAqf&7%_npA?>^mpSmmkz)=d~s&-=}I-L`~*JS4P zTd`g|Yo--@!C!8pC0#?%GGgYI<^Q;I8vN&(7v+_ixeDIrn~iaurX8|^EeR*Zo%`=<*dR*hE;c{Y8$k6vOWCT)*Br#GYlm~5H>Vx~pW}Wh_eelP2>$3eiqfGV z7d30lV1>9!{>jQB_vgU-cDZgmSQdMm^J}d$uES|NGQCOA@YPPuCx@mnwi?mO$!CJ6 zH+pN=*cskOh4&V(iDg}C)v>9^ZLYYupIQkUL30`tONYbKA#1M&6lXb>W+ab(bAGxRi`o)VwJ%@>x6A zWB7`BhMV=}>?_x6{ zp8jU2bkn%K$H!0VEKd~P557ImhYshrl-(t1|xf*QtK-NEN~?8!M(Vd~{oyDO*E;wT0tq2io05UiV?)9$Aezpoyto-?t$yW?=;q7M6__qfSmlNJ? zd^`@E{qMgEj}$wf?a&S zRcA_QWJxH%iLF-qpp4BPVWswuQ(-X)(?S6KE52vUGw8xSCONC_1R$Os537Yb?%2pJX%nH370Gf}FmlEGn8CSjt% zy5bfBV(NwBN1=RJ0ijqt5Jwb`bP@uGiPs89brjy{5|EZ~5)Td&H33Tp>z)f#(*Fcx zX`O{Iy0WZAax(%_K!==mp&ATF1CV)m$*M5oIWfh<6s~Ahqyz^*=e`s)l#ZQAAWl$C zphII0qFz#@UL&Z{RHX4iP_w5oWj$s zlW|}d%}lVmSh1c&F`!wjzo4fTuBTwFE1chZcpof?o?(biA8tFd3C-Ww%cAg|M8|# zQpK|#k;1<~)J!1K4q?*PdK$Z&>300hAX=_4^FAfo|AVSv`dk=&Q#j5p*VP`5L$Zge zVL-6cb+?C54Qq&uLx(tbr&3jCL%T^q8Gpektss;LH4?U*($n^Kl2p`FjhnC7>)(ldiuT!O`tk|hNpsV0Q8kk@H zdxH(FPFJUTxSp~JNdW_q&JGhK zFUXm6Di?S9z7TyO@4oP5u3WpEOE=!$NZ+_G>*m9AuuQVGq_VZY|913Hx*Iu&tx za-TcitAoW9lRutFqy>q$MS5j>lKNg&^?&%0l2bKMv*q^zI_QaQ(cWxkH6L1?8eG~M zXq6n<-nvH7(?}$#NL4B@Lu6{F#p61JO~M3KJI;d&Vzs)WV_=z0@bq`EOge1F?Wb#9 zhnQoSkZiSBwyva+w46}qM_Mm+a%ao0t#=6$pFT*xE0H?4*y~!QMoVrDzpOOdEpL9| z`6YETrEx%8(MzMaQ&N9RS!i21Ku=Y%W=&g0txQkjGvt(gsbAf_+;F_CzLkQkp>pq>U%Bo_OWx{6*IsPf@86+t-rg_geObr*!?*IsKt(jC z+0PM~J?)p@Xs>R+WLd4Q5uEOML3<-v{Z70(4SzoFS8D`pYyJDmGMkso&1?`F>Bcn^ zsZ1d5CtNh$58aD_x3UYcS#=|1L;tkWu-fiC@QqSBT0dU8V^Ma0J0at*_r;rCJEt!U z&i>UnukZZ(bkMn*KS7#kJ0?NY>&a3Clhah8%ayhbS zv9sHyn(}yNU+&SplZ3CldPRVgJYVt#U$VGxUaT+!RD`ddXRQur`%8RdN$ldQy?-}% z>-K~{`iLON5)CD|E#LEkFTwju33lG%qszcAKKy1UxG_{Kyd47TqSEB!^uge{b`|#a z8;6}>eXz1)r(#dCkh#3n=r1|8e4Lnqf`)=3gtF}Ar}ETKO^+&1BxmFu{4DMIjm!5_ z&}jhl74Q%IROmwOS{qcJ$!lG@qQ!PmkMdjX;%{vPpmbe983EN+*jE))G#vFV)($uL z(V%{5Uujv`$h=Y6&kujieW@gG3C(hO*Ac}8RnHE^ zskvLtFY1S0)NHoyo4|1`Q4 zgu(hct?3Rd_^fQ)6@y+i;sf5`h;M8+8gaXgS4SzA5kv>R15NjRs}R#$lMhWl9hm)T zyuJ3&{+g0;T21+plI~Lj-iZRdBLqMKJhiXzb5sawiU{ogFA@nb4e~go%enM!x$Lay z+#Kf_YpoHLN}D}_59Ht!LrT5F6X=Z#wyVJ zZx8Q}`nb3|R(OVxGg2>Zty5V8wgM1=FU9m<9io~|7}g|wtH z99wa<;IJ(bIxRT;7Sj%)Bo)=v`zk3zRd~n1B)-5G2;6l;7ieQi8Ujdfc$o3{$VO1f zqwE;x(E<>T?UV!4*Vgl&2d18>#?h%+U4iBy!t)^N$#31p^-pl;iy=axa`jkB^sQ66 zuziK_m5Vs;eG=1W*C*$%j5S#SXau_cSEIzqMtK$@3{s1HjN87H>OCxb9#nq4xw5mh z3K3q@`)cB6b&06@a)@yqNnJf!y*#V+MNxet-Q%j!AouAYZyna3VTKLAPa6K7+$cGz z@K>mN9OMw9ary4!RKM1r==`p?uU(rjy#o?8{$~XD`rlfW!`c4+UYprH5P0yvyuaopvFJJ%fJTv#s@$ zRn4hwSqS~!$3TbqJ6toscxu{rxec$<`}E@hU7cnxm*$Y9X6H^Fu2ysK_1}I`tpSLp z^l{rDQ5Haa$s^ zwHqyd2^b<6qW+y{X-1yGXjus`ClfcbVn;>^EnFd#o{1X?)Do<{EYoj0%QF*bh)K-> z$xd;G1-c`z17p-1#hD4Zoe)O4n_J37W=qHJi9|v1prL( zFC77(go_PO5jGMAILoNxZwc&ZfUzp@{&u#4Plw-M05|^O!;@5GJo2cT$q?Z( z&}SXaZ_Zs%S_@p4Mv@#eEj>a%v4aB(S`DLxN#%z!ZYo084E3e*A$soVyErhn=Iv1v zcI!$1$rLlH<4x#0E}S7@R$P$m4K~B{a(c3grlunqicc>Z zixIDx6EM6CA6rkR?k9ocSuuO4r-+|(WH7Ha{-%qpwEAaXtX*t*Nr01E4p1V}TITA; z8RPO2=%X4H#qSWAdy8l_9d)^C>%WO)=dcVEJ~Q@wkds`Nndz)22M}qDcBF_zCB&j} zQO!Nsw-%;`0AQ4jV022W3$IX>GLjpyU5kIE%`8Em=2pS*5_S7h*LnRmK8z7b|6g(C zf4&1k_3JX>g)P!yn<>$Qa6%6tB|EhR7D>!!Wjy;u_3cNei)qnZLE)gkb5~X)V^*4hQ$k0pXB{jD*(jRh9T19VLEU9-~Djt6iPO z>s}gFT>hs%eaX&dhsyv|J7DGauWb-;-bhqGAoY~@;cDFIzovsfVa*FMoy0u=xGGg_ z7*kR^1UV>LLH@`Qe!#yv2g zS#U2%AXJ$Z92tcv5F)XY!R$_Wq^E^BYEv&8CI zCm%$u@7PgXzT46wTc8Mp8rtKFW2OkEbzK5U)q**wee0I_@v03k~pZ9I6c0mnXn z5a+UXN{743nux=S!}Px@7+(Nz$?Uhmz=K5np48jIjO-G9R?=wMtGSu+DD_L-$RQHtGh-OSW2abL6 zM_|@Gk7Mc%TB!uwzQL(9FdiAe4D}VlLA@puU;g_2in&_EqDam3FMl+^(s!3e$|6jZ z+YC@tchG~$0VhLAJ`F$uV0h)j7rRch$!@%|l7La93B~*KcqQ_FIpgCo7cddj?=1ME zreM2)e}^oIr|!{wQlg2Gm^N~9&X{kbDht*6@mHCPKVx)97v3gOMqL#O=Q-rJ-{xt4 zA>6$lIxKHiTt@@=zEQUC|L~ycZZT-sWjA7f*g&w91?PDNwuQiKfL0z)SIbO(I>Wd( zk3eaU*vO0fC<*z`E#H5asS}qyS>Ce$chQMj-}6-J+UwyPWNE*a%Livgt*^9doIsj$ z9SfP*Il%_0P9Ha z_Er<;Lt3>~+1!noD{ZT+9~G%xG|6<#nzebEvUpxS8hPcrCQj(I=m7(zIVd{OHAz2= z-?!wqo&;fI-OU<;U^6sAaUzgdmYy|z1TudXNj(Ei=@{5{5qrv=-5R|uzA1;Y_32%xebzW?-O%hOx)OTA1&Q`5=VQ_b6%!tMUO4A;TH+-;e>7!nY> zJ|DSHav$u8HtOJ_=iH23bdRjIiAhK*GH3PkJ6`S#6yG0GU-xF|`_-nx7|c8+)>2p$e=g z?RbKSkSnK#)X_R%=c{B(=1lL0!@ag*?#O3gfRKa>E6cWf$_B{r2e;wFf}L4anP6iE zx4QV8)$`kgRmamZ^651d$5Iu*LN`R=mQW&C`Vg#r;l6txrqC!B;uwqIk4ZUF zsGWO4#YX$6Mp-#Wef2lKmgs~fYSQJ?1%*Y&_C<>dM7}AC*=LOrXM46=%!e&fdM^fi zY*ufdBO%76|2{NMQ;p1k1(!mfRTwE0*~X$uluj%le|-RMGKg;yctFN98AZ1kh0~Ja zT*_oCR~+dY1cY|=&XOW>d}t&l0BRp*#}UemWmL~cxsL(#`I?I$CRgC1J%~otD#X%X z^lnNbq8x-ePGoEm`kD{nz;IF(vCJDPR03_A*nS4vxWv2hjug@Hl%4ridW*{C;1K2z?eyft~eCPRp^C?)%luO?n?@_?qL;wYV z@i=K%d7`EG3+s$nTIV$LV%bEFj8CDlFYGe@bo;;L;D@DUWY1^h9%tkSUXb9(Jn1tp z<`75^%&ch1teVdRtwz^~b7OBaIE4ds;%=$_S*kQl+V>m<&f<693b2_uM(P-iifmI(HXY9l z%ghWtIP2Al>`V5=)2?38?v6)FKAG0Wka}@MQ#DNNX(=0WmF| zR8u%>RtFfXDl+aG7d?@vB-j_9jiFZvsPob7E*#=~cs_wZUy4PLiO7N7%Hi)-t(mAr zZ1tx^)T{;SJ-n*l0@+GLG?C#26j(BuzMhEa15neosFhmuo@{}q1ox+)(i#35q3iV` zkL$UQ3T?kv*vHm9uc+ZaIX4*4^Asfcd}uov3vVRUad4r_$>?%U)}t|WGyL^0V?=2p z{R;xTc?>yCL2VJLpDpn6|IHN3GHL&>UWT)#R4%vHxLmd}`z#+lYk{mL(5H{VyJbGjx+xR#5>-l1z3NZoo2X9Md5EYQUlHNdu zB?_{U__~*HzH2FY#hG!2V^}4iMsP@XNq94W`b0+aW?5l1nkBE-m)&iaH>&S{)jV&U zd2=D_hXtxj7M?~xjA76RW3B3$EjjZwivWr&3r`+{_gSFUi41k`xURk{tNp}YZCBH# z_`ZIyzS{0xT?WI-7_x|ph4&|-N*-r4O0*TXFsu_${a8e@ESwCW76}XuTo=aQ@j85} zUXaX~sbpI_$+>m6;&x@`pF|XyKwmG5`jPLI{v)dkfqF}z&$d9$)}l+FvHjulU0$dN zsHo4_`#8@*o>C*{&!Z;^P2@xrvGOA-JNv8_?K(*R4uM*wv^@;sq@2{%T*uPFJNm^t z-uJ)HYhn0=Lu8C0SI7)EE?0b$01|&7w+G?FwWxh!d&OS`TQ0VP$9!j8&9hnEALzT< z#JjS~(ZfXgx3wtap>~tgdYX2I4GR=GpT2;A{8Zbao78^H#q&3-jJK*3{k8hNc+Y?E z@@zYXSu(tc3ZQoLJKH~X(T}5jgXya%$d%nDamzPq4qVs0_-+Ir8F<^lLHvENa81d68t$wJ(DvhLi&>=96m!H8K5gYP2m^XiXg(l?(5 z&(_DhG2ri$d@}6fz_o=#R1?tYJTn=RFf)LzHDexl&#+{HOdF#gBcrWb=dn(+x$j$N zOonSs7VK_t{iPr?&bQ&&Y@zUeP0dkoJHxAdWEKHFIfhOj_;jSf{Ne0V0o88d*$S%A z0!hh!6OC#bH7yliU|7#bW?&K17E6^mZx)8i-pd>v`0ELM-WiX6G$A0(ohiS*qR)Lp6R zgy2k8nKhj8+U;?MNdUe=D69JUnRBR2OlEdh7FC6XkJOUGxz;RrKUpO(pSuI~V|}(C z)&w>A=Y!_K?dY*u`f36Sv$S4(yzc(*>v0a-5&7-q+(m-++I4Df?==U^83jcbjI5~c zKKR+6bGA{Lv7%zhP@Rud^IpOxEQJPN_-H{FNnv<^o}VVeXMV0+ZmUT3{#F|EO^%Tv zwQb05yJuFC`FxOE*75r@Z^mzl$h3TfvG$wkzu#;BE#8s2ut$K85Le!6k4$MY-`xf2 zC9b}ME;?HPvSW-#iG5BtyT5+_-v8nKU@p_XEPQ(Go8Q^DBdwpeeZYbM;gNGe00Z=WBuS^Ld$3Owl;&lx3 zSVW;L>f>OCC2tYU{au~UDE_K^q0iwFPV?Oz*HY?20R4J_< zx-@>Eng5#yG;~b)y=|5w#>;*-1_A+}5`7pZvGD3dR0R6QI`4rV9`sQO#%zHJxd;$1 zVo0}+Du_U62DriT=&3o#?LOmTExq^B?zma`y`4ipGVRpZT;ljCp1&2=#P~?`(*Vz5;tT^Ym;k?`+}YSr3(p40l9+9z82}{M4F%+H(QKK1A#aBz_e@WGMEp(U(HO<6Ny6NCzbi*@4r^<&)|Z*-+I z7QL~Y{cs1$VYP1bLfACYdiuw@@k{9&AHwOG7@N{%KR)rIGfl4YQk0Xa;!t#JG!in^ z($BR1W>sREqaDF{RbmP$^HVwpX9V!WjT*dvN>C)Pfr2)X+%t|8TR58jC0_1;U-5?T z&!wv;qdzA-7Iy#9v{}Di3Jr%`&UtvSYyC9-_+GNGC#NJaZfBczlZl=K$OeOWiL`+m~MbzqA8? z+YzbvjyM{I)aZn#3{GRiC8&I+QbNpTud+3N8pv=+2EJSVx{c<-xei~^-Ys=)v zu&%QDI$>+$q_77jCZ#U&ikDS_uM+);{ZP(i_8WYZyj8_cSFls!dI2?iiAY4(R#;KK3!Jbr*1G}?D}^_MtiP{N{_Jg zaz0-dPz{Ss%hK=SjoJRK!}$T#Q;zzZ55BC|GHQnu{B~gfa>iEi`1f?;t*0t4St+H5 z87{Ns^wliwVL_zgs=bUsmKe%Z3^*|5N;`>b?{9WPr=w(A5q|y?_o{)!2B& z@&%UFKI^tkm{I$_5%8#jnsJ9{WA71}EVJN|mb86T^DHL>?O8rb8~?q;_P<{yPs<8Q z=BuK%N9^9UqPM<;Q#l`NG>p@p%D+jA-FQJ5b`d(a%M)U^e{Oxy_|d)3irFdN%;4ZO zPx`At7(M&lTz-$3G08-uj7zsJ_0RJpyvpRToyxak zL;spZy=vAU%&^~hX<6TYc4?_pXXsBc@!Qv00o_FBjh43|rvWX(*Us+F%V}JCd8G+t z>i>QDPo_$l{hhzBS;4ZHT48Q6-HMfVDw6NqIts(d$PRWQzMPP7rQsx&dQ6o2XF47D zOY;zOkbx%pH=XjS0QF&jxGoS(`M9G+hX%p$U45c#vZ<#|>R|#n`9q<_}8=*?Tn^%J0 zw~RkZhn*lNoid2{(WKk5yT+M0W}v}J(kmHTk(#x+uLLFO zd)B|)Nq3@3MvB$@be9por;iril*`y3HWF44-%_PfxDeBK*RUoNli5q}qGsBXUBt5A z@JuD`(x`6C1;d|1UvMVf%=n51A3#%3O{a6T)WoX5A9M+T<3vFRf?Qc+|4&nA{T9{t z2HG>j6g`wQ4Bg#5gmjlE;m}Bfl$1jwB_$;y9fAUqDlvqFbci4!4bmbYA3*1F@ALiP z{tx>+&p!Ko*IH1e%IV?D!|~Vn{s%S4mh3Q0Z*i^qE{Ij03Cj-4)wy3|vuzKPG^Un( zHjg7Lcu(%O>haiUjaT2A;mz})0OJa#A!SZK)2?#r0QErE0}`l(QIIAQG?Zz!YLa4X z6Z2AsaPMWce03>NVBI&>H(^X`BM!{enIwUm3R!m;d~bS?CXKEFLu+LZy6WrHXo}>r z*ooxgsVnkIoCPMnWb4G&Ylu@r@nVu6vm3;P3rp(m>A&EyDqm#}i}!LDqGh~S^MFb_ zw|v2f)pP-zcA@`N%A;hOA8-SHV0%p)f>ft|Z7U>dv3GBj z-6)AY?#r(Cz9nuqs12*C2KWO@xt8ATSPHm+TMw@|U)#qY7L=ZjVdmq?<;-PyNA|Ci z>?px5EUS6&;0YeiNOJ+wQW7#HD zPM?#M&Qta?3>+xr<~It1T$6<6WPa1}b9KVaZWFg`ii~X=3Lfo&g0)A&$l=1mU+Dg| zomHIhyxvC{vjL?pyunLG{=xR|rUL+hczf8?iHmE8g^ds0Q30Rgn1)od=Y9RQ`~nK) zB3`bRwK;|xzI`ChotVWvT0s6=dQjHF+!WFM^tLyz8D$5%U!gKQ5;pHJxtV)Mx$rN3 z+!7XPc_eg{9ce@G@W0|9oK*JjOf9Ri9>EXxh(0FBUjkuUxI#43{PTv~)JQz4h7Ly1t$11t3FIn z5a_VK?77ClQf$H&`MRHsPjnu=f=BF5j0d;)s8fxvChS@~{nH!VwPnq^v%U-t^B?>! zydn#=jw{Ck#`v=Qx#eFYe_8`-mI&zl-$e`x-P8HrXMR!c-!UA=qR94NAE8cOg20wR zy%zaX<5veQ62;1x!myhS1rhzGRi*0(Y}bYP+JC;h{1|b>+9~nvpKt3ghwx3FuA32` zDreCsC_2hHPYHxXgKgrYv~l2oMDZak6acCDBFF(OaXHBF`W0(dH>_5A@V&|?u6yzl zH-e}=8A+f#pmENXL zNudDrK^Czl0^$qw=sfyV=%747h?>CtO5}2sQWl_ipdzIO?8cs1Qkd>n!4Y;7^*7SuYQ9CFa%Fz`!xgl zwPO1<58~Vs`*oZ9_4@nuXZv+iV*Td(jUbcMWD zd-H%tho;pk#O?&@d8X;<2_nfOu(}-ZmmGYoG3c)mtF1j46fhVZI~bBZ7{mneFB}Z( z9}J(>3Xp`V%@4Yhz#go|nj_<%N)E+HYH6Tj?a@O%8VMEJiE+rpghcIlGy)&jpglVY zu%yGwMG>6l+y=XC)w>CqDQfBBjXUp~Du4tL%GUxm)xx7y;Z4bzX9=D|FH&dnML4@_ zFvRtfMDLNw#Ro~#dFW_S;$}A>-JHm+9r|ikDt(&aRX#Ti0VF;m%5$m_Y?cpcfZhir zacesGmr38;QfGZrm)uC3r~&zEtShgYXJYC?bt*}Am$ZAF2ST~=eM)wJ3l0lFak>Mg zvR2p11u1VT380-Mg^iwU7slkjt;ny9$%m)`b~-F^2l@||{69p+r|jgQq1c9{`rrl9 zZo!W`le*gLU$)p0L73YSXLpmIem;aJ>b-bJHSGSRQiX@mHhK*2Po;e9KK5HJDcm>S zU{|`PX3Wv?OT{kyfwpYI^_Z5QXnC?M$ZAYYz;Mze$rlmlvO6|cqEg{D-q}(784EW~ zMD3Zg?U#R9n@&4C5LkaaRxYY+iRnH0(Dd7!^3N?|#iUcAP`P@5Yi?}qE$3WZ;_Zh> zSM0Vt!hTV^7RFOk0&z)?Fmb;m-uj47`tK>PHydqu5{0HiAJ9#DH5xO9jaTl%9o(|U z*sI6`$B`{<#Q7jPI{j*-=z9&KNG#0Q%8*8?`}e2GJIj2Q82t~v(PTr>ZEExkcPF-u zC$rAT5C|+RBZ-BS!5<0zwVz89IB|AB5{fbUG!zA(qw$&rB00ZvDa(ya_sJ!Oz`RSQ za04-psW?lNfeFRTUn2QY1U$pDS7FjLJ*>?uYKEWY-BE|+?HO?gpqmUYRHUR92}nu3 z-lK=W%E)&wGN!n>Ec{gjZ67WpDLJ6+N8J?L&-=>DA*?k^vu2Po0}?8 znROC}qhOZ1Gq=+F(jUcLOshN z?w%3R>;w*OS={CJ^#kQ6Lo6dg-3?^@RRTXL3Xztbr7eZ2Vk+izVu5t5*I(*Lsp(Ji za0l7AzX4RyLid(B$U=}%Kj-=QyA;?jF~Ba6AvHRIq20pnA?6MwO?S6 z`nGY45YG$bL}%d}(`X)1ps3PhTRu{p8;Uk3hqgl>%yUZcbtndYkD*EP#l^PM2-%0p zJmtkc>$MKuu#os=F}j=Z2pK2W#NEle6iH)Y1x@t@pyLtu9HUxgn7=lrN@fOr9XW~D zbu>x1T*`cFnR`w)EoJ-YOP!4~KmN(vB`MQ_k@J+>kHi6Kb-bP;Vy^1*+4lGZW~`my zLr^n&m}^_n=x9ry&1N?-pWuMB3|%0;BWdaFwRpG-GcaDDeoQ^yV0YKn_R;i87QNj! zDbdMW2s8b`6&K=E$f{rA$KiauvDJ?kDe^Y2EH7K82#S702z{TtWhRZk(Kvm7`DwZ8 zJk1k@xqvRC%6c!~s=QxbybTcD2jVwrka(K$ow#&wURzQ2*MGiRAm7c;MPSx$fpSdT zu<0U^U47q}!R}b>UuR68)W_7Gm3M&{xw~oZ^Rdf^Y0s}Jwb`S~rD0xK2I^MC=Vdpajp#wLTbxaI1PB?V%fXazVuU0kws60#yq>Cfe z+yF}yNu}}MSwRLN^@>U#ve3vvogA6B|f*(h$qcl^9kWM@6<-%(kiKy+Qm$ zWRF0(V9P-(joG~+RwVj^>GHY^vn!G<2=decCe){Uc6is@VTb!eIXAtG~rTA+uEcRcNlV;Es;~j^J z&a_AW9x6+3QZ6J|w?nC=9fI#}jbI5RFwW(PGxx4HABwvkpExeAlLcB12aRV%YR6mV z88}^F((HLj5P+%`5x%q2h|$FX^en-WH~tr=w2k!lZj!AR6xc^}arVm&mvuXz8=|OW z%_Cf9YwlvYoZUbRw}xHllRGlck6evg9ZLO(eVuKLy`2)`-wX_W$#vmjCC$DE!;q=E z#YLt$lx^QEI&UqLPBTwGVR7fIv=2*uMDcEy^e5bn_t9qhUSQXcqKhKDEL_%b(MCBZ z;f2ttSPT*!ZB1l%RLD`;iXr_F&!e2y^sXh{Zr|!jy~fLp`0c%##AqNdsyYt@M=TPm zyL+0|m6SS>JzK6D|7nr${zlrZ{#|aUsC}Vy>s!m^8Y`%*DCAW{;&qf|61U0709jX2 z8>t-Jz<6`~$QFNK?(r|2C=&QV9p^kdm!9nP$bW#uqSfrM&U3QW%^8+?s}1PCAmO|A z-2HdB{H0)&2FjSUX?BEUL;yUP8F^kT1;Xcx^Rg3}2Wr^OIb^>Y=iMCi^|0#zISd)^ z^0Lg>-#JOB_i8WSEh4u%)_rp1p7UtyC?ld6>agn8G1Pd=!lPi`pJWpZ^2RGGT_u0P zZ~PC7oP4;1car0YSgk&WN!HQN3>|AxU^U)EdRuesL^sD4+ONw4vy*CY?YWx4E$jcPNI=R32L{{}dSX z`CyxZk93PSYmno8NXG|XfqTqCY27OtVo9w)jhe9gA*Zw=rkqBnEk`82TgOa;h7QV@ zD~8{&^Ir*Numh{k9j zosy^a-d8XE39NsT+A}mRDRxIgH%j z4D?^z?U;xsYwi!zFQhURKLR9>4)=I|Ppu~2WYzuyuK?#mbqS`#*oT*5PU;{`2tG0R zvK0{&E(}C(Ld`MLvV3LlC>f!N9Zs0-AMIc!x^wg?iR$1)s&poe+fCT-D&URFDKJ ziIAt|S8u-!+OEc8^5RM!4%Ix>uBaY*#+lgEt^LgAIz=(;1^~$?#(a2vt(yM%Q(M2k zw#DQ2ex3en?Q)pc<#mrwzhRxmlc9I?^YC8Ra7&GZL9GN+&zoVDyKaf+`mvt}s_s@? z4kzs1Oz?bZL465O`S~N3A6Eg@xpy$z>KHu~P1f$Q8+0tNQy^s@r$j5O`VWn7^;BQN zkp4(WZN7Z{c3mFE1P>yt96<(_sHZY+&Mjt+aqb8_5JH>x0(L07aUJz;kVE_^q;_` z52`noh*q4*s$sdt>4t$Qu`-o?AcaB3pEIO^V<@)iAWrZ@WASh{KeS`NWqNHeSKQ*l zjN9Y2rso_*;tXiwc+4#hB?~HG@+O*2_?G-tz=>1=%51RMR1?C$Z zKBqBxTnK(|HnM)>wJ+_}?a+E^LeubDXf|GxmTXx-vSg+r1m1lJH<*>fSKAUwczd?i zZ46~ry?^Do;H84;zcTo&X)dl7!=mz=lvI-22&bNVWv(0Hn{>2R>bma(TP z`#xA_1?SpY$QLf_54v%a+t)Iw+TA4j3zjyJKR^4*8=$pw%^-UmRF|}+muM{?I=%a} zYA~cjX=q*iN1u=Fv3bi*aJQb1u4wb4Qn?BSwYtx9wh<8SW^%E*=9tMRgcq6*y$^J% zSK~r|asSYxcB!URD)F2_2Cx_=+CBs^#4+nby@OFtDZ7G6xtB?(*AkTTcd5bz{sWRD z>_$9YHovaPILkGt+SWrkQhQCQdD5Re%^x=C>|qD~Xv$1fh*~UukXe(NA4xW=2HZzA z8}Ob0cdE*`*_<&M&nkCH>`Obu4J!*muQKDNdnnL|#GE&irF>EaHROzS8IzKAvjkL? z^+C-)lka}{;3$)CzG0;MjJhEzzG^(*?#=L+I;qsVD|zF(O1s)j@mBq_`}K=1kb|7@ zi(EJUjWu&qc98a@XIN7uwO9PjZ^mF>-B=!38As@3#0ab?uf0z?V?W^Qd5$b z80~*p07be6-4&2# zCq>#{^RnSgS$wL=irLlTpZaIr{0z8p>a_EF z{$LYy?^J5;QX({OGpXytEb*3(o?`9qqKy4tEUya>h~(_m+2yW1b{4_eF*^Ls-x%fR zyTA)O=o?uMA~^?Q zYYFuv4L@D=VGwK-1$bL+FcmjsljpX!qT+oMIcK$H&>5_&svggXN(NX+erZe(i#iDt zb3kdp%x?3gSmn(h2kzBnt6u%FxOtjY2w(bUgl?U+S_S0VVV3zOr6VIqsylQ4#^b8F)| zBtTal^xnhy@S!~rCEveOE-UrA*IYB%wqT-(kmj9Igxb6{mc~!)zq`yqojK_cDDGSW6q9$IhTcK>W*DDZTA+%eaJFAD1)frlEq#7U_ zGQ604nZFh+5|nwdowOfELjg5HyP$Ub$Ebv&BwF*$X4)h&VV&@>Q(}otP)L}7jRbY! zLzu#gZaIUr4av1snx^2!P>zP7+b)tim$+YCGMxM5+L|IOqo3=@$LEcc)SrK|LpdWS zLce{%x0g23F$>Iua_&aeUhWI!c;C>Il4MIXiGJV;S-K!?N?sP5Z-*A;FSR@Ro6HA(Sk zJ^VD$=~lKv?6`k1GN8QH{OLy3&7^IiFkDJ(RJj*r+3_>j^5|j813@E+;Rh4VM|L&f zPKp;gf`wnOu=*!9owpFZhWaob#@$|`!0AT)+u}P%LjWmU! zv7)Ccv1sY+X2?6Ka8Y;+Rh>h30nBg|db{;9`oI2hI2`wX+l(#%N2W*LuZt%z4pBb)dP3@D+!cLa|&YPZIC*m}(H}Dalp@)o*hkDs7C;qx2*zxDzG$l3E{*C?XsRypC>;`oAa|XDpu}u-#)e9)W0o_Hy}y ztv8(-fWdaWu+c&E5Z`lM9kf`Ht28NCZ)M)ZqHqB%{?+vId`%$dmL``)85Y#QXBqVgw52St2AOp>|H zZ#7m3Z^PDex~l*=qKxd8`9{Rbm2xN)agdjD{9iQ89AD)6KQ;_I|6~rtOjRdUmKDAv zdGq(cjqVRtZ)z zT>eDLiuB2J%MyX`WWHhi%A#|uig6$RsJejobK@^F0=@9Nr+r*Zclf5J2PQe0|IW9Z z^+{oSP1$0(yOIU&BJZz2Oo^{YUFL=CGXn&O~;|7+r zG4K%QHcG4fR6=RJ@*sf_B2@^GVEVad4cJM!B@7*Ej4Lc!Su9t!MdP+C{PXM1zwis9 zH0RZ1tGOK;w;i|(x*t{6_t52V^(z*JESo`z_TaW4Mx75Qmjh zgqy9^eSAm)c0w!1J+6RhBtIV-NVkc#iK&o7BKK>9nQD;AS-UQ`&F`eDkSan`W0$Ura!*Dmx8#M|IRqunXez|AS zD}7w%m3|Cn59gmHdygmqcmja~Du)*u@uh{Stplu=3-{z1UAXo0c&mZ%j3=+GGuVgx zCTEktcg~q=XyPF47FIEA54042B0dlB1FDn#u;;zsoylTzrqwnR$$YSU$;Qv~Rvt-f z@`gxH=N@S)H1`S#z6vgk*J=NWYOxL_o6ci5c;*igA9e0N<1@X4qG5Z2KdVak$^3uy zNy--79n*8$t1Kr%!>Q3IjWRV!Fml&z5y4+%x2HMj${AM^c-CJf9fz@jH70#_pssZ; zjCr#~?udrHSKh~%YnpkYft#MA^1Jus_JP^=MuDdO8y-_9EZ+%y5 z#w74bd_bA0kCzi4Z+)UlX4Ru2yZ`A(z)D-dNPo1YGLDNH)I|wnD8x~sJ=&B%GZbQ} z(4Qq`)!PfQ>T~uVU25&8T2&bGm*`UZlv7BGQhjvSxC22G=S{z%To4%0ZY@@&)-YBL zBFdFj1#rgEoCeghg6ifmI8LU9Ob^qu8XkAScm8z?PY!}PfAUdVm$}EXarUUG?Y+q1 zR(Bfl7_PD!XVjDgGa#a4IY~M4qFRJCq(yh%vOp)vQYJq#OzEzB=sLYAs#5bL;I01Y zDjYkjOjjVK(JI(O65=&_booKSHc=( z5P;HLe>dq}M{JBx;k$ul;pWb_dkzqV=4hdYqmJ8@$M7`ecWg1S!zD}trd=YLfH%{Ij0AIF6ai?>OEZg3E&pOE=F~yxdovMC?)PaZ`ivw)?Z3BCrCd=-+MM!S$(u z)tC-(v8_7M+!p>N)e1PDn@V8?U5u|8yQ_Dch?a39&8;S;OBY(3NY3Y`kQkjVzk88+ z5={BCy)u^kxf+B+<4ypYd~*90^@$qf{rB~ZXqT9^xkhHz_kYK~#pOU)1t65SWo>lM zlDpp>su!Gm)#9_Rj_yn~?-zL0t2uc3c&l%Db~WZpkUXb9W7`S(rWam^e$fS|e4Y~B z8tv*X%>L;+SnHRw4&i=?ddm9;D!5+Cz{aUNVpA4X1cJYVC4YapbXL|^V_oFA>=mLG z!JkTL)fmn8iJ==DyB-H& zsx&o>>Myl7QXYc0b)Jf<)CSNuN%~e32&}5{%feYndWd4tKngBMd1vxK(ulEHZMKgK zX+uR2Xe@AQEF|qF;ueie#_sGW1~fX-QS`tgA%^w z(Sk#2bhZ6&nsvR2+|=iBFvOWePoT}qXMz|T^~G~re6tkQ`Gl=H_o$0*-nl>f+VX_i{6Q zjHIm=U8J#U5^jN$^p6pTk3D8p$@~BJL+)&WbZ*dPEQsS}WsJ|5CDEn%;vq7ps#Z&6%8>fa2{qkp0GqCbtA93qsX>mUtLAF17sG>DeNEvZ| znI6m5eU@^(?dqDG1I=6W0>50p*bwQMY$~yQDrU;p|2aH5 zsnCzwW0p$SkEDzt2(63X(Hcs;F*c!cQ4A8vqiBTN@v`y<)z>lHyjOa$t1xy*a|{ON zjUsx3A~yX5=f=4UVsAD6?VqsxIPizuPaj?@e60HPv0mX*+ow<6cm+08@23fc&TpSO ze<*a7DWLMeUB3f)vU>$LKjFv~d#b`XNx+?sXkZl7P216@qS(U$W>2~PSli2sRue*W z$nCPRGOV-SSw}NDuqAbH+<84nweFq=T;#_nH+PJ5D~=9!j7}(yed`$ep*X(ZCyr4c z|I;ynSDb`LOxE@)AUc%;`gm8>6zG&@WIAWsI^;&xCN@Bf#xY8YN^`Ce6B5x}HW4E- zDPs!i!jci{07oq`b^*^Wyj~>6?nqD_A!3Sq%klE@ga7_YyXqYD)u^c}jJ&yHcAj@_ z3_t)oXJ2_NxU5xEVc^zBRHi_LTd(3!-s4b_k5n92T7HOsUwtaK@)DwWD-s&=mVN&5 zdr)dk)vXQ+y~YYxY3Ln3)6_}Z)XKc=C~_VqJ8iaX>OCOPo{N;kL~gfz-QJgqo`{ug z01H7vr@m6Ga(pPMSAL3)`T1U2*TXCLSnk)p=8AB;AMJzNN2sUf@zp9%d&F~?S=F8x1V#hYgSXbJeDU~UEs+h&LukDb^y9gX8Yif zTKS94Z(Zt}yaT7`D3#w#0yC1vefR#eT`aGCHT$)Ow1A85iHpY)*I#<^>?e-x24|6Y z5`+9^iyvU)s(1MptzW-6{W0j9ty`JdQ?|w+H{0c$US)Rk@Cf{2Q!w6{HA~?A*mzVs zQTDVbt?T%__Uyh>1c3RzE;BG`DG)ET0=z^(QVHm#=u+u9f^BNlTS zQE8nAxn#MYHWKz`QxZZ7pB<?Ps2j(^W-VSb>CmLp~a0amZ@eaGN=tw*`>eYk_ zHEHV$WcpXB^C`e{b1r`-n`zbGP|W5}*95Sbh<&B*x0pIRvACT_Npw9ODsj&CG=;hs zNo^W?bw6i04EUDaKkW3Mt1Q62I6)6$_dDg< zoix=92K|kiO(9ghb6Q@%Z8%nLm;-_F6a!*dNPKe+O^Yr3%+CoKt`EwF1=#}v?q z8@sVOSk$H6b?m2 zWN|++Zg~QhQR}^^(WJiL(OCN<;qH3qqjvZnoWZ1lh1aWnf!q9Nq=7fXW|eAEs3hXQ z;dmO$R=zp6F0)f>J{)0b!X0aB;a%Srs_vYbHVSep&S8tY?_c}6t%()2v>bI4Sv`+sM#Z8qz?JEjw)R&eUgzwNq8*I% zv6x0evitb^@XNcvh2dQiNXkZOvl9DvPa*BIG>WhxjW}FcTp4yiKGXE>afkrR*ifv5 zxORqc&NiE0l4JI|i*`naUz7_qUb{^ruVq-{y&<~;>yuS0Z8--g=1IES_B*I6e^<<@ z{$qkfafm`X$*FPy({P*gsd|$}Y*b70mXKe*p6yX)F7w)!NEE%kJ(*c9xB)Jfkw0pG z5yKSec~|PFWVDbstKcidMd?irNeD7aX|B$hp6dRqMjOr?wFk69o%x1=>(jaW0XquM zt zq$ZqXSn0hgiGBl^VH1bo!|M$wMT7eo(e`|HHttkK{KTb>oQ_KYpJ!gS`c#qpBIi=5 znDVKJ&mYG?xsw`Gj~bFvDdZpNW}TW7JUD-|YgTO4^!008y9wWq!jjNkKT;bTwL3Fb zgVbX)b3bq!3@lJhS>&f_(pK+`&Zb(g8+n;d{@8k-egUXR^K)NbM{3KL@v@_F=4D(} ztUs|Z0r3pW37fm`hROsuJd%bTbjM0Fo4LxR_p?Gm`sm;1_48$Bqz0u^x7Sd3Noa^A zxx}hJ-p}{E;vebQG9b)t-1pLy*ncB&sLnJ)=gF1iM;d7U$F|2nTcLG|WaCRI!$GmW zmsXxF*|w!zM?jL%^Gm!UK6;?jL{*Fbok@zBb~F_Zt0_I(`1x9Hi)9516BcD7!k81Z zwD1SN3A(q^|RT-8yEjfKU*`KM!i}Wj%+StoIz;{pw|)&n!&U~*a4}J zeq^DWF}CMexWYI^nkTx9?)`i$hpauZv%VwaLE?c=&Qeu=XnOw>(p^#L^g>Q+-Uq@p zxZ*g-$xV`gjyJHMQ`GO7NlG-;TTGmwo9b-}Ao@-nT^u*}TB4rkI`xXcK+G`cxk?Q0 zq}PmybJJdrJ6`iBbGpZ$h4JsZh}klhL(vPlY1K5}*fPcyq?Y`5isuXeYUf-T0y>2C zW{&+|OeJ;le}AXYW$h^QZL^irkgMW*W28d(T8>-dLh6uzvO-nCVJqc^fg-RIxOC>C zjch1h{*;KL-sPr7nWA4kyiO$4-5u;DoI4Jd(17V8WvyATh?qY*iI5q ze)g*46@H(F1Yjf)p5k1>mMN2ThOcMBu?gLjpB94XOW^`slhiJY^+a)jfzgO znLiD3?4zN@7m;NhEX1rhAb<4E<~A4W`O^Mzllx=^oK6X8Jm^)zuY z3B477K(HZ~_U+m%BL2z-I&M81{fBC$jXcu9hc7F{{wH0rcmCGrcGr6A_Z@oWpUmKh zUA*HZxHxKz-p8=%f03^oI#MzKC-T<{%?ZJ#`XOTf9wl@GSI2)JkY70X@ZG7>1)tyz z9sfak|FMG@&x`BZ}p%El|OQsUfnRKW=$RE?-+k_cK%>V!sx+Jhii z(%KWEDF}%NduF5n-)O_L!b!;CBq`kQ4$C?@t2+rrP2td_X4(l-hn*CJVY++}^ggWt1&u)i{c{sW+f}wY zG1^?-!u~03wO?$MSk72KN_-Tf447FKAiQS+6gE=P98<~c02fA#Xdl#f0J6Eps_*Ni zA4LWQSfOZEXfKN5l=yQ^g6=R2l{o7k6V#On3j~FNJD~nEAqc^-6RL51iq~cGZ_%dY zqxNV2G07@2jY5la(5|u>QWoNVQL#~Kocv-v^W)$@W&h)dlIcab7xO$cMG%m)k30fL zKSz#FibSJt04&)Vmh8rXjscBIHwCh%`Lq1_c&aGq{k*cZR@_hdoBUA)rZ>f={7@`^ zL;@V^gDN#e&5Ltpkk>LeJZ?y08O{`#puECQn+n&83x9hLVsQ}pY?^iE%M=0OV{7EO z68|$j&9;5}UWY}pu=8_ei9Vw|2~TA3TZKQt9;{3X7K@TGV33m_c+j!LHJc*wRi^FR}K91IF+5p05j3`kv}bIv&zO}^u0`!{)zJM$0|@P0*1Z`hpU`tsVJPF z$7DyN$t1*?Ptx}sb|_5k~%K}bn=^ZUY+TbNa|Ju=+-przCF`zl+input,html.theme--catppuccin-frappe .button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:.4em;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}html.theme--catppuccin-frappe .pagination-previous:focus,html.theme--catppuccin-frappe .pagination-next:focus,html.theme--catppuccin-frappe .pagination-link:focus,html.theme--catppuccin-frappe .pagination-ellipsis:focus,html.theme--catppuccin-frappe .file-cta:focus,html.theme--catppuccin-frappe .file-name:focus,html.theme--catppuccin-frappe .select select:focus,html.theme--catppuccin-frappe .textarea:focus,html.theme--catppuccin-frappe .input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-frappe .button:focus,html.theme--catppuccin-frappe .is-focused.pagination-previous,html.theme--catppuccin-frappe .is-focused.pagination-next,html.theme--catppuccin-frappe .is-focused.pagination-link,html.theme--catppuccin-frappe .is-focused.pagination-ellipsis,html.theme--catppuccin-frappe .is-focused.file-cta,html.theme--catppuccin-frappe .is-focused.file-name,html.theme--catppuccin-frappe .select select.is-focused,html.theme--catppuccin-frappe .is-focused.textarea,html.theme--catppuccin-frappe .is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-focused.button,html.theme--catppuccin-frappe .pagination-previous:active,html.theme--catppuccin-frappe .pagination-next:active,html.theme--catppuccin-frappe .pagination-link:active,html.theme--catppuccin-frappe .pagination-ellipsis:active,html.theme--catppuccin-frappe .file-cta:active,html.theme--catppuccin-frappe .file-name:active,html.theme--catppuccin-frappe .select select:active,html.theme--catppuccin-frappe .textarea:active,html.theme--catppuccin-frappe .input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-frappe .button:active,html.theme--catppuccin-frappe .is-active.pagination-previous,html.theme--catppuccin-frappe .is-active.pagination-next,html.theme--catppuccin-frappe .is-active.pagination-link,html.theme--catppuccin-frappe .is-active.pagination-ellipsis,html.theme--catppuccin-frappe .is-active.file-cta,html.theme--catppuccin-frappe .is-active.file-name,html.theme--catppuccin-frappe .select select.is-active,html.theme--catppuccin-frappe .is-active.textarea,html.theme--catppuccin-frappe .is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-frappe .is-active.button{outline:none}html.theme--catppuccin-frappe .pagination-previous[disabled],html.theme--catppuccin-frappe .pagination-next[disabled],html.theme--catppuccin-frappe .pagination-link[disabled],html.theme--catppuccin-frappe .pagination-ellipsis[disabled],html.theme--catppuccin-frappe .file-cta[disabled],html.theme--catppuccin-frappe .file-name[disabled],html.theme--catppuccin-frappe .select select[disabled],html.theme--catppuccin-frappe .textarea[disabled],html.theme--catppuccin-frappe .input[disabled],html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled],html.theme--catppuccin-frappe .button[disabled],fieldset[disabled] html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe fieldset[disabled] .pagination-previous,fieldset[disabled] html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe fieldset[disabled] .pagination-next,fieldset[disabled] html.theme--catppuccin-frappe .pagination-link,html.theme--catppuccin-frappe fieldset[disabled] .pagination-link,fieldset[disabled] html.theme--catppuccin-frappe .pagination-ellipsis,html.theme--catppuccin-frappe fieldset[disabled] .pagination-ellipsis,fieldset[disabled] html.theme--catppuccin-frappe .file-cta,html.theme--catppuccin-frappe fieldset[disabled] .file-cta,fieldset[disabled] html.theme--catppuccin-frappe .file-name,html.theme--catppuccin-frappe fieldset[disabled] .file-name,fieldset[disabled] html.theme--catppuccin-frappe .select select,fieldset[disabled] html.theme--catppuccin-frappe .textarea,fieldset[disabled] html.theme--catppuccin-frappe .input,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe fieldset[disabled] .select select,html.theme--catppuccin-frappe .select fieldset[disabled] select,html.theme--catppuccin-frappe fieldset[disabled] .textarea,html.theme--catppuccin-frappe fieldset[disabled] .input,html.theme--catppuccin-frappe fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] html.theme--catppuccin-frappe .button,html.theme--catppuccin-frappe fieldset[disabled] .button{cursor:not-allowed}html.theme--catppuccin-frappe .tabs,html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe .pagination-link,html.theme--catppuccin-frappe .pagination-ellipsis,html.theme--catppuccin-frappe .breadcrumb,html.theme--catppuccin-frappe .file,html.theme--catppuccin-frappe .button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}html.theme--catppuccin-frappe .navbar-link:not(.is-arrowless)::after,html.theme--catppuccin-frappe .select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}html.theme--catppuccin-frappe .admonition:not(:last-child),html.theme--catppuccin-frappe .tabs:not(:last-child),html.theme--catppuccin-frappe .pagination:not(:last-child),html.theme--catppuccin-frappe .message:not(:last-child),html.theme--catppuccin-frappe .level:not(:last-child),html.theme--catppuccin-frappe .breadcrumb:not(:last-child),html.theme--catppuccin-frappe .block:not(:last-child),html.theme--catppuccin-frappe .title:not(:last-child),html.theme--catppuccin-frappe .subtitle:not(:last-child),html.theme--catppuccin-frappe .table-container:not(:last-child),html.theme--catppuccin-frappe .table:not(:last-child),html.theme--catppuccin-frappe .progress:not(:last-child),html.theme--catppuccin-frappe .notification:not(:last-child),html.theme--catppuccin-frappe .content:not(:last-child),html.theme--catppuccin-frappe .box:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-frappe .modal-close,html.theme--catppuccin-frappe .delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}html.theme--catppuccin-frappe .modal-close::before,html.theme--catppuccin-frappe .delete::before,html.theme--catppuccin-frappe .modal-close::after,html.theme--catppuccin-frappe .delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-frappe .modal-close::before,html.theme--catppuccin-frappe .delete::before{height:2px;width:50%}html.theme--catppuccin-frappe .modal-close::after,html.theme--catppuccin-frappe .delete::after{height:50%;width:2px}html.theme--catppuccin-frappe .modal-close:hover,html.theme--catppuccin-frappe .delete:hover,html.theme--catppuccin-frappe .modal-close:focus,html.theme--catppuccin-frappe .delete:focus{background-color:rgba(10,10,10,0.3)}html.theme--catppuccin-frappe .modal-close:active,html.theme--catppuccin-frappe .delete:active{background-color:rgba(10,10,10,0.4)}html.theme--catppuccin-frappe .is-small.modal-close,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.modal-close,html.theme--catppuccin-frappe .is-small.delete,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}html.theme--catppuccin-frappe .is-medium.modal-close,html.theme--catppuccin-frappe .is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}html.theme--catppuccin-frappe .is-large.modal-close,html.theme--catppuccin-frappe .is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}html.theme--catppuccin-frappe .control.is-loading::after,html.theme--catppuccin-frappe .select.is-loading::after,html.theme--catppuccin-frappe .loader,html.theme--catppuccin-frappe .button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #838ba7;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}html.theme--catppuccin-frappe .hero-video,html.theme--catppuccin-frappe .modal-background,html.theme--catppuccin-frappe .modal,html.theme--catppuccin-frappe .image.is-square img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-frappe .image.is-square .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-frappe .image.is-1by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-frappe .image.is-1by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-frappe .image.is-5by4 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-frappe .image.is-5by4 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-frappe .image.is-4by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-frappe .image.is-4by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-frappe .image.is-3by2 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-frappe .image.is-3by2 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-frappe .image.is-5by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-frappe .image.is-5by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-frappe .image.is-16by9 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-frappe .image.is-16by9 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-frappe .image.is-2by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-frappe .image.is-2by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-frappe .image.is-3by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-frappe .image.is-3by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-frappe .image.is-4by5 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-frappe .image.is-4by5 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-frappe .image.is-3by4 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-frappe .image.is-3by4 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-frappe .image.is-2by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-frappe .image.is-2by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-frappe .image.is-3by5 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-frappe .image.is-3by5 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-frappe .image.is-9by16 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-frappe .image.is-9by16 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-frappe .image.is-1by2 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-frappe .image.is-1by2 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-frappe .image.is-1by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-frappe .image.is-1by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}html.theme--catppuccin-frappe .navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#f5f5f5 !important}a.has-text-light:hover,a.has-text-light:focus{color:#dbdbdb !important}.has-background-light{background-color:#f5f5f5 !important}.has-text-dark{color:#414559 !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#2b2e3c !important}.has-background-dark{background-color:#414559 !important}.has-text-primary{color:#8caaee !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#6089e7 !important}.has-background-primary{background-color:#8caaee !important}.has-text-primary-light{color:#edf2fc !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#c1d1f6 !important}.has-background-primary-light{background-color:#edf2fc !important}.has-text-primary-dark{color:#153a8e !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#1c4cbb !important}.has-background-primary-dark{background-color:#153a8e !important}.has-text-link{color:#8caaee !important}a.has-text-link:hover,a.has-text-link:focus{color:#6089e7 !important}.has-background-link{background-color:#8caaee !important}.has-text-link-light{color:#edf2fc !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#c1d1f6 !important}.has-background-link-light{background-color:#edf2fc !important}.has-text-link-dark{color:#153a8e !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#1c4cbb !important}.has-background-link-dark{background-color:#153a8e !important}.has-text-info{color:#81c8be !important}a.has-text-info:hover,a.has-text-info:focus{color:#5db9ac !important}.has-background-info{background-color:#81c8be !important}.has-text-info-light{color:#f1f9f8 !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#cde9e5 !important}.has-background-info-light{background-color:#f1f9f8 !important}.has-text-info-dark{color:#2d675f !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#3c8a7f !important}.has-background-info-dark{background-color:#2d675f !important}.has-text-success{color:#a6d189 !important}a.has-text-success:hover,a.has-text-success:focus{color:#8ac364 !important}.has-background-success{background-color:#a6d189 !important}.has-text-success-light{color:#f4f9f0 !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#d8ebcc !important}.has-background-success-light{background-color:#f4f9f0 !important}.has-text-success-dark{color:#446a29 !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#5b8f38 !important}.has-background-success-dark{background-color:#446a29 !important}.has-text-warning{color:#e5c890 !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#dbb467 !important}.has-background-warning{background-color:#e5c890 !important}.has-text-warning-light{color:#fbf7ee !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#f1e2c5 !important}.has-background-warning-light{background-color:#fbf7ee !important}.has-text-warning-dark{color:#78591c !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#a17726 !important}.has-background-warning-dark{background-color:#78591c !important}.has-text-danger{color:#e78284 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#df575a !important}.has-background-danger{background-color:#e78284 !important}.has-text-danger-light{color:#fceeee !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#f3c3c4 !important}.has-background-danger-light{background-color:#fceeee !important}.has-text-danger-dark{color:#9a1e20 !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#c52629 !important}.has-background-danger-dark{background-color:#9a1e20 !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#414559 !important}.has-background-grey-darker{background-color:#414559 !important}.has-text-grey-dark{color:#51576d !important}.has-background-grey-dark{background-color:#51576d !important}.has-text-grey{color:#626880 !important}.has-background-grey{background-color:#626880 !important}.has-text-grey-light{color:#737994 !important}.has-background-grey-light{background-color:#737994 !important}.has-text-grey-lighter{color:#838ba7 !important}.has-background-grey-lighter{background-color:#838ba7 !important}.has-text-white-ter{color:#f5f5f5 !important}.has-background-white-ter{background-color:#f5f5f5 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}html.theme--catppuccin-frappe html{background-color:#303446;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-frappe article,html.theme--catppuccin-frappe aside,html.theme--catppuccin-frappe figure,html.theme--catppuccin-frappe footer,html.theme--catppuccin-frappe header,html.theme--catppuccin-frappe hgroup,html.theme--catppuccin-frappe section{display:block}html.theme--catppuccin-frappe body,html.theme--catppuccin-frappe button,html.theme--catppuccin-frappe input,html.theme--catppuccin-frappe optgroup,html.theme--catppuccin-frappe select,html.theme--catppuccin-frappe textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}html.theme--catppuccin-frappe code,html.theme--catppuccin-frappe pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-frappe body{color:#c6d0f5;font-size:1em;font-weight:400;line-height:1.5}html.theme--catppuccin-frappe a{color:#8caaee;cursor:pointer;text-decoration:none}html.theme--catppuccin-frappe a strong{color:currentColor}html.theme--catppuccin-frappe a:hover{color:#99d1db}html.theme--catppuccin-frappe code{background-color:#292c3c;color:#c6d0f5;font-size:.875em;font-weight:normal;padding:.1em}html.theme--catppuccin-frappe hr{background-color:#292c3c;border:none;display:block;height:2px;margin:1.5rem 0}html.theme--catppuccin-frappe img{height:auto;max-width:100%}html.theme--catppuccin-frappe input[type="checkbox"],html.theme--catppuccin-frappe input[type="radio"]{vertical-align:baseline}html.theme--catppuccin-frappe small{font-size:.875em}html.theme--catppuccin-frappe span{font-style:inherit;font-weight:inherit}html.theme--catppuccin-frappe strong{color:#b0bef1;font-weight:700}html.theme--catppuccin-frappe fieldset{border:none}html.theme--catppuccin-frappe pre{-webkit-overflow-scrolling:touch;background-color:#292c3c;color:#c6d0f5;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}html.theme--catppuccin-frappe pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}html.theme--catppuccin-frappe table td,html.theme--catppuccin-frappe table th{vertical-align:top}html.theme--catppuccin-frappe table td:not([align]),html.theme--catppuccin-frappe table th:not([align]){text-align:inherit}html.theme--catppuccin-frappe table th{color:#b0bef1}html.theme--catppuccin-frappe .box{background-color:#51576d;border-radius:8px;box-shadow:none;color:#c6d0f5;display:block;padding:1.25rem}html.theme--catppuccin-frappe a.box:hover,html.theme--catppuccin-frappe a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #8caaee}html.theme--catppuccin-frappe a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #8caaee}html.theme--catppuccin-frappe .button{background-color:#292c3c;border-color:#484d69;border-width:1px;color:#8caaee;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}html.theme--catppuccin-frappe .button strong{color:inherit}html.theme--catppuccin-frappe .button .icon,html.theme--catppuccin-frappe .button .icon.is-small,html.theme--catppuccin-frappe .button #documenter .docs-sidebar form.docs-search>input.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .button form.docs-search>input.icon,html.theme--catppuccin-frappe .button .icon.is-medium,html.theme--catppuccin-frappe .button .icon.is-large{height:1.5em;width:1.5em}html.theme--catppuccin-frappe .button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}html.theme--catppuccin-frappe .button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-frappe .button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-frappe .button:hover,html.theme--catppuccin-frappe .button.is-hovered{border-color:#737994;color:#b0bef1}html.theme--catppuccin-frappe .button:focus,html.theme--catppuccin-frappe .button.is-focused{border-color:#737994;color:#769aeb}html.theme--catppuccin-frappe .button:focus:not(:active),html.theme--catppuccin-frappe .button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .button:active,html.theme--catppuccin-frappe .button.is-active{border-color:#51576d;color:#b0bef1}html.theme--catppuccin-frappe .button.is-text{background-color:transparent;border-color:transparent;color:#c6d0f5;text-decoration:underline}html.theme--catppuccin-frappe .button.is-text:hover,html.theme--catppuccin-frappe .button.is-text.is-hovered,html.theme--catppuccin-frappe .button.is-text:focus,html.theme--catppuccin-frappe .button.is-text.is-focused{background-color:#292c3c;color:#b0bef1}html.theme--catppuccin-frappe .button.is-text:active,html.theme--catppuccin-frappe .button.is-text.is-active{background-color:#1f212d;color:#b0bef1}html.theme--catppuccin-frappe .button.is-text[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}html.theme--catppuccin-frappe .button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#8caaee;text-decoration:none}html.theme--catppuccin-frappe .button.is-ghost:hover,html.theme--catppuccin-frappe .button.is-ghost.is-hovered{color:#8caaee;text-decoration:underline}html.theme--catppuccin-frappe .button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white:hover,html.theme--catppuccin-frappe .button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white:focus,html.theme--catppuccin-frappe .button.is-white.is-focused{border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white:focus:not(:active),html.theme--catppuccin-frappe .button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-frappe .button.is-white:active,html.theme--catppuccin-frappe .button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}html.theme--catppuccin-frappe .button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .button.is-white.is-inverted:hover,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-hovered{background-color:#000}html.theme--catppuccin-frappe .button.is-white.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-frappe .button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-white.is-outlined:hover,html.theme--catppuccin-frappe .button.is-white.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-white.is-outlined:focus,html.theme--catppuccin-frappe .button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-white.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-white.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-white.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-frappe .button.is-white.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-black:hover,html.theme--catppuccin-frappe .button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-black:focus,html.theme--catppuccin-frappe .button.is-black.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-black:focus:not(:active),html.theme--catppuccin-frappe .button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-frappe .button.is-black:active,html.theme--catppuccin-frappe .button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-black[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}html.theme--catppuccin-frappe .button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black.is-inverted:hover,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-frappe .button.is-black.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black.is-outlined:hover,html.theme--catppuccin-frappe .button.is-black.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-black.is-outlined:focus,html.theme--catppuccin-frappe .button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-frappe .button.is-black.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-black.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-black.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-black.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-light{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light:hover,html.theme--catppuccin-frappe .button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light:focus,html.theme--catppuccin-frappe .button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light:focus:not(:active),html.theme--catppuccin-frappe .button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-frappe .button.is-light:active,html.theme--catppuccin-frappe .button.is-light.is-active{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-light{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none}html.theme--catppuccin-frappe .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-frappe .button.is-light.is-inverted:hover,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-frappe .button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;color:#f5f5f5}html.theme--catppuccin-frappe .button.is-light.is-outlined:hover,html.theme--catppuccin-frappe .button.is-light.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-light.is-outlined:focus,html.theme--catppuccin-frappe .button.is-light.is-outlined.is-focused{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-frappe .button.is-light.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-light.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-light.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-light.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-dark,html.theme--catppuccin-frappe .content kbd.button{background-color:#414559;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-dark:hover,html.theme--catppuccin-frappe .content kbd.button:hover,html.theme--catppuccin-frappe .button.is-dark.is-hovered,html.theme--catppuccin-frappe .content kbd.button.is-hovered{background-color:#3c3f52;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-dark:focus,html.theme--catppuccin-frappe .content kbd.button:focus,html.theme--catppuccin-frappe .button.is-dark.is-focused,html.theme--catppuccin-frappe .content kbd.button.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-dark:focus:not(:active),html.theme--catppuccin-frappe .content kbd.button:focus:not(:active),html.theme--catppuccin-frappe .button.is-dark.is-focused:not(:active),html.theme--catppuccin-frappe .content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(65,69,89,0.25)}html.theme--catppuccin-frappe .button.is-dark:active,html.theme--catppuccin-frappe .content kbd.button:active,html.theme--catppuccin-frappe .button.is-dark.is-active,html.theme--catppuccin-frappe .content kbd.button.is-active{background-color:#363a4a;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-dark[disabled],html.theme--catppuccin-frappe .content kbd.button[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-dark,fieldset[disabled] html.theme--catppuccin-frappe .content kbd.button{background-color:#414559;border-color:#414559;box-shadow:none}html.theme--catppuccin-frappe .button.is-dark.is-inverted,html.theme--catppuccin-frappe .content kbd.button.is-inverted{background-color:#fff;color:#414559}html.theme--catppuccin-frappe .button.is-dark.is-inverted:hover,html.theme--catppuccin-frappe .content kbd.button.is-inverted:hover,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-hovered,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-frappe .button.is-dark.is-inverted[disabled],html.theme--catppuccin-frappe .content kbd.button.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-dark.is-inverted,fieldset[disabled] html.theme--catppuccin-frappe .content kbd.button.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#414559}html.theme--catppuccin-frappe .button.is-dark.is-loading::after,html.theme--catppuccin-frappe .content kbd.button.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-dark.is-outlined,html.theme--catppuccin-frappe .content kbd.button.is-outlined{background-color:transparent;border-color:#414559;color:#414559}html.theme--catppuccin-frappe .button.is-dark.is-outlined:hover,html.theme--catppuccin-frappe .content kbd.button.is-outlined:hover,html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-hovered,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-dark.is-outlined:focus,html.theme--catppuccin-frappe .content kbd.button.is-outlined:focus,html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-focused,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-focused{background-color:#414559;border-color:#414559;color:#fff}html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-loading::after,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #414559 #414559 !important}html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-dark.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-frappe .content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-dark.is-outlined[disabled],html.theme--catppuccin-frappe .content kbd.button.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-dark.is-outlined,fieldset[disabled] html.theme--catppuccin-frappe .content kbd.button.is-outlined{background-color:transparent;border-color:#414559;box-shadow:none;color:#414559}html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-focused,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-focused{background-color:#fff;color:#414559}html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #414559 #414559 !important}html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined[disabled],html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-dark.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-frappe .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-primary,html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink{background-color:#8caaee;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-primary:hover,html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink:hover,html.theme--catppuccin-frappe .button.is-primary.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#81a2ec;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-primary:focus,html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink:focus,html.theme--catppuccin-frappe .button.is-primary.is-focused,html.theme--catppuccin-frappe .docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-primary:focus:not(:active),html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink:focus:not(:active),html.theme--catppuccin-frappe .button.is-primary.is-focused:not(:active),html.theme--catppuccin-frappe .docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .button.is-primary:active,html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink:active,html.theme--catppuccin-frappe .button.is-primary.is-active,html.theme--catppuccin-frappe .docstring>section>a.button.is-active.docs-sourcelink{background-color:#769aeb;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-primary[disabled],html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-primary,fieldset[disabled] html.theme--catppuccin-frappe .docstring>section>a.button.docs-sourcelink{background-color:#8caaee;border-color:#8caaee;box-shadow:none}html.theme--catppuccin-frappe .button.is-primary.is-inverted,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .button.is-primary.is-inverted:hover,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.docs-sourcelink:hover,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}html.theme--catppuccin-frappe .button.is-primary.is-inverted[disabled],html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-primary.is-inverted,fieldset[disabled] html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#8caaee}html.theme--catppuccin-frappe .button.is-primary.is-loading::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-primary.is-outlined,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#8caaee;color:#8caaee}html.theme--catppuccin-frappe .button.is-primary.is-outlined:hover,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-frappe .button.is-primary.is-outlined:focus,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-focused,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#8caaee;border-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-loading::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #8caaee #8caaee !important}html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-frappe .button.is-primary.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-primary.is-outlined[disabled],html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-primary.is-outlined,fieldset[disabled] html.theme--catppuccin-frappe .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#8caaee;box-shadow:none;color:#8caaee}html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-focused,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #8caaee #8caaee !important}html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined[disabled],html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-primary.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-frappe .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-primary.is-light,html.theme--catppuccin-frappe .docstring>section>a.button.is-light.docs-sourcelink{background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .button.is-primary.is-light:hover,html.theme--catppuccin-frappe .docstring>section>a.button.is-light.docs-sourcelink:hover,html.theme--catppuccin-frappe .button.is-primary.is-light.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#e2eafb;border-color:transparent;color:#153a8e}html.theme--catppuccin-frappe .button.is-primary.is-light:active,html.theme--catppuccin-frappe .docstring>section>a.button.is-light.docs-sourcelink:active,html.theme--catppuccin-frappe .button.is-primary.is-light.is-active,html.theme--catppuccin-frappe .docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#d7e1f9;border-color:transparent;color:#153a8e}html.theme--catppuccin-frappe .button.is-link{background-color:#8caaee;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-link:hover,html.theme--catppuccin-frappe .button.is-link.is-hovered{background-color:#81a2ec;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-link:focus,html.theme--catppuccin-frappe .button.is-link.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-link:focus:not(:active),html.theme--catppuccin-frappe .button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .button.is-link:active,html.theme--catppuccin-frappe .button.is-link.is-active{background-color:#769aeb;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-link[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-link{background-color:#8caaee;border-color:#8caaee;box-shadow:none}html.theme--catppuccin-frappe .button.is-link.is-inverted{background-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .button.is-link.is-inverted:hover,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-frappe .button.is-link.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#8caaee}html.theme--catppuccin-frappe .button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-link.is-outlined{background-color:transparent;border-color:#8caaee;color:#8caaee}html.theme--catppuccin-frappe .button.is-link.is-outlined:hover,html.theme--catppuccin-frappe .button.is-link.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-link.is-outlined:focus,html.theme--catppuccin-frappe .button.is-link.is-outlined.is-focused{background-color:#8caaee;border-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #8caaee #8caaee !important}html.theme--catppuccin-frappe .button.is-link.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-link.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-link.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-link.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-link.is-outlined{background-color:transparent;border-color:#8caaee;box-shadow:none;color:#8caaee}html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #8caaee #8caaee !important}html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-link.is-light{background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .button.is-link.is-light:hover,html.theme--catppuccin-frappe .button.is-link.is-light.is-hovered{background-color:#e2eafb;border-color:transparent;color:#153a8e}html.theme--catppuccin-frappe .button.is-link.is-light:active,html.theme--catppuccin-frappe .button.is-link.is-light.is-active{background-color:#d7e1f9;border-color:transparent;color:#153a8e}html.theme--catppuccin-frappe .button.is-info{background-color:#81c8be;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info:hover,html.theme--catppuccin-frappe .button.is-info.is-hovered{background-color:#78c4b9;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info:focus,html.theme--catppuccin-frappe .button.is-info.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info:focus:not(:active),html.theme--catppuccin-frappe .button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(129,200,190,0.25)}html.theme--catppuccin-frappe .button.is-info:active,html.theme--catppuccin-frappe .button.is-info.is-active{background-color:#6fc0b5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-info{background-color:#81c8be;border-color:#81c8be;box-shadow:none}html.theme--catppuccin-frappe .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);color:#81c8be}html.theme--catppuccin-frappe .button.is-info.is-inverted:hover,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#81c8be}html.theme--catppuccin-frappe .button.is-info.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-info.is-outlined{background-color:transparent;border-color:#81c8be;color:#81c8be}html.theme--catppuccin-frappe .button.is-info.is-outlined:hover,html.theme--catppuccin-frappe .button.is-info.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-info.is-outlined:focus,html.theme--catppuccin-frappe .button.is-info.is-outlined.is-focused{background-color:#81c8be;border-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #81c8be #81c8be !important}html.theme--catppuccin-frappe .button.is-info.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-info.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-info.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-info.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-info.is-outlined{background-color:transparent;border-color:#81c8be;box-shadow:none;color:#81c8be}html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#81c8be}html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #81c8be #81c8be !important}html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-info.is-light{background-color:#f1f9f8;color:#2d675f}html.theme--catppuccin-frappe .button.is-info.is-light:hover,html.theme--catppuccin-frappe .button.is-info.is-light.is-hovered{background-color:#e8f5f3;border-color:transparent;color:#2d675f}html.theme--catppuccin-frappe .button.is-info.is-light:active,html.theme--catppuccin-frappe .button.is-info.is-light.is-active{background-color:#dff1ef;border-color:transparent;color:#2d675f}html.theme--catppuccin-frappe .button.is-success{background-color:#a6d189;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success:hover,html.theme--catppuccin-frappe .button.is-success.is-hovered{background-color:#9fcd80;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success:focus,html.theme--catppuccin-frappe .button.is-success.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success:focus:not(:active),html.theme--catppuccin-frappe .button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(166,209,137,0.25)}html.theme--catppuccin-frappe .button.is-success:active,html.theme--catppuccin-frappe .button.is-success.is-active{background-color:#98ca77;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-success{background-color:#a6d189;border-color:#a6d189;box-shadow:none}html.theme--catppuccin-frappe .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);color:#a6d189}html.theme--catppuccin-frappe .button.is-success.is-inverted:hover,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#a6d189}html.theme--catppuccin-frappe .button.is-success.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-success.is-outlined{background-color:transparent;border-color:#a6d189;color:#a6d189}html.theme--catppuccin-frappe .button.is-success.is-outlined:hover,html.theme--catppuccin-frappe .button.is-success.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-success.is-outlined:focus,html.theme--catppuccin-frappe .button.is-success.is-outlined.is-focused{background-color:#a6d189;border-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #a6d189 #a6d189 !important}html.theme--catppuccin-frappe .button.is-success.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-success.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-success.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-success.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-success.is-outlined{background-color:transparent;border-color:#a6d189;box-shadow:none;color:#a6d189}html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#a6d189}html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #a6d189 #a6d189 !important}html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-success.is-light{background-color:#f4f9f0;color:#446a29}html.theme--catppuccin-frappe .button.is-success.is-light:hover,html.theme--catppuccin-frappe .button.is-success.is-light.is-hovered{background-color:#edf6e7;border-color:transparent;color:#446a29}html.theme--catppuccin-frappe .button.is-success.is-light:active,html.theme--catppuccin-frappe .button.is-success.is-light.is-active{background-color:#e6f2de;border-color:transparent;color:#446a29}html.theme--catppuccin-frappe .button.is-warning{background-color:#e5c890;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning:hover,html.theme--catppuccin-frappe .button.is-warning.is-hovered{background-color:#e3c386;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning:focus,html.theme--catppuccin-frappe .button.is-warning.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning:focus:not(:active),html.theme--catppuccin-frappe .button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(229,200,144,0.25)}html.theme--catppuccin-frappe .button.is-warning:active,html.theme--catppuccin-frappe .button.is-warning.is-active{background-color:#e0be7b;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-warning{background-color:#e5c890;border-color:#e5c890;box-shadow:none}html.theme--catppuccin-frappe .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);color:#e5c890}html.theme--catppuccin-frappe .button.is-warning.is-inverted:hover,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#e5c890}html.theme--catppuccin-frappe .button.is-warning.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-warning.is-outlined{background-color:transparent;border-color:#e5c890;color:#e5c890}html.theme--catppuccin-frappe .button.is-warning.is-outlined:hover,html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-warning.is-outlined:focus,html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-focused{background-color:#e5c890;border-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #e5c890 #e5c890 !important}html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-frappe .button.is-warning.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-warning.is-outlined{background-color:transparent;border-color:#e5c890;box-shadow:none;color:#e5c890}html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#e5c890}html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #e5c890 #e5c890 !important}html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .button.is-warning.is-light{background-color:#fbf7ee;color:#78591c}html.theme--catppuccin-frappe .button.is-warning.is-light:hover,html.theme--catppuccin-frappe .button.is-warning.is-light.is-hovered{background-color:#f9f2e4;border-color:transparent;color:#78591c}html.theme--catppuccin-frappe .button.is-warning.is-light:active,html.theme--catppuccin-frappe .button.is-warning.is-light.is-active{background-color:#f6edda;border-color:transparent;color:#78591c}html.theme--catppuccin-frappe .button.is-danger{background-color:#e78284;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-danger:hover,html.theme--catppuccin-frappe .button.is-danger.is-hovered{background-color:#e57779;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-danger:focus,html.theme--catppuccin-frappe .button.is-danger.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-danger:focus:not(:active),html.theme--catppuccin-frappe .button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(231,130,132,0.25)}html.theme--catppuccin-frappe .button.is-danger:active,html.theme--catppuccin-frappe .button.is-danger.is-active{background-color:#e36d6f;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .button.is-danger[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-danger{background-color:#e78284;border-color:#e78284;box-shadow:none}html.theme--catppuccin-frappe .button.is-danger.is-inverted{background-color:#fff;color:#e78284}html.theme--catppuccin-frappe .button.is-danger.is-inverted:hover,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-frappe .button.is-danger.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#e78284}html.theme--catppuccin-frappe .button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-danger.is-outlined{background-color:transparent;border-color:#e78284;color:#e78284}html.theme--catppuccin-frappe .button.is-danger.is-outlined:hover,html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-danger.is-outlined:focus,html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-focused{background-color:#e78284;border-color:#e78284;color:#fff}html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #e78284 #e78284 !important}html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-frappe .button.is-danger.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-danger.is-outlined{background-color:transparent;border-color:#e78284;box-shadow:none;color:#e78284}html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined:hover,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined:focus,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#e78284}html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #e78284 #e78284 !important}html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-frappe .button.is-danger.is-light{background-color:#fceeee;color:#9a1e20}html.theme--catppuccin-frappe .button.is-danger.is-light:hover,html.theme--catppuccin-frappe .button.is-danger.is-light.is-hovered{background-color:#fae3e4;border-color:transparent;color:#9a1e20}html.theme--catppuccin-frappe .button.is-danger.is-light:active,html.theme--catppuccin-frappe .button.is-danger.is-light.is-active{background-color:#f8d8d9;border-color:transparent;color:#9a1e20}html.theme--catppuccin-frappe .button.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}html.theme--catppuccin-frappe .button.is-small:not(.is-rounded),html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:3px}html.theme--catppuccin-frappe .button.is-normal{font-size:1rem}html.theme--catppuccin-frappe .button.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .button.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .button[disabled],fieldset[disabled] html.theme--catppuccin-frappe .button{background-color:#737994;border-color:#626880;box-shadow:none;opacity:.5}html.theme--catppuccin-frappe .button.is-fullwidth{display:flex;width:100%}html.theme--catppuccin-frappe .button.is-loading{color:transparent !important;pointer-events:none}html.theme--catppuccin-frappe .button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}html.theme--catppuccin-frappe .button.is-static{background-color:#292c3c;border-color:#626880;color:#838ba7;box-shadow:none;pointer-events:none}html.theme--catppuccin-frappe .button.is-rounded,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}html.theme--catppuccin-frappe .buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-frappe .buttons .button{margin-bottom:0.5rem}html.theme--catppuccin-frappe .buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}html.theme--catppuccin-frappe .buttons:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-frappe .buttons:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-frappe .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}html.theme--catppuccin-frappe .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:3px}html.theme--catppuccin-frappe .buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}html.theme--catppuccin-frappe .buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}html.theme--catppuccin-frappe .buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-frappe .buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}html.theme--catppuccin-frappe .buttons.has-addons .button:last-child{margin-right:0}html.theme--catppuccin-frappe .buttons.has-addons .button:hover,html.theme--catppuccin-frappe .buttons.has-addons .button.is-hovered{z-index:2}html.theme--catppuccin-frappe .buttons.has-addons .button:focus,html.theme--catppuccin-frappe .buttons.has-addons .button.is-focused,html.theme--catppuccin-frappe .buttons.has-addons .button:active,html.theme--catppuccin-frappe .buttons.has-addons .button.is-active,html.theme--catppuccin-frappe .buttons.has-addons .button.is-selected{z-index:3}html.theme--catppuccin-frappe .buttons.has-addons .button:focus:hover,html.theme--catppuccin-frappe .buttons.has-addons .button.is-focused:hover,html.theme--catppuccin-frappe .buttons.has-addons .button:active:hover,html.theme--catppuccin-frappe .buttons.has-addons .button.is-active:hover,html.theme--catppuccin-frappe .buttons.has-addons .button.is-selected:hover{z-index:4}html.theme--catppuccin-frappe .buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .buttons.is-centered{justify-content:center}html.theme--catppuccin-frappe .buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}html.theme--catppuccin-frappe .buttons.is-right{justify-content:flex-end}html.theme--catppuccin-frappe .buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .button.is-responsive.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}html.theme--catppuccin-frappe .button.is-responsive,html.theme--catppuccin-frappe .button.is-responsive.is-normal{font-size:.65625rem}html.theme--catppuccin-frappe .button.is-responsive.is-medium{font-size:.75rem}html.theme--catppuccin-frappe .button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .button.is-responsive.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}html.theme--catppuccin-frappe .button.is-responsive,html.theme--catppuccin-frappe .button.is-responsive.is-normal{font-size:.75rem}html.theme--catppuccin-frappe .button.is-responsive.is-medium{font-size:1rem}html.theme--catppuccin-frappe .button.is-responsive.is-large{font-size:1.25rem}}html.theme--catppuccin-frappe .container{flex-grow:1;margin:0 auto;position:relative;width:auto}html.theme--catppuccin-frappe .container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .container{max-width:992px}}@media screen and (max-width: 1215px){html.theme--catppuccin-frappe .container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){html.theme--catppuccin-frappe .container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}html.theme--catppuccin-frappe .content li+li{margin-top:0.25em}html.theme--catppuccin-frappe .content p:not(:last-child),html.theme--catppuccin-frappe .content dl:not(:last-child),html.theme--catppuccin-frappe .content ol:not(:last-child),html.theme--catppuccin-frappe .content ul:not(:last-child),html.theme--catppuccin-frappe .content blockquote:not(:last-child),html.theme--catppuccin-frappe .content pre:not(:last-child),html.theme--catppuccin-frappe .content table:not(:last-child){margin-bottom:1em}html.theme--catppuccin-frappe .content h1,html.theme--catppuccin-frappe .content h2,html.theme--catppuccin-frappe .content h3,html.theme--catppuccin-frappe .content h4,html.theme--catppuccin-frappe .content h5,html.theme--catppuccin-frappe .content h6{color:#c6d0f5;font-weight:600;line-height:1.125}html.theme--catppuccin-frappe .content h1{font-size:2em;margin-bottom:0.5em}html.theme--catppuccin-frappe .content h1:not(:first-child){margin-top:1em}html.theme--catppuccin-frappe .content h2{font-size:1.75em;margin-bottom:0.5714em}html.theme--catppuccin-frappe .content h2:not(:first-child){margin-top:1.1428em}html.theme--catppuccin-frappe .content h3{font-size:1.5em;margin-bottom:0.6666em}html.theme--catppuccin-frappe .content h3:not(:first-child){margin-top:1.3333em}html.theme--catppuccin-frappe .content h4{font-size:1.25em;margin-bottom:0.8em}html.theme--catppuccin-frappe .content h5{font-size:1.125em;margin-bottom:0.8888em}html.theme--catppuccin-frappe .content h6{font-size:1em;margin-bottom:1em}html.theme--catppuccin-frappe .content blockquote{background-color:#292c3c;border-left:5px solid #626880;padding:1.25em 1.5em}html.theme--catppuccin-frappe .content ol{list-style-position:outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-frappe .content ol:not([type]){list-style-type:decimal}html.theme--catppuccin-frappe .content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}html.theme--catppuccin-frappe .content ol.is-lower-roman:not([type]){list-style-type:lower-roman}html.theme--catppuccin-frappe .content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}html.theme--catppuccin-frappe .content ol.is-upper-roman:not([type]){list-style-type:upper-roman}html.theme--catppuccin-frappe .content ul{list-style:disc outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-frappe .content ul ul{list-style-type:circle;margin-top:0.5em}html.theme--catppuccin-frappe .content ul ul ul{list-style-type:square}html.theme--catppuccin-frappe .content dd{margin-left:2em}html.theme--catppuccin-frappe .content figure{margin-left:2em;margin-right:2em;text-align:center}html.theme--catppuccin-frappe .content figure:not(:first-child){margin-top:2em}html.theme--catppuccin-frappe .content figure:not(:last-child){margin-bottom:2em}html.theme--catppuccin-frappe .content figure img{display:inline-block}html.theme--catppuccin-frappe .content figure figcaption{font-style:italic}html.theme--catppuccin-frappe .content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}html.theme--catppuccin-frappe .content sup,html.theme--catppuccin-frappe .content sub{font-size:75%}html.theme--catppuccin-frappe .content table{width:100%}html.theme--catppuccin-frappe .content table td,html.theme--catppuccin-frappe .content table th{border:1px solid #626880;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-frappe .content table th{color:#b0bef1}html.theme--catppuccin-frappe .content table th:not([align]){text-align:inherit}html.theme--catppuccin-frappe .content table thead td,html.theme--catppuccin-frappe .content table thead th{border-width:0 0 2px;color:#b0bef1}html.theme--catppuccin-frappe .content table tfoot td,html.theme--catppuccin-frappe .content table tfoot th{border-width:2px 0 0;color:#b0bef1}html.theme--catppuccin-frappe .content table tbody tr:last-child td,html.theme--catppuccin-frappe .content table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-frappe .content .tabs li+li{margin-top:0}html.theme--catppuccin-frappe .content.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}html.theme--catppuccin-frappe .content.is-normal{font-size:1rem}html.theme--catppuccin-frappe .content.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .content.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}html.theme--catppuccin-frappe .icon.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}html.theme--catppuccin-frappe .icon.is-medium{height:2rem;width:2rem}html.theme--catppuccin-frappe .icon.is-large{height:3rem;width:3rem}html.theme--catppuccin-frappe .icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}html.theme--catppuccin-frappe .icon-text .icon{flex-grow:0;flex-shrink:0}html.theme--catppuccin-frappe .icon-text .icon:not(:last-child){margin-right:.25em}html.theme--catppuccin-frappe .icon-text .icon:not(:first-child){margin-left:.25em}html.theme--catppuccin-frappe div.icon-text{display:flex}html.theme--catppuccin-frappe .image,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img{display:block;position:relative}html.theme--catppuccin-frappe .image img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}html.theme--catppuccin-frappe .image img.is-rounded,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}html.theme--catppuccin-frappe .image.is-fullwidth,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}html.theme--catppuccin-frappe .image.is-square img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-frappe .image.is-square .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-frappe .image.is-1by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-frappe .image.is-1by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-frappe .image.is-5by4 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-frappe .image.is-5by4 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-frappe .image.is-4by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-frappe .image.is-4by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-frappe .image.is-3by2 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-frappe .image.is-3by2 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-frappe .image.is-5by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-frappe .image.is-5by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-frappe .image.is-16by9 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-frappe .image.is-16by9 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-frappe .image.is-2by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-frappe .image.is-2by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-frappe .image.is-3by1 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-frappe .image.is-3by1 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-frappe .image.is-4by5 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-frappe .image.is-4by5 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-frappe .image.is-3by4 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-frappe .image.is-3by4 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-frappe .image.is-2by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-frappe .image.is-2by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-frappe .image.is-3by5 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-frappe .image.is-3by5 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-frappe .image.is-9by16 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-frappe .image.is-9by16 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-frappe .image.is-1by2 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-frappe .image.is-1by2 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-frappe .image.is-1by3 img,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-frappe .image.is-1by3 .has-ratio,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}html.theme--catppuccin-frappe .image.is-square,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-square,html.theme--catppuccin-frappe .image.is-1by1,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}html.theme--catppuccin-frappe .image.is-5by4,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}html.theme--catppuccin-frappe .image.is-4by3,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}html.theme--catppuccin-frappe .image.is-3by2,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}html.theme--catppuccin-frappe .image.is-5by3,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}html.theme--catppuccin-frappe .image.is-16by9,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}html.theme--catppuccin-frappe .image.is-2by1,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}html.theme--catppuccin-frappe .image.is-3by1,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}html.theme--catppuccin-frappe .image.is-4by5,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}html.theme--catppuccin-frappe .image.is-3by4,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}html.theme--catppuccin-frappe .image.is-2by3,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}html.theme--catppuccin-frappe .image.is-3by5,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}html.theme--catppuccin-frappe .image.is-9by16,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}html.theme--catppuccin-frappe .image.is-1by2,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}html.theme--catppuccin-frappe .image.is-1by3,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}html.theme--catppuccin-frappe .image.is-16x16,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}html.theme--catppuccin-frappe .image.is-24x24,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}html.theme--catppuccin-frappe .image.is-32x32,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}html.theme--catppuccin-frappe .image.is-48x48,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}html.theme--catppuccin-frappe .image.is-64x64,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}html.theme--catppuccin-frappe .image.is-96x96,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}html.theme--catppuccin-frappe .image.is-128x128,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}html.theme--catppuccin-frappe .notification{background-color:#292c3c;border-radius:.4em;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}html.theme--catppuccin-frappe .notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-frappe .notification strong{color:currentColor}html.theme--catppuccin-frappe .notification code,html.theme--catppuccin-frappe .notification pre{background:#fff}html.theme--catppuccin-frappe .notification pre code{background:transparent}html.theme--catppuccin-frappe .notification>.delete{right:.5rem;position:absolute;top:0.5rem}html.theme--catppuccin-frappe .notification .title,html.theme--catppuccin-frappe .notification .subtitle,html.theme--catppuccin-frappe .notification .content{color:currentColor}html.theme--catppuccin-frappe .notification.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .notification.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .notification.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .notification.is-dark,html.theme--catppuccin-frappe .content kbd.notification{background-color:#414559;color:#fff}html.theme--catppuccin-frappe .notification.is-primary,html.theme--catppuccin-frappe .docstring>section>a.notification.docs-sourcelink{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .notification.is-primary.is-light,html.theme--catppuccin-frappe .docstring>section>a.notification.is-light.docs-sourcelink{background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .notification.is-link{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .notification.is-link.is-light{background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .notification.is-info{background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .notification.is-info.is-light{background-color:#f1f9f8;color:#2d675f}html.theme--catppuccin-frappe .notification.is-success{background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .notification.is-success.is-light{background-color:#f4f9f0;color:#446a29}html.theme--catppuccin-frappe .notification.is-warning{background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .notification.is-warning.is-light{background-color:#fbf7ee;color:#78591c}html.theme--catppuccin-frappe .notification.is-danger{background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .notification.is-danger.is-light{background-color:#fceeee;color:#9a1e20}html.theme--catppuccin-frappe .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}html.theme--catppuccin-frappe .progress::-webkit-progress-bar{background-color:#51576d}html.theme--catppuccin-frappe .progress::-webkit-progress-value{background-color:#838ba7}html.theme--catppuccin-frappe .progress::-moz-progress-bar{background-color:#838ba7}html.theme--catppuccin-frappe .progress::-ms-fill{background-color:#838ba7;border:none}html.theme--catppuccin-frappe .progress.is-white::-webkit-progress-value{background-color:#fff}html.theme--catppuccin-frappe .progress.is-white::-moz-progress-bar{background-color:#fff}html.theme--catppuccin-frappe .progress.is-white::-ms-fill{background-color:#fff}html.theme--catppuccin-frappe .progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-black::-webkit-progress-value{background-color:#0a0a0a}html.theme--catppuccin-frappe .progress.is-black::-moz-progress-bar{background-color:#0a0a0a}html.theme--catppuccin-frappe .progress.is-black::-ms-fill{background-color:#0a0a0a}html.theme--catppuccin-frappe .progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-light::-webkit-progress-value{background-color:#f5f5f5}html.theme--catppuccin-frappe .progress.is-light::-moz-progress-bar{background-color:#f5f5f5}html.theme--catppuccin-frappe .progress.is-light::-ms-fill{background-color:#f5f5f5}html.theme--catppuccin-frappe .progress.is-light:indeterminate{background-image:linear-gradient(to right, #f5f5f5 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-dark::-webkit-progress-value,html.theme--catppuccin-frappe .content kbd.progress::-webkit-progress-value{background-color:#414559}html.theme--catppuccin-frappe .progress.is-dark::-moz-progress-bar,html.theme--catppuccin-frappe .content kbd.progress::-moz-progress-bar{background-color:#414559}html.theme--catppuccin-frappe .progress.is-dark::-ms-fill,html.theme--catppuccin-frappe .content kbd.progress::-ms-fill{background-color:#414559}html.theme--catppuccin-frappe .progress.is-dark:indeterminate,html.theme--catppuccin-frappe .content kbd.progress:indeterminate{background-image:linear-gradient(to right, #414559 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-primary::-webkit-progress-value,html.theme--catppuccin-frappe .docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-primary::-moz-progress-bar,html.theme--catppuccin-frappe .docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-primary::-ms-fill,html.theme--catppuccin-frappe .docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-primary:indeterminate,html.theme--catppuccin-frappe .docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #8caaee 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-link::-webkit-progress-value{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-link::-moz-progress-bar{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-link::-ms-fill{background-color:#8caaee}html.theme--catppuccin-frappe .progress.is-link:indeterminate{background-image:linear-gradient(to right, #8caaee 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-info::-webkit-progress-value{background-color:#81c8be}html.theme--catppuccin-frappe .progress.is-info::-moz-progress-bar{background-color:#81c8be}html.theme--catppuccin-frappe .progress.is-info::-ms-fill{background-color:#81c8be}html.theme--catppuccin-frappe .progress.is-info:indeterminate{background-image:linear-gradient(to right, #81c8be 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-success::-webkit-progress-value{background-color:#a6d189}html.theme--catppuccin-frappe .progress.is-success::-moz-progress-bar{background-color:#a6d189}html.theme--catppuccin-frappe .progress.is-success::-ms-fill{background-color:#a6d189}html.theme--catppuccin-frappe .progress.is-success:indeterminate{background-image:linear-gradient(to right, #a6d189 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-warning::-webkit-progress-value{background-color:#e5c890}html.theme--catppuccin-frappe .progress.is-warning::-moz-progress-bar{background-color:#e5c890}html.theme--catppuccin-frappe .progress.is-warning::-ms-fill{background-color:#e5c890}html.theme--catppuccin-frappe .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #e5c890 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress.is-danger::-webkit-progress-value{background-color:#e78284}html.theme--catppuccin-frappe .progress.is-danger::-moz-progress-bar{background-color:#e78284}html.theme--catppuccin-frappe .progress.is-danger::-ms-fill{background-color:#e78284}html.theme--catppuccin-frappe .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #e78284 30%, #51576d 30%)}html.theme--catppuccin-frappe .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#51576d;background-image:linear-gradient(to right, #c6d0f5 30%, #51576d 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}html.theme--catppuccin-frappe .progress:indeterminate::-webkit-progress-bar{background-color:transparent}html.theme--catppuccin-frappe .progress:indeterminate::-moz-progress-bar{background-color:transparent}html.theme--catppuccin-frappe .progress:indeterminate::-ms-fill{animation-name:none}html.theme--catppuccin-frappe .progress.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}html.theme--catppuccin-frappe .progress.is-medium{height:1.25rem}html.theme--catppuccin-frappe .progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}html.theme--catppuccin-frappe .table{background-color:#51576d;color:#c6d0f5}html.theme--catppuccin-frappe .table td,html.theme--catppuccin-frappe .table th{border:1px solid #626880;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-frappe .table td.is-white,html.theme--catppuccin-frappe .table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .table td.is-black,html.theme--catppuccin-frappe .table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .table td.is-light,html.theme--catppuccin-frappe .table th.is-light{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .table td.is-dark,html.theme--catppuccin-frappe .table th.is-dark{background-color:#414559;border-color:#414559;color:#fff}html.theme--catppuccin-frappe .table td.is-primary,html.theme--catppuccin-frappe .table th.is-primary{background-color:#8caaee;border-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .table td.is-link,html.theme--catppuccin-frappe .table th.is-link{background-color:#8caaee;border-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .table td.is-info,html.theme--catppuccin-frappe .table th.is-info{background-color:#81c8be;border-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .table td.is-success,html.theme--catppuccin-frappe .table th.is-success{background-color:#a6d189;border-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .table td.is-warning,html.theme--catppuccin-frappe .table th.is-warning{background-color:#e5c890;border-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .table td.is-danger,html.theme--catppuccin-frappe .table th.is-danger{background-color:#e78284;border-color:#e78284;color:#fff}html.theme--catppuccin-frappe .table td.is-narrow,html.theme--catppuccin-frappe .table th.is-narrow{white-space:nowrap;width:1%}html.theme--catppuccin-frappe .table td.is-selected,html.theme--catppuccin-frappe .table th.is-selected{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .table td.is-selected a,html.theme--catppuccin-frappe .table td.is-selected strong,html.theme--catppuccin-frappe .table th.is-selected a,html.theme--catppuccin-frappe .table th.is-selected strong{color:currentColor}html.theme--catppuccin-frappe .table td.is-vcentered,html.theme--catppuccin-frappe .table th.is-vcentered{vertical-align:middle}html.theme--catppuccin-frappe .table th{color:#b0bef1}html.theme--catppuccin-frappe .table th:not([align]){text-align:left}html.theme--catppuccin-frappe .table tr.is-selected{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .table tr.is-selected a,html.theme--catppuccin-frappe .table tr.is-selected strong{color:currentColor}html.theme--catppuccin-frappe .table tr.is-selected td,html.theme--catppuccin-frappe .table tr.is-selected th{border-color:#fff;color:currentColor}html.theme--catppuccin-frappe .table thead{background-color:rgba(0,0,0,0)}html.theme--catppuccin-frappe .table thead td,html.theme--catppuccin-frappe .table thead th{border-width:0 0 2px;color:#b0bef1}html.theme--catppuccin-frappe .table tfoot{background-color:rgba(0,0,0,0)}html.theme--catppuccin-frappe .table tfoot td,html.theme--catppuccin-frappe .table tfoot th{border-width:2px 0 0;color:#b0bef1}html.theme--catppuccin-frappe .table tbody{background-color:rgba(0,0,0,0)}html.theme--catppuccin-frappe .table tbody tr:last-child td,html.theme--catppuccin-frappe .table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-frappe .table.is-bordered td,html.theme--catppuccin-frappe .table.is-bordered th{border-width:1px}html.theme--catppuccin-frappe .table.is-bordered tr:last-child td,html.theme--catppuccin-frappe .table.is-bordered tr:last-child th{border-bottom-width:1px}html.theme--catppuccin-frappe .table.is-fullwidth{width:100%}html.theme--catppuccin-frappe .table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#414559}html.theme--catppuccin-frappe .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#414559}html.theme--catppuccin-frappe .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#454a5f}html.theme--catppuccin-frappe .table.is-narrow td,html.theme--catppuccin-frappe .table.is-narrow th{padding:0.25em 0.5em}html.theme--catppuccin-frappe .table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#414559}html.theme--catppuccin-frappe .table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}html.theme--catppuccin-frappe .tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-frappe .tags .tag,html.theme--catppuccin-frappe .tags .content kbd,html.theme--catppuccin-frappe .content .tags kbd,html.theme--catppuccin-frappe .tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}html.theme--catppuccin-frappe .tags .tag:not(:last-child),html.theme--catppuccin-frappe .tags .content kbd:not(:last-child),html.theme--catppuccin-frappe .content .tags kbd:not(:last-child),html.theme--catppuccin-frappe .tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}html.theme--catppuccin-frappe .tags:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-frappe .tags:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-frappe .tags.are-medium .tag:not(.is-normal):not(.is-large),html.theme--catppuccin-frappe .tags.are-medium .content kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-frappe .content .tags.are-medium kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-frappe .tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}html.theme--catppuccin-frappe .tags.are-large .tag:not(.is-normal):not(.is-medium),html.theme--catppuccin-frappe .tags.are-large .content kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-frappe .content .tags.are-large kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-frappe .tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}html.theme--catppuccin-frappe .tags.is-centered{justify-content:center}html.theme--catppuccin-frappe .tags.is-centered .tag,html.theme--catppuccin-frappe .tags.is-centered .content kbd,html.theme--catppuccin-frappe .content .tags.is-centered kbd,html.theme--catppuccin-frappe .tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}html.theme--catppuccin-frappe .tags.is-right{justify-content:flex-end}html.theme--catppuccin-frappe .tags.is-right .tag:not(:first-child),html.theme--catppuccin-frappe .tags.is-right .content kbd:not(:first-child),html.theme--catppuccin-frappe .content .tags.is-right kbd:not(:first-child),html.theme--catppuccin-frappe .tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}html.theme--catppuccin-frappe .tags.is-right .tag:not(:last-child),html.theme--catppuccin-frappe .tags.is-right .content kbd:not(:last-child),html.theme--catppuccin-frappe .content .tags.is-right kbd:not(:last-child),html.theme--catppuccin-frappe .tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}html.theme--catppuccin-frappe .tags.has-addons .tag,html.theme--catppuccin-frappe .tags.has-addons .content kbd,html.theme--catppuccin-frappe .content .tags.has-addons kbd,html.theme--catppuccin-frappe .tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}html.theme--catppuccin-frappe .tags.has-addons .tag:not(:first-child),html.theme--catppuccin-frappe .tags.has-addons .content kbd:not(:first-child),html.theme--catppuccin-frappe .content .tags.has-addons kbd:not(:first-child),html.theme--catppuccin-frappe .tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}html.theme--catppuccin-frappe .tags.has-addons .tag:not(:last-child),html.theme--catppuccin-frappe .tags.has-addons .content kbd:not(:last-child),html.theme--catppuccin-frappe .content .tags.has-addons kbd:not(:last-child),html.theme--catppuccin-frappe .tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}html.theme--catppuccin-frappe .tag:not(body),html.theme--catppuccin-frappe .content kbd:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#292c3c;border-radius:.4em;color:#c6d0f5;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}html.theme--catppuccin-frappe .tag:not(body) .delete,html.theme--catppuccin-frappe .content kbd:not(body) .delete,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}html.theme--catppuccin-frappe .tag.is-white:not(body),html.theme--catppuccin-frappe .content kbd.is-white:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .tag.is-black:not(body),html.theme--catppuccin-frappe .content kbd.is-black:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .tag.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .tag.is-dark:not(body),html.theme--catppuccin-frappe .content kbd:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-dark:not(body),html.theme--catppuccin-frappe .content .docstring>section>kbd:not(body){background-color:#414559;color:#fff}html.theme--catppuccin-frappe .tag.is-primary:not(body),html.theme--catppuccin-frappe .content kbd.is-primary:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body){background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .tag.is-primary.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-primary.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .tag.is-link:not(body),html.theme--catppuccin-frappe .content kbd.is-link:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .tag.is-link.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-link.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#edf2fc;color:#153a8e}html.theme--catppuccin-frappe .tag.is-info:not(body),html.theme--catppuccin-frappe .content kbd.is-info:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .tag.is-info.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-info.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#f1f9f8;color:#2d675f}html.theme--catppuccin-frappe .tag.is-success:not(body),html.theme--catppuccin-frappe .content kbd.is-success:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .tag.is-success.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-success.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#f4f9f0;color:#446a29}html.theme--catppuccin-frappe .tag.is-warning:not(body),html.theme--catppuccin-frappe .content kbd.is-warning:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .tag.is-warning.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-warning.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fbf7ee;color:#78591c}html.theme--catppuccin-frappe .tag.is-danger:not(body),html.theme--catppuccin-frappe .content kbd.is-danger:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .tag.is-danger.is-light:not(body),html.theme--catppuccin-frappe .content kbd.is-danger.is-light:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#fceeee;color:#9a1e20}html.theme--catppuccin-frappe .tag.is-normal:not(body),html.theme--catppuccin-frappe .content kbd.is-normal:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}html.theme--catppuccin-frappe .tag.is-medium:not(body),html.theme--catppuccin-frappe .content kbd.is-medium:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}html.theme--catppuccin-frappe .tag.is-large:not(body),html.theme--catppuccin-frappe .content kbd.is-large:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}html.theme--catppuccin-frappe .tag:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-frappe .content kbd:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}html.theme--catppuccin-frappe .tag:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-frappe .content kbd:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}html.theme--catppuccin-frappe .tag:not(body) .icon:first-child:last-child,html.theme--catppuccin-frappe .content kbd:not(body) .icon:first-child:last-child,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}html.theme--catppuccin-frappe .tag.is-delete:not(body),html.theme--catppuccin-frappe .content kbd.is-delete:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}html.theme--catppuccin-frappe .tag.is-delete:not(body)::before,html.theme--catppuccin-frappe .content kbd.is-delete:not(body)::before,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body)::before,html.theme--catppuccin-frappe .tag.is-delete:not(body)::after,html.theme--catppuccin-frappe .content kbd.is-delete:not(body)::after,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-frappe .tag.is-delete:not(body)::before,html.theme--catppuccin-frappe .content kbd.is-delete:not(body)::before,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}html.theme--catppuccin-frappe .tag.is-delete:not(body)::after,html.theme--catppuccin-frappe .content kbd.is-delete:not(body)::after,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}html.theme--catppuccin-frappe .tag.is-delete:not(body):hover,html.theme--catppuccin-frappe .content kbd.is-delete:not(body):hover,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body):hover,html.theme--catppuccin-frappe .tag.is-delete:not(body):focus,html.theme--catppuccin-frappe .content kbd.is-delete:not(body):focus,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#1f212d}html.theme--catppuccin-frappe .tag.is-delete:not(body):active,html.theme--catppuccin-frappe .content kbd.is-delete:not(body):active,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#14161e}html.theme--catppuccin-frappe .tag.is-rounded:not(body),html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:not(body),html.theme--catppuccin-frappe .content kbd.is-rounded:not(body),html.theme--catppuccin-frappe #documenter .docs-sidebar .content form.docs-search>input:not(body),html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}html.theme--catppuccin-frappe a.tag:hover,html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:hover{text-decoration:underline}html.theme--catppuccin-frappe .title,html.theme--catppuccin-frappe .subtitle{word-break:break-word}html.theme--catppuccin-frappe .title em,html.theme--catppuccin-frappe .title span,html.theme--catppuccin-frappe .subtitle em,html.theme--catppuccin-frappe .subtitle span{font-weight:inherit}html.theme--catppuccin-frappe .title sub,html.theme--catppuccin-frappe .subtitle sub{font-size:.75em}html.theme--catppuccin-frappe .title sup,html.theme--catppuccin-frappe .subtitle sup{font-size:.75em}html.theme--catppuccin-frappe .title .tag,html.theme--catppuccin-frappe .title .content kbd,html.theme--catppuccin-frappe .content .title kbd,html.theme--catppuccin-frappe .title .docstring>section>a.docs-sourcelink,html.theme--catppuccin-frappe .subtitle .tag,html.theme--catppuccin-frappe .subtitle .content kbd,html.theme--catppuccin-frappe .content .subtitle kbd,html.theme--catppuccin-frappe .subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}html.theme--catppuccin-frappe .title{color:#fff;font-size:2rem;font-weight:500;line-height:1.125}html.theme--catppuccin-frappe .title strong{color:inherit;font-weight:inherit}html.theme--catppuccin-frappe .title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}html.theme--catppuccin-frappe .title.is-1{font-size:3rem}html.theme--catppuccin-frappe .title.is-2{font-size:2.5rem}html.theme--catppuccin-frappe .title.is-3{font-size:2rem}html.theme--catppuccin-frappe .title.is-4{font-size:1.5rem}html.theme--catppuccin-frappe .title.is-5{font-size:1.25rem}html.theme--catppuccin-frappe .title.is-6{font-size:1rem}html.theme--catppuccin-frappe .title.is-7{font-size:.75rem}html.theme--catppuccin-frappe .subtitle{color:#737994;font-size:1.25rem;font-weight:400;line-height:1.25}html.theme--catppuccin-frappe .subtitle strong{color:#737994;font-weight:600}html.theme--catppuccin-frappe .subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}html.theme--catppuccin-frappe .subtitle.is-1{font-size:3rem}html.theme--catppuccin-frappe .subtitle.is-2{font-size:2.5rem}html.theme--catppuccin-frappe .subtitle.is-3{font-size:2rem}html.theme--catppuccin-frappe .subtitle.is-4{font-size:1.5rem}html.theme--catppuccin-frappe .subtitle.is-5{font-size:1.25rem}html.theme--catppuccin-frappe .subtitle.is-6{font-size:1rem}html.theme--catppuccin-frappe .subtitle.is-7{font-size:.75rem}html.theme--catppuccin-frappe .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--catppuccin-frappe .number{align-items:center;background-color:#292c3c;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}html.theme--catppuccin-frappe .select select,html.theme--catppuccin-frappe .textarea,html.theme--catppuccin-frappe .input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{background-color:#303446;border-color:#626880;border-radius:.4em;color:#838ba7}html.theme--catppuccin-frappe .select select::-moz-placeholder,html.theme--catppuccin-frappe .textarea::-moz-placeholder,html.theme--catppuccin-frappe .input::-moz-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#868c98}html.theme--catppuccin-frappe .select select::-webkit-input-placeholder,html.theme--catppuccin-frappe .textarea::-webkit-input-placeholder,html.theme--catppuccin-frappe .input::-webkit-input-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#868c98}html.theme--catppuccin-frappe .select select:-moz-placeholder,html.theme--catppuccin-frappe .textarea:-moz-placeholder,html.theme--catppuccin-frappe .input:-moz-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#868c98}html.theme--catppuccin-frappe .select select:-ms-input-placeholder,html.theme--catppuccin-frappe .textarea:-ms-input-placeholder,html.theme--catppuccin-frappe .input:-ms-input-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#868c98}html.theme--catppuccin-frappe .select select:hover,html.theme--catppuccin-frappe .textarea:hover,html.theme--catppuccin-frappe .input:hover,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:hover,html.theme--catppuccin-frappe .select select.is-hovered,html.theme--catppuccin-frappe .is-hovered.textarea,html.theme--catppuccin-frappe .is-hovered.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#737994}html.theme--catppuccin-frappe .select select:focus,html.theme--catppuccin-frappe .textarea:focus,html.theme--catppuccin-frappe .input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-frappe .select select.is-focused,html.theme--catppuccin-frappe .is-focused.textarea,html.theme--catppuccin-frappe .is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .select select:active,html.theme--catppuccin-frappe .textarea:active,html.theme--catppuccin-frappe .input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-frappe .select select.is-active,html.theme--catppuccin-frappe .is-active.textarea,html.theme--catppuccin-frappe .is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{border-color:#8caaee;box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .select select[disabled],html.theme--catppuccin-frappe .textarea[disabled],html.theme--catppuccin-frappe .input[disabled],html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] html.theme--catppuccin-frappe .select select,fieldset[disabled] html.theme--catppuccin-frappe .textarea,fieldset[disabled] html.theme--catppuccin-frappe .input,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{background-color:#737994;border-color:#292c3c;box-shadow:none;color:#f1f4fd}html.theme--catppuccin-frappe .select select[disabled]::-moz-placeholder,html.theme--catppuccin-frappe .textarea[disabled]::-moz-placeholder,html.theme--catppuccin-frappe .input[disabled]::-moz-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .select select::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .textarea::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .input::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(241,244,253,0.3)}html.theme--catppuccin-frappe .select select[disabled]::-webkit-input-placeholder,html.theme--catppuccin-frappe .textarea[disabled]::-webkit-input-placeholder,html.theme--catppuccin-frappe .input[disabled]::-webkit-input-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .select select::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .textarea::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .input::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(241,244,253,0.3)}html.theme--catppuccin-frappe .select select[disabled]:-moz-placeholder,html.theme--catppuccin-frappe .textarea[disabled]:-moz-placeholder,html.theme--catppuccin-frappe .input[disabled]:-moz-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .select select:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .textarea:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .input:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(241,244,253,0.3)}html.theme--catppuccin-frappe .select select[disabled]:-ms-input-placeholder,html.theme--catppuccin-frappe .textarea[disabled]:-ms-input-placeholder,html.theme--catppuccin-frappe .input[disabled]:-ms-input-placeholder,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .select select:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .textarea:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe .input:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(241,244,253,0.3)}html.theme--catppuccin-frappe .textarea,html.theme--catppuccin-frappe .input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}html.theme--catppuccin-frappe .textarea[readonly],html.theme--catppuccin-frappe .input[readonly],html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}html.theme--catppuccin-frappe .is-white.textarea,html.theme--catppuccin-frappe .is-white.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}html.theme--catppuccin-frappe .is-white.textarea:focus,html.theme--catppuccin-frappe .is-white.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-white:focus,html.theme--catppuccin-frappe .is-white.is-focused.textarea,html.theme--catppuccin-frappe .is-white.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-white.textarea:active,html.theme--catppuccin-frappe .is-white.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-white:active,html.theme--catppuccin-frappe .is-white.is-active.textarea,html.theme--catppuccin-frappe .is-white.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-frappe .is-black.textarea,html.theme--catppuccin-frappe .is-black.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}html.theme--catppuccin-frappe .is-black.textarea:focus,html.theme--catppuccin-frappe .is-black.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-black:focus,html.theme--catppuccin-frappe .is-black.is-focused.textarea,html.theme--catppuccin-frappe .is-black.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-black.textarea:active,html.theme--catppuccin-frappe .is-black.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-black:active,html.theme--catppuccin-frappe .is-black.is-active.textarea,html.theme--catppuccin-frappe .is-black.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-frappe .is-light.textarea,html.theme--catppuccin-frappe .is-light.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-light{border-color:#f5f5f5}html.theme--catppuccin-frappe .is-light.textarea:focus,html.theme--catppuccin-frappe .is-light.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-light:focus,html.theme--catppuccin-frappe .is-light.is-focused.textarea,html.theme--catppuccin-frappe .is-light.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-light.textarea:active,html.theme--catppuccin-frappe .is-light.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-light:active,html.theme--catppuccin-frappe .is-light.is-active.textarea,html.theme--catppuccin-frappe .is-light.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-frappe .is-dark.textarea,html.theme--catppuccin-frappe .content kbd.textarea,html.theme--catppuccin-frappe .is-dark.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-dark,html.theme--catppuccin-frappe .content kbd.input{border-color:#414559}html.theme--catppuccin-frappe .is-dark.textarea:focus,html.theme--catppuccin-frappe .content kbd.textarea:focus,html.theme--catppuccin-frappe .is-dark.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-dark:focus,html.theme--catppuccin-frappe .content kbd.input:focus,html.theme--catppuccin-frappe .is-dark.is-focused.textarea,html.theme--catppuccin-frappe .content kbd.is-focused.textarea,html.theme--catppuccin-frappe .is-dark.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .content kbd.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar .content form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-dark.textarea:active,html.theme--catppuccin-frappe .content kbd.textarea:active,html.theme--catppuccin-frappe .is-dark.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-dark:active,html.theme--catppuccin-frappe .content kbd.input:active,html.theme--catppuccin-frappe .is-dark.is-active.textarea,html.theme--catppuccin-frappe .content kbd.is-active.textarea,html.theme--catppuccin-frappe .is-dark.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-frappe .content kbd.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(65,69,89,0.25)}html.theme--catppuccin-frappe .is-primary.textarea,html.theme--catppuccin-frappe .docstring>section>a.textarea.docs-sourcelink,html.theme--catppuccin-frappe .is-primary.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-primary,html.theme--catppuccin-frappe .docstring>section>a.input.docs-sourcelink{border-color:#8caaee}html.theme--catppuccin-frappe .is-primary.textarea:focus,html.theme--catppuccin-frappe .docstring>section>a.textarea.docs-sourcelink:focus,html.theme--catppuccin-frappe .is-primary.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-primary:focus,html.theme--catppuccin-frappe .docstring>section>a.input.docs-sourcelink:focus,html.theme--catppuccin-frappe .is-primary.is-focused.textarea,html.theme--catppuccin-frappe .docstring>section>a.is-focused.textarea.docs-sourcelink,html.theme--catppuccin-frappe .is-primary.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .docstring>section>a.is-focused.input.docs-sourcelink,html.theme--catppuccin-frappe .is-primary.textarea:active,html.theme--catppuccin-frappe .docstring>section>a.textarea.docs-sourcelink:active,html.theme--catppuccin-frappe .is-primary.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-primary:active,html.theme--catppuccin-frappe .docstring>section>a.input.docs-sourcelink:active,html.theme--catppuccin-frappe .is-primary.is-active.textarea,html.theme--catppuccin-frappe .docstring>section>a.is-active.textarea.docs-sourcelink,html.theme--catppuccin-frappe .is-primary.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-frappe .docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .is-link.textarea,html.theme--catppuccin-frappe .is-link.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-link{border-color:#8caaee}html.theme--catppuccin-frappe .is-link.textarea:focus,html.theme--catppuccin-frappe .is-link.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-link:focus,html.theme--catppuccin-frappe .is-link.is-focused.textarea,html.theme--catppuccin-frappe .is-link.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-link.textarea:active,html.theme--catppuccin-frappe .is-link.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-link:active,html.theme--catppuccin-frappe .is-link.is-active.textarea,html.theme--catppuccin-frappe .is-link.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .is-info.textarea,html.theme--catppuccin-frappe .is-info.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-info{border-color:#81c8be}html.theme--catppuccin-frappe .is-info.textarea:focus,html.theme--catppuccin-frappe .is-info.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-info:focus,html.theme--catppuccin-frappe .is-info.is-focused.textarea,html.theme--catppuccin-frappe .is-info.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-info.textarea:active,html.theme--catppuccin-frappe .is-info.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-info:active,html.theme--catppuccin-frappe .is-info.is-active.textarea,html.theme--catppuccin-frappe .is-info.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(129,200,190,0.25)}html.theme--catppuccin-frappe .is-success.textarea,html.theme--catppuccin-frappe .is-success.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-success{border-color:#a6d189}html.theme--catppuccin-frappe .is-success.textarea:focus,html.theme--catppuccin-frappe .is-success.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-success:focus,html.theme--catppuccin-frappe .is-success.is-focused.textarea,html.theme--catppuccin-frappe .is-success.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-success.textarea:active,html.theme--catppuccin-frappe .is-success.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-success:active,html.theme--catppuccin-frappe .is-success.is-active.textarea,html.theme--catppuccin-frappe .is-success.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(166,209,137,0.25)}html.theme--catppuccin-frappe .is-warning.textarea,html.theme--catppuccin-frappe .is-warning.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#e5c890}html.theme--catppuccin-frappe .is-warning.textarea:focus,html.theme--catppuccin-frappe .is-warning.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-warning:focus,html.theme--catppuccin-frappe .is-warning.is-focused.textarea,html.theme--catppuccin-frappe .is-warning.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-warning.textarea:active,html.theme--catppuccin-frappe .is-warning.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-warning:active,html.theme--catppuccin-frappe .is-warning.is-active.textarea,html.theme--catppuccin-frappe .is-warning.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(229,200,144,0.25)}html.theme--catppuccin-frappe .is-danger.textarea,html.theme--catppuccin-frappe .is-danger.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#e78284}html.theme--catppuccin-frappe .is-danger.textarea:focus,html.theme--catppuccin-frappe .is-danger.input:focus,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-danger:focus,html.theme--catppuccin-frappe .is-danger.is-focused.textarea,html.theme--catppuccin-frappe .is-danger.is-focused.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-frappe .is-danger.textarea:active,html.theme--catppuccin-frappe .is-danger.input:active,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-danger:active,html.theme--catppuccin-frappe .is-danger.is-active.textarea,html.theme--catppuccin-frappe .is-danger.is-active.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(231,130,132,0.25)}html.theme--catppuccin-frappe .is-small.textarea,html.theme--catppuccin-frappe .is-small.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{border-radius:3px;font-size:.75rem}html.theme--catppuccin-frappe .is-medium.textarea,html.theme--catppuccin-frappe .is-medium.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .is-large.textarea,html.theme--catppuccin-frappe .is-large.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .is-fullwidth.textarea,html.theme--catppuccin-frappe .is-fullwidth.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}html.theme--catppuccin-frappe .is-inline.textarea,html.theme--catppuccin-frappe .is-inline.input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}html.theme--catppuccin-frappe .input.is-rounded,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}html.theme--catppuccin-frappe .input.is-static,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}html.theme--catppuccin-frappe .textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}html.theme--catppuccin-frappe .textarea:not([rows]){max-height:40em;min-height:8em}html.theme--catppuccin-frappe .textarea[rows]{height:initial}html.theme--catppuccin-frappe .textarea.has-fixed-size{resize:none}html.theme--catppuccin-frappe .radio,html.theme--catppuccin-frappe .checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}html.theme--catppuccin-frappe .radio input,html.theme--catppuccin-frappe .checkbox input{cursor:pointer}html.theme--catppuccin-frappe .radio:hover,html.theme--catppuccin-frappe .checkbox:hover{color:#99d1db}html.theme--catppuccin-frappe .radio[disabled],html.theme--catppuccin-frappe .checkbox[disabled],fieldset[disabled] html.theme--catppuccin-frappe .radio,fieldset[disabled] html.theme--catppuccin-frappe .checkbox,html.theme--catppuccin-frappe .radio input[disabled],html.theme--catppuccin-frappe .checkbox input[disabled]{color:#f1f4fd;cursor:not-allowed}html.theme--catppuccin-frappe .radio+.radio{margin-left:.5em}html.theme--catppuccin-frappe .select{display:inline-block;max-width:100%;position:relative;vertical-align:top}html.theme--catppuccin-frappe .select:not(.is-multiple){height:2.5em}html.theme--catppuccin-frappe .select:not(.is-multiple):not(.is-loading)::after{border-color:#8caaee;right:1.125em;z-index:4}html.theme--catppuccin-frappe .select.is-rounded select,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}html.theme--catppuccin-frappe .select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}html.theme--catppuccin-frappe .select select::-ms-expand{display:none}html.theme--catppuccin-frappe .select select[disabled]:hover,fieldset[disabled] html.theme--catppuccin-frappe .select select:hover{border-color:#292c3c}html.theme--catppuccin-frappe .select select:not([multiple]){padding-right:2.5em}html.theme--catppuccin-frappe .select select[multiple]{height:auto;padding:0}html.theme--catppuccin-frappe .select select[multiple] option{padding:0.5em 1em}html.theme--catppuccin-frappe .select:not(.is-multiple):not(.is-loading):hover::after{border-color:#99d1db}html.theme--catppuccin-frappe .select.is-white:not(:hover)::after{border-color:#fff}html.theme--catppuccin-frappe .select.is-white select{border-color:#fff}html.theme--catppuccin-frappe .select.is-white select:hover,html.theme--catppuccin-frappe .select.is-white select.is-hovered{border-color:#f2f2f2}html.theme--catppuccin-frappe .select.is-white select:focus,html.theme--catppuccin-frappe .select.is-white select.is-focused,html.theme--catppuccin-frappe .select.is-white select:active,html.theme--catppuccin-frappe .select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-frappe .select.is-black:not(:hover)::after{border-color:#0a0a0a}html.theme--catppuccin-frappe .select.is-black select{border-color:#0a0a0a}html.theme--catppuccin-frappe .select.is-black select:hover,html.theme--catppuccin-frappe .select.is-black select.is-hovered{border-color:#000}html.theme--catppuccin-frappe .select.is-black select:focus,html.theme--catppuccin-frappe .select.is-black select.is-focused,html.theme--catppuccin-frappe .select.is-black select:active,html.theme--catppuccin-frappe .select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-frappe .select.is-light:not(:hover)::after{border-color:#f5f5f5}html.theme--catppuccin-frappe .select.is-light select{border-color:#f5f5f5}html.theme--catppuccin-frappe .select.is-light select:hover,html.theme--catppuccin-frappe .select.is-light select.is-hovered{border-color:#e8e8e8}html.theme--catppuccin-frappe .select.is-light select:focus,html.theme--catppuccin-frappe .select.is-light select.is-focused,html.theme--catppuccin-frappe .select.is-light select:active,html.theme--catppuccin-frappe .select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-frappe .select.is-dark:not(:hover)::after,html.theme--catppuccin-frappe .content kbd.select:not(:hover)::after{border-color:#414559}html.theme--catppuccin-frappe .select.is-dark select,html.theme--catppuccin-frappe .content kbd.select select{border-color:#414559}html.theme--catppuccin-frappe .select.is-dark select:hover,html.theme--catppuccin-frappe .content kbd.select select:hover,html.theme--catppuccin-frappe .select.is-dark select.is-hovered,html.theme--catppuccin-frappe .content kbd.select select.is-hovered{border-color:#363a4a}html.theme--catppuccin-frappe .select.is-dark select:focus,html.theme--catppuccin-frappe .content kbd.select select:focus,html.theme--catppuccin-frappe .select.is-dark select.is-focused,html.theme--catppuccin-frappe .content kbd.select select.is-focused,html.theme--catppuccin-frappe .select.is-dark select:active,html.theme--catppuccin-frappe .content kbd.select select:active,html.theme--catppuccin-frappe .select.is-dark select.is-active,html.theme--catppuccin-frappe .content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(65,69,89,0.25)}html.theme--catppuccin-frappe .select.is-primary:not(:hover)::after,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#8caaee}html.theme--catppuccin-frappe .select.is-primary select,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select{border-color:#8caaee}html.theme--catppuccin-frappe .select.is-primary select:hover,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select:hover,html.theme--catppuccin-frappe .select.is-primary select.is-hovered,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#769aeb}html.theme--catppuccin-frappe .select.is-primary select:focus,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select:focus,html.theme--catppuccin-frappe .select.is-primary select.is-focused,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select.is-focused,html.theme--catppuccin-frappe .select.is-primary select:active,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select:active,html.theme--catppuccin-frappe .select.is-primary select.is-active,html.theme--catppuccin-frappe .docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .select.is-link:not(:hover)::after{border-color:#8caaee}html.theme--catppuccin-frappe .select.is-link select{border-color:#8caaee}html.theme--catppuccin-frappe .select.is-link select:hover,html.theme--catppuccin-frappe .select.is-link select.is-hovered{border-color:#769aeb}html.theme--catppuccin-frappe .select.is-link select:focus,html.theme--catppuccin-frappe .select.is-link select.is-focused,html.theme--catppuccin-frappe .select.is-link select:active,html.theme--catppuccin-frappe .select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(140,170,238,0.25)}html.theme--catppuccin-frappe .select.is-info:not(:hover)::after{border-color:#81c8be}html.theme--catppuccin-frappe .select.is-info select{border-color:#81c8be}html.theme--catppuccin-frappe .select.is-info select:hover,html.theme--catppuccin-frappe .select.is-info select.is-hovered{border-color:#6fc0b5}html.theme--catppuccin-frappe .select.is-info select:focus,html.theme--catppuccin-frappe .select.is-info select.is-focused,html.theme--catppuccin-frappe .select.is-info select:active,html.theme--catppuccin-frappe .select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(129,200,190,0.25)}html.theme--catppuccin-frappe .select.is-success:not(:hover)::after{border-color:#a6d189}html.theme--catppuccin-frappe .select.is-success select{border-color:#a6d189}html.theme--catppuccin-frappe .select.is-success select:hover,html.theme--catppuccin-frappe .select.is-success select.is-hovered{border-color:#98ca77}html.theme--catppuccin-frappe .select.is-success select:focus,html.theme--catppuccin-frappe .select.is-success select.is-focused,html.theme--catppuccin-frappe .select.is-success select:active,html.theme--catppuccin-frappe .select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(166,209,137,0.25)}html.theme--catppuccin-frappe .select.is-warning:not(:hover)::after{border-color:#e5c890}html.theme--catppuccin-frappe .select.is-warning select{border-color:#e5c890}html.theme--catppuccin-frappe .select.is-warning select:hover,html.theme--catppuccin-frappe .select.is-warning select.is-hovered{border-color:#e0be7b}html.theme--catppuccin-frappe .select.is-warning select:focus,html.theme--catppuccin-frappe .select.is-warning select.is-focused,html.theme--catppuccin-frappe .select.is-warning select:active,html.theme--catppuccin-frappe .select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(229,200,144,0.25)}html.theme--catppuccin-frappe .select.is-danger:not(:hover)::after{border-color:#e78284}html.theme--catppuccin-frappe .select.is-danger select{border-color:#e78284}html.theme--catppuccin-frappe .select.is-danger select:hover,html.theme--catppuccin-frappe .select.is-danger select.is-hovered{border-color:#e36d6f}html.theme--catppuccin-frappe .select.is-danger select:focus,html.theme--catppuccin-frappe .select.is-danger select.is-focused,html.theme--catppuccin-frappe .select.is-danger select:active,html.theme--catppuccin-frappe .select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(231,130,132,0.25)}html.theme--catppuccin-frappe .select.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.select{border-radius:3px;font-size:.75rem}html.theme--catppuccin-frappe .select.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .select.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .select.is-disabled::after{border-color:#f1f4fd !important;opacity:0.5}html.theme--catppuccin-frappe .select.is-fullwidth{width:100%}html.theme--catppuccin-frappe .select.is-fullwidth select{width:100%}html.theme--catppuccin-frappe .select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}html.theme--catppuccin-frappe .select.is-loading.is-small:after,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-frappe .select.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-frappe .select.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-frappe .file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}html.theme--catppuccin-frappe .file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .file.is-white:hover .file-cta,html.theme--catppuccin-frappe .file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .file.is-white:focus .file-cta,html.theme--catppuccin-frappe .file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}html.theme--catppuccin-frappe .file.is-white:active .file-cta,html.theme--catppuccin-frappe .file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-frappe .file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-black:hover .file-cta,html.theme--catppuccin-frappe .file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-black:focus .file-cta,html.theme--catppuccin-frappe .file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}html.theme--catppuccin-frappe .file.is-black:active .file-cta,html.theme--catppuccin-frappe .file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-light .file-cta{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-light:hover .file-cta,html.theme--catppuccin-frappe .file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-light:focus .file-cta,html.theme--catppuccin-frappe .file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(245,245,245,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-light:active .file-cta,html.theme--catppuccin-frappe .file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-dark .file-cta,html.theme--catppuccin-frappe .content kbd.file .file-cta{background-color:#414559;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-dark:hover .file-cta,html.theme--catppuccin-frappe .content kbd.file:hover .file-cta,html.theme--catppuccin-frappe .file.is-dark.is-hovered .file-cta,html.theme--catppuccin-frappe .content kbd.file.is-hovered .file-cta{background-color:#3c3f52;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-dark:focus .file-cta,html.theme--catppuccin-frappe .content kbd.file:focus .file-cta,html.theme--catppuccin-frappe .file.is-dark.is-focused .file-cta,html.theme--catppuccin-frappe .content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(65,69,89,0.25);color:#fff}html.theme--catppuccin-frappe .file.is-dark:active .file-cta,html.theme--catppuccin-frappe .content kbd.file:active .file-cta,html.theme--catppuccin-frappe .file.is-dark.is-active .file-cta,html.theme--catppuccin-frappe .content kbd.file.is-active .file-cta{background-color:#363a4a;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-primary .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.docs-sourcelink .file-cta{background-color:#8caaee;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-primary:hover .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.docs-sourcelink:hover .file-cta,html.theme--catppuccin-frappe .file.is-primary.is-hovered .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#81a2ec;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-primary:focus .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.docs-sourcelink:focus .file-cta,html.theme--catppuccin-frappe .file.is-primary.is-focused .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(140,170,238,0.25);color:#fff}html.theme--catppuccin-frappe .file.is-primary:active .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.docs-sourcelink:active .file-cta,html.theme--catppuccin-frappe .file.is-primary.is-active .file-cta,html.theme--catppuccin-frappe .docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#769aeb;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-link .file-cta{background-color:#8caaee;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-link:hover .file-cta,html.theme--catppuccin-frappe .file.is-link.is-hovered .file-cta{background-color:#81a2ec;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-link:focus .file-cta,html.theme--catppuccin-frappe .file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(140,170,238,0.25);color:#fff}html.theme--catppuccin-frappe .file.is-link:active .file-cta,html.theme--catppuccin-frappe .file.is-link.is-active .file-cta{background-color:#769aeb;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-info .file-cta{background-color:#81c8be;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-info:hover .file-cta,html.theme--catppuccin-frappe .file.is-info.is-hovered .file-cta{background-color:#78c4b9;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-info:focus .file-cta,html.theme--catppuccin-frappe .file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(129,200,190,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-info:active .file-cta,html.theme--catppuccin-frappe .file.is-info.is-active .file-cta{background-color:#6fc0b5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-success .file-cta{background-color:#a6d189;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-success:hover .file-cta,html.theme--catppuccin-frappe .file.is-success.is-hovered .file-cta{background-color:#9fcd80;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-success:focus .file-cta,html.theme--catppuccin-frappe .file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(166,209,137,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-success:active .file-cta,html.theme--catppuccin-frappe .file.is-success.is-active .file-cta{background-color:#98ca77;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-warning .file-cta{background-color:#e5c890;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-warning:hover .file-cta,html.theme--catppuccin-frappe .file.is-warning.is-hovered .file-cta{background-color:#e3c386;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-warning:focus .file-cta,html.theme--catppuccin-frappe .file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(229,200,144,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-warning:active .file-cta,html.theme--catppuccin-frappe .file.is-warning.is-active .file-cta{background-color:#e0be7b;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .file.is-danger .file-cta{background-color:#e78284;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-danger:hover .file-cta,html.theme--catppuccin-frappe .file.is-danger.is-hovered .file-cta{background-color:#e57779;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-danger:focus .file-cta,html.theme--catppuccin-frappe .file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(231,130,132,0.25);color:#fff}html.theme--catppuccin-frappe .file.is-danger:active .file-cta,html.theme--catppuccin-frappe .file.is-danger.is-active .file-cta{background-color:#e36d6f;border-color:transparent;color:#fff}html.theme--catppuccin-frappe .file.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}html.theme--catppuccin-frappe .file.is-normal{font-size:1rem}html.theme--catppuccin-frappe .file.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .file.is-medium .file-icon .fa{font-size:21px}html.theme--catppuccin-frappe .file.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .file.is-large .file-icon .fa{font-size:28px}html.theme--catppuccin-frappe .file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-frappe .file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-frappe .file.has-name.is-empty .file-cta{border-radius:.4em}html.theme--catppuccin-frappe .file.has-name.is-empty .file-name{display:none}html.theme--catppuccin-frappe .file.is-boxed .file-label{flex-direction:column}html.theme--catppuccin-frappe .file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}html.theme--catppuccin-frappe .file.is-boxed .file-name{border-width:0 1px 1px}html.theme--catppuccin-frappe .file.is-boxed .file-icon{height:1.5em;width:1.5em}html.theme--catppuccin-frappe .file.is-boxed .file-icon .fa{font-size:21px}html.theme--catppuccin-frappe .file.is-boxed.is-small .file-icon .fa,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}html.theme--catppuccin-frappe .file.is-boxed.is-medium .file-icon .fa{font-size:28px}html.theme--catppuccin-frappe .file.is-boxed.is-large .file-icon .fa{font-size:35px}html.theme--catppuccin-frappe .file.is-boxed.has-name .file-cta{border-radius:.4em .4em 0 0}html.theme--catppuccin-frappe .file.is-boxed.has-name .file-name{border-radius:0 0 .4em .4em;border-width:0 1px 1px}html.theme--catppuccin-frappe .file.is-centered{justify-content:center}html.theme--catppuccin-frappe .file.is-fullwidth .file-label{width:100%}html.theme--catppuccin-frappe .file.is-fullwidth .file-name{flex-grow:1;max-width:none}html.theme--catppuccin-frappe .file.is-right{justify-content:flex-end}html.theme--catppuccin-frappe .file.is-right .file-cta{border-radius:0 .4em .4em 0}html.theme--catppuccin-frappe .file.is-right .file-name{border-radius:.4em 0 0 .4em;border-width:1px 0 1px 1px;order:-1}html.theme--catppuccin-frappe .file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}html.theme--catppuccin-frappe .file-label:hover .file-cta{background-color:#3c3f52;color:#b0bef1}html.theme--catppuccin-frappe .file-label:hover .file-name{border-color:#5c6279}html.theme--catppuccin-frappe .file-label:active .file-cta{background-color:#363a4a;color:#b0bef1}html.theme--catppuccin-frappe .file-label:active .file-name{border-color:#575c72}html.theme--catppuccin-frappe .file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}html.theme--catppuccin-frappe .file-cta,html.theme--catppuccin-frappe .file-name{border-color:#626880;border-radius:.4em;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}html.theme--catppuccin-frappe .file-cta{background-color:#414559;color:#c6d0f5}html.theme--catppuccin-frappe .file-name{border-color:#626880;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}html.theme--catppuccin-frappe .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}html.theme--catppuccin-frappe .file-icon .fa{font-size:14px}html.theme--catppuccin-frappe .label{color:#b0bef1;display:block;font-size:1rem;font-weight:700}html.theme--catppuccin-frappe .label:not(:last-child){margin-bottom:0.5em}html.theme--catppuccin-frappe .label.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}html.theme--catppuccin-frappe .label.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .label.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .help{display:block;font-size:.75rem;margin-top:0.25rem}html.theme--catppuccin-frappe .help.is-white{color:#fff}html.theme--catppuccin-frappe .help.is-black{color:#0a0a0a}html.theme--catppuccin-frappe .help.is-light{color:#f5f5f5}html.theme--catppuccin-frappe .help.is-dark,html.theme--catppuccin-frappe .content kbd.help{color:#414559}html.theme--catppuccin-frappe .help.is-primary,html.theme--catppuccin-frappe .docstring>section>a.help.docs-sourcelink{color:#8caaee}html.theme--catppuccin-frappe .help.is-link{color:#8caaee}html.theme--catppuccin-frappe .help.is-info{color:#81c8be}html.theme--catppuccin-frappe .help.is-success{color:#a6d189}html.theme--catppuccin-frappe .help.is-warning{color:#e5c890}html.theme--catppuccin-frappe .help.is-danger{color:#e78284}html.theme--catppuccin-frappe .field:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-frappe .field.has-addons{display:flex;justify-content:flex-start}html.theme--catppuccin-frappe .field.has-addons .control:not(:last-child){margin-right:-1px}html.theme--catppuccin-frappe .field.has-addons .control:not(:first-child):not(:last-child) .button,html.theme--catppuccin-frappe .field.has-addons .control:not(:first-child):not(:last-child) .input,html.theme--catppuccin-frappe .field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,html.theme--catppuccin-frappe .field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}html.theme--catppuccin-frappe .field.has-addons .control:first-child:not(:only-child) .button,html.theme--catppuccin-frappe .field.has-addons .control:first-child:not(:only-child) .input,html.theme--catppuccin-frappe .field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-frappe .field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-frappe .field.has-addons .control:last-child:not(:only-child) .button,html.theme--catppuccin-frappe .field.has-addons .control:last-child:not(:only-child) .input,html.theme--catppuccin-frappe .field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-frappe .field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-frappe .field.has-addons .control .button:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .button.is-hovered:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .input:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .input.is-hovered:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .select select:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}html.theme--catppuccin-frappe .field.has-addons .control .button:not([disabled]):focus,html.theme--catppuccin-frappe .field.has-addons .control .button.is-focused:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .button:not([disabled]):active,html.theme--catppuccin-frappe .field.has-addons .control .button.is-active:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .input:not([disabled]):focus,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-frappe .field.has-addons .control .input.is-focused:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .input:not([disabled]):active,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,html.theme--catppuccin-frappe .field.has-addons .control .input.is-active:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .select select:not([disabled]):focus,html.theme--catppuccin-frappe .field.has-addons .control .select select.is-focused:not([disabled]),html.theme--catppuccin-frappe .field.has-addons .control .select select:not([disabled]):active,html.theme--catppuccin-frappe .field.has-addons .control .select select.is-active:not([disabled]){z-index:3}html.theme--catppuccin-frappe .field.has-addons .control .button:not([disabled]):focus:hover,html.theme--catppuccin-frappe .field.has-addons .control .button.is-focused:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .button:not([disabled]):active:hover,html.theme--catppuccin-frappe .field.has-addons .control .button.is-active:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .input:not([disabled]):focus:hover,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-frappe .field.has-addons .control .input.is-focused:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .input:not([disabled]):active:hover,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-frappe .field.has-addons .control .input.is-active:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-frappe #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .select select:not([disabled]):focus:hover,html.theme--catppuccin-frappe .field.has-addons .control .select select.is-focused:not([disabled]):hover,html.theme--catppuccin-frappe .field.has-addons .control .select select:not([disabled]):active:hover,html.theme--catppuccin-frappe .field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}html.theme--catppuccin-frappe .field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .field.has-addons.has-addons-centered{justify-content:center}html.theme--catppuccin-frappe .field.has-addons.has-addons-right{justify-content:flex-end}html.theme--catppuccin-frappe .field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}html.theme--catppuccin-frappe .field.is-grouped{display:flex;justify-content:flex-start}html.theme--catppuccin-frappe .field.is-grouped>.control{flex-shrink:0}html.theme--catppuccin-frappe .field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-frappe .field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-centered{justify-content:center}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-right{justify-content:flex-end}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-multiline{flex-wrap:wrap}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-multiline>.control:last-child,html.theme--catppuccin-frappe .field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}html.theme--catppuccin-frappe .field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .field.is-horizontal{display:flex}}html.theme--catppuccin-frappe .field-label .label{font-size:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}html.theme--catppuccin-frappe .field-label.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}html.theme--catppuccin-frappe .field-label.is-normal{padding-top:0.375em}html.theme--catppuccin-frappe .field-label.is-medium{font-size:1.25rem;padding-top:0.375em}html.theme--catppuccin-frappe .field-label.is-large{font-size:1.5rem;padding-top:0.375em}}html.theme--catppuccin-frappe .field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}html.theme--catppuccin-frappe .field-body .field{margin-bottom:0}html.theme--catppuccin-frappe .field-body>.field{flex-shrink:1}html.theme--catppuccin-frappe .field-body>.field:not(.is-narrow){flex-grow:1}html.theme--catppuccin-frappe .field-body>.field:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-frappe .control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}html.theme--catppuccin-frappe .control.has-icons-left .input:focus~.icon,html.theme--catppuccin-frappe .control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,html.theme--catppuccin-frappe .control.has-icons-left .select:focus~.icon,html.theme--catppuccin-frappe .control.has-icons-right .input:focus~.icon,html.theme--catppuccin-frappe .control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,html.theme--catppuccin-frappe .control.has-icons-right .select:focus~.icon{color:#414559}html.theme--catppuccin-frappe .control.has-icons-left .input.is-small~.icon,html.theme--catppuccin-frappe .control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,html.theme--catppuccin-frappe .control.has-icons-left .select.is-small~.icon,html.theme--catppuccin-frappe .control.has-icons-right .input.is-small~.icon,html.theme--catppuccin-frappe .control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,html.theme--catppuccin-frappe .control.has-icons-right .select.is-small~.icon{font-size:.75rem}html.theme--catppuccin-frappe .control.has-icons-left .input.is-medium~.icon,html.theme--catppuccin-frappe .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,html.theme--catppuccin-frappe .control.has-icons-left .select.is-medium~.icon,html.theme--catppuccin-frappe .control.has-icons-right .input.is-medium~.icon,html.theme--catppuccin-frappe .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,html.theme--catppuccin-frappe .control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}html.theme--catppuccin-frappe .control.has-icons-left .input.is-large~.icon,html.theme--catppuccin-frappe .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,html.theme--catppuccin-frappe .control.has-icons-left .select.is-large~.icon,html.theme--catppuccin-frappe .control.has-icons-right .input.is-large~.icon,html.theme--catppuccin-frappe .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,html.theme--catppuccin-frappe .control.has-icons-right .select.is-large~.icon{font-size:1.5rem}html.theme--catppuccin-frappe .control.has-icons-left .icon,html.theme--catppuccin-frappe .control.has-icons-right .icon{color:#626880;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}html.theme--catppuccin-frappe .control.has-icons-left .input,html.theme--catppuccin-frappe .control.has-icons-left #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-left form.docs-search>input,html.theme--catppuccin-frappe .control.has-icons-left .select select{padding-left:2.5em}html.theme--catppuccin-frappe .control.has-icons-left .icon.is-left{left:0}html.theme--catppuccin-frappe .control.has-icons-right .input,html.theme--catppuccin-frappe .control.has-icons-right #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe #documenter .docs-sidebar .control.has-icons-right form.docs-search>input,html.theme--catppuccin-frappe .control.has-icons-right .select select{padding-right:2.5em}html.theme--catppuccin-frappe .control.has-icons-right .icon.is-right{right:0}html.theme--catppuccin-frappe .control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}html.theme--catppuccin-frappe .control.is-loading.is-small:after,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-frappe .control.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-frappe .control.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-frappe .breadcrumb{font-size:1rem;white-space:nowrap}html.theme--catppuccin-frappe .breadcrumb a{align-items:center;color:#8caaee;display:flex;justify-content:center;padding:0 .75em}html.theme--catppuccin-frappe .breadcrumb a:hover{color:#99d1db}html.theme--catppuccin-frappe .breadcrumb li{align-items:center;display:flex}html.theme--catppuccin-frappe .breadcrumb li:first-child a{padding-left:0}html.theme--catppuccin-frappe .breadcrumb li.is-active a{color:#b0bef1;cursor:default;pointer-events:none}html.theme--catppuccin-frappe .breadcrumb li+li::before{color:#737994;content:"\0002f"}html.theme--catppuccin-frappe .breadcrumb ul,html.theme--catppuccin-frappe .breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-frappe .breadcrumb .icon:first-child{margin-right:.5em}html.theme--catppuccin-frappe .breadcrumb .icon:last-child{margin-left:.5em}html.theme--catppuccin-frappe .breadcrumb.is-centered ol,html.theme--catppuccin-frappe .breadcrumb.is-centered ul{justify-content:center}html.theme--catppuccin-frappe .breadcrumb.is-right ol,html.theme--catppuccin-frappe .breadcrumb.is-right ul{justify-content:flex-end}html.theme--catppuccin-frappe .breadcrumb.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}html.theme--catppuccin-frappe .breadcrumb.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .breadcrumb.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .breadcrumb.has-arrow-separator li+li::before{content:"\02192"}html.theme--catppuccin-frappe .breadcrumb.has-bullet-separator li+li::before{content:"\02022"}html.theme--catppuccin-frappe .breadcrumb.has-dot-separator li+li::before{content:"\000b7"}html.theme--catppuccin-frappe .breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}html.theme--catppuccin-frappe .card{background-color:#fff;border-radius:.25rem;box-shadow:#171717;color:#c6d0f5;max-width:100%;position:relative}html.theme--catppuccin-frappe .card-footer:first-child,html.theme--catppuccin-frappe .card-content:first-child,html.theme--catppuccin-frappe .card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-frappe .card-footer:last-child,html.theme--catppuccin-frappe .card-content:last-child,html.theme--catppuccin-frappe .card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-frappe .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}html.theme--catppuccin-frappe .card-header-title{align-items:center;color:#b0bef1;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}html.theme--catppuccin-frappe .card-header-title.is-centered{justify-content:center}html.theme--catppuccin-frappe .card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}html.theme--catppuccin-frappe .card-image{display:block;position:relative}html.theme--catppuccin-frappe .card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-frappe .card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-frappe .card-content{background-color:rgba(0,0,0,0);padding:1.5rem}html.theme--catppuccin-frappe .card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}html.theme--catppuccin-frappe .card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}html.theme--catppuccin-frappe .card-footer-item:not(:last-child){border-right:1px solid #ededed}html.theme--catppuccin-frappe .card .media:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-frappe .dropdown{display:inline-flex;position:relative;vertical-align:top}html.theme--catppuccin-frappe .dropdown.is-active .dropdown-menu,html.theme--catppuccin-frappe .dropdown.is-hoverable:hover .dropdown-menu{display:block}html.theme--catppuccin-frappe .dropdown.is-right .dropdown-menu{left:auto;right:0}html.theme--catppuccin-frappe .dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}html.theme--catppuccin-frappe .dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}html.theme--catppuccin-frappe .dropdown-content{background-color:#292c3c;border-radius:.4em;box-shadow:#171717;padding-bottom:.5rem;padding-top:.5rem}html.theme--catppuccin-frappe .dropdown-item{color:#c6d0f5;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}html.theme--catppuccin-frappe a.dropdown-item,html.theme--catppuccin-frappe button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}html.theme--catppuccin-frappe a.dropdown-item:hover,html.theme--catppuccin-frappe button.dropdown-item:hover{background-color:#292c3c;color:#0a0a0a}html.theme--catppuccin-frappe a.dropdown-item.is-active,html.theme--catppuccin-frappe button.dropdown-item.is-active{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}html.theme--catppuccin-frappe .level{align-items:center;justify-content:space-between}html.theme--catppuccin-frappe .level code{border-radius:.4em}html.theme--catppuccin-frappe .level img{display:inline-block;vertical-align:top}html.theme--catppuccin-frappe .level.is-mobile{display:flex}html.theme--catppuccin-frappe .level.is-mobile .level-left,html.theme--catppuccin-frappe .level.is-mobile .level-right{display:flex}html.theme--catppuccin-frappe .level.is-mobile .level-left+.level-right{margin-top:0}html.theme--catppuccin-frappe .level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-frappe .level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .level{display:flex}html.theme--catppuccin-frappe .level>.level-item:not(.is-narrow){flex-grow:1}}html.theme--catppuccin-frappe .level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}html.theme--catppuccin-frappe .level-item .title,html.theme--catppuccin-frappe .level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .level-item:not(:last-child){margin-bottom:.75rem}}html.theme--catppuccin-frappe .level-left,html.theme--catppuccin-frappe .level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-frappe .level-left .level-item.is-flexible,html.theme--catppuccin-frappe .level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .level-left .level-item:not(:last-child),html.theme--catppuccin-frappe .level-right .level-item:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-frappe .level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .level-left{display:flex}}html.theme--catppuccin-frappe .level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .level-right{display:flex}}html.theme--catppuccin-frappe .media{align-items:flex-start;display:flex;text-align:inherit}html.theme--catppuccin-frappe .media .content:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-frappe .media .media{border-top:1px solid rgba(98,104,128,0.5);display:flex;padding-top:.75rem}html.theme--catppuccin-frappe .media .media .content:not(:last-child),html.theme--catppuccin-frappe .media .media .control:not(:last-child){margin-bottom:.5rem}html.theme--catppuccin-frappe .media .media .media{padding-top:.5rem}html.theme--catppuccin-frappe .media .media .media+.media{margin-top:.5rem}html.theme--catppuccin-frappe .media+.media{border-top:1px solid rgba(98,104,128,0.5);margin-top:1rem;padding-top:1rem}html.theme--catppuccin-frappe .media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}html.theme--catppuccin-frappe .media-left,html.theme--catppuccin-frappe .media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-frappe .media-left{margin-right:1rem}html.theme--catppuccin-frappe .media-right{margin-left:1rem}html.theme--catppuccin-frappe .media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .media-content{overflow-x:auto}}html.theme--catppuccin-frappe .menu{font-size:1rem}html.theme--catppuccin-frappe .menu.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}html.theme--catppuccin-frappe .menu.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .menu.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .menu-list{line-height:1.25}html.theme--catppuccin-frappe .menu-list a{border-radius:3px;color:#c6d0f5;display:block;padding:0.5em 0.75em}html.theme--catppuccin-frappe .menu-list a:hover{background-color:#292c3c;color:#b0bef1}html.theme--catppuccin-frappe .menu-list a.is-active{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .menu-list li ul{border-left:1px solid #626880;margin:.75em;padding-left:.75em}html.theme--catppuccin-frappe .menu-label{color:#f1f4fd;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}html.theme--catppuccin-frappe .menu-label:not(:first-child){margin-top:1em}html.theme--catppuccin-frappe .menu-label:not(:last-child){margin-bottom:1em}html.theme--catppuccin-frappe .message{background-color:#292c3c;border-radius:.4em;font-size:1rem}html.theme--catppuccin-frappe .message strong{color:currentColor}html.theme--catppuccin-frappe .message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-frappe .message.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}html.theme--catppuccin-frappe .message.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .message.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .message.is-white{background-color:#fff}html.theme--catppuccin-frappe .message.is-white .message-header{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .message.is-white .message-body{border-color:#fff}html.theme--catppuccin-frappe .message.is-black{background-color:#fafafa}html.theme--catppuccin-frappe .message.is-black .message-header{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .message.is-black .message-body{border-color:#0a0a0a}html.theme--catppuccin-frappe .message.is-light{background-color:#fafafa}html.theme--catppuccin-frappe .message.is-light .message-header{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .message.is-light .message-body{border-color:#f5f5f5}html.theme--catppuccin-frappe .message.is-dark,html.theme--catppuccin-frappe .content kbd.message{background-color:#f9f9fb}html.theme--catppuccin-frappe .message.is-dark .message-header,html.theme--catppuccin-frappe .content kbd.message .message-header{background-color:#414559;color:#fff}html.theme--catppuccin-frappe .message.is-dark .message-body,html.theme--catppuccin-frappe .content kbd.message .message-body{border-color:#414559}html.theme--catppuccin-frappe .message.is-primary,html.theme--catppuccin-frappe .docstring>section>a.message.docs-sourcelink{background-color:#edf2fc}html.theme--catppuccin-frappe .message.is-primary .message-header,html.theme--catppuccin-frappe .docstring>section>a.message.docs-sourcelink .message-header{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .message.is-primary .message-body,html.theme--catppuccin-frappe .docstring>section>a.message.docs-sourcelink .message-body{border-color:#8caaee;color:#153a8e}html.theme--catppuccin-frappe .message.is-link{background-color:#edf2fc}html.theme--catppuccin-frappe .message.is-link .message-header{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .message.is-link .message-body{border-color:#8caaee;color:#153a8e}html.theme--catppuccin-frappe .message.is-info{background-color:#f1f9f8}html.theme--catppuccin-frappe .message.is-info .message-header{background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .message.is-info .message-body{border-color:#81c8be;color:#2d675f}html.theme--catppuccin-frappe .message.is-success{background-color:#f4f9f0}html.theme--catppuccin-frappe .message.is-success .message-header{background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .message.is-success .message-body{border-color:#a6d189;color:#446a29}html.theme--catppuccin-frappe .message.is-warning{background-color:#fbf7ee}html.theme--catppuccin-frappe .message.is-warning .message-header{background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .message.is-warning .message-body{border-color:#e5c890;color:#78591c}html.theme--catppuccin-frappe .message.is-danger{background-color:#fceeee}html.theme--catppuccin-frappe .message.is-danger .message-header{background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .message.is-danger .message-body{border-color:#e78284;color:#9a1e20}html.theme--catppuccin-frappe .message-header{align-items:center;background-color:#c6d0f5;border-radius:.4em .4em 0 0;color:rgba(0,0,0,0.7);display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}html.theme--catppuccin-frappe .message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}html.theme--catppuccin-frappe .message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}html.theme--catppuccin-frappe .message-body{border-color:#626880;border-radius:.4em;border-style:solid;border-width:0 0 0 4px;color:#c6d0f5;padding:1.25em 1.5em}html.theme--catppuccin-frappe .message-body code,html.theme--catppuccin-frappe .message-body pre{background-color:#fff}html.theme--catppuccin-frappe .message-body pre code{background-color:rgba(0,0,0,0)}html.theme--catppuccin-frappe .modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}html.theme--catppuccin-frappe .modal.is-active{display:flex}html.theme--catppuccin-frappe .modal-background{background-color:rgba(10,10,10,0.86)}html.theme--catppuccin-frappe .modal-content,html.theme--catppuccin-frappe .modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){html.theme--catppuccin-frappe .modal-content,html.theme--catppuccin-frappe .modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}html.theme--catppuccin-frappe .modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}html.theme--catppuccin-frappe .modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}html.theme--catppuccin-frappe .modal-card-head,html.theme--catppuccin-frappe .modal-card-foot{align-items:center;background-color:#292c3c;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}html.theme--catppuccin-frappe .modal-card-head{border-bottom:1px solid #626880;border-top-left-radius:8px;border-top-right-radius:8px}html.theme--catppuccin-frappe .modal-card-title{color:#c6d0f5;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}html.theme--catppuccin-frappe .modal-card-foot{border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid #626880}html.theme--catppuccin-frappe .modal-card-foot .button:not(:last-child){margin-right:.5em}html.theme--catppuccin-frappe .modal-card-body{-webkit-overflow-scrolling:touch;background-color:#303446;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}html.theme--catppuccin-frappe .navbar{background-color:#8caaee;min-height:4rem;position:relative;z-index:30}html.theme--catppuccin-frappe .navbar.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-white .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-white .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-white .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-white .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-white .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-white .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-white .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-frappe .navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}html.theme--catppuccin-frappe .navbar.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-black .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-black .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-black .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-black .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-black .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-black .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-black .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-black .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}html.theme--catppuccin-frappe .navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}html.theme--catppuccin-frappe .navbar.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-light .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-light .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-light .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-light .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-light .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-light .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-light .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-light .navbar-end .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-frappe .navbar.is-dark,html.theme--catppuccin-frappe .content kbd.navbar{background-color:#414559;color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand .navbar-link.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#363a4a;color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-brand .navbar-link::after,html.theme--catppuccin-frappe .content kbd.navbar .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-burger,html.theme--catppuccin-frappe .content kbd.navbar .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-dark .navbar-start>.navbar-item,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end>.navbar-item,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end .navbar-link.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#363a4a;color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .content kbd.navbar .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-dark .navbar-end .navbar-link::after,html.theme--catppuccin-frappe .content kbd.navbar .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-frappe .content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#363a4a;color:#fff}html.theme--catppuccin-frappe .navbar.is-dark .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-frappe .content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#414559;color:#fff}}html.theme--catppuccin-frappe .navbar.is-primary,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand .navbar-link.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-brand .navbar-link::after,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-burger,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-primary .navbar-start>.navbar-item,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end>.navbar-item,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end .navbar-link.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-primary .navbar-end .navbar-link::after,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#8caaee;color:#fff}}html.theme--catppuccin-frappe .navbar.is-link{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-link .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-link .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-link .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-link .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-link .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-link .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-link .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-link .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-link .navbar-end .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#8caaee;color:#fff}}html.theme--catppuccin-frappe .navbar.is-info{background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#6fc0b5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-info .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-info .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-info .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-info .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-info .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-info .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-info .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-info .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-info .navbar-end .navbar-link.is-active{background-color:#6fc0b5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-info .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#6fc0b5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#81c8be;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-frappe .navbar.is-success{background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#98ca77;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-success .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-success .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-success .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-success .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-success .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-success .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-success .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-success .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-success .navbar-end .navbar-link.is-active{background-color:#98ca77;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-success .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#98ca77;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#a6d189;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-frappe .navbar.is-warning{background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#e0be7b;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-warning .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#e0be7b;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-warning .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e0be7b;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#e5c890;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-frappe .navbar.is-danger{background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand>.navbar-item,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#e36d6f;color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar.is-danger .navbar-start>.navbar-item,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start .navbar-link,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end>.navbar-item,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-start>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-start .navbar-link.is-active,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end>a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end>a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#e36d6f;color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-start .navbar-link::after,html.theme--catppuccin-frappe .navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e36d6f;color:#fff}html.theme--catppuccin-frappe .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#e78284;color:#fff}}html.theme--catppuccin-frappe .navbar>.container{align-items:stretch;display:flex;min-height:4rem;width:100%}html.theme--catppuccin-frappe .navbar.has-shadow{box-shadow:0 2px 0 0 #292c3c}html.theme--catppuccin-frappe .navbar.is-fixed-bottom,html.theme--catppuccin-frappe .navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-frappe .navbar.is-fixed-bottom{bottom:0}html.theme--catppuccin-frappe .navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #292c3c}html.theme--catppuccin-frappe .navbar.is-fixed-top{top:0}html.theme--catppuccin-frappe html.has-navbar-fixed-top,html.theme--catppuccin-frappe body.has-navbar-fixed-top{padding-top:4rem}html.theme--catppuccin-frappe html.has-navbar-fixed-bottom,html.theme--catppuccin-frappe body.has-navbar-fixed-bottom{padding-bottom:4rem}html.theme--catppuccin-frappe .navbar-brand,html.theme--catppuccin-frappe .navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:4rem}html.theme--catppuccin-frappe .navbar-brand a.navbar-item:focus,html.theme--catppuccin-frappe .navbar-brand a.navbar-item:hover{background-color:transparent}html.theme--catppuccin-frappe .navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}html.theme--catppuccin-frappe .navbar-burger{color:#c6d0f5;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:4rem;position:relative;width:4rem;margin-left:auto}html.theme--catppuccin-frappe .navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}html.theme--catppuccin-frappe .navbar-burger span:nth-child(1){top:calc(50% - 6px)}html.theme--catppuccin-frappe .navbar-burger span:nth-child(2){top:calc(50% - 1px)}html.theme--catppuccin-frappe .navbar-burger span:nth-child(3){top:calc(50% + 4px)}html.theme--catppuccin-frappe .navbar-burger:hover{background-color:rgba(0,0,0,0.05)}html.theme--catppuccin-frappe .navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}html.theme--catppuccin-frappe .navbar-burger.is-active span:nth-child(2){opacity:0}html.theme--catppuccin-frappe .navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}html.theme--catppuccin-frappe .navbar-menu{display:none}html.theme--catppuccin-frappe .navbar-item,html.theme--catppuccin-frappe .navbar-link{color:#c6d0f5;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}html.theme--catppuccin-frappe .navbar-item .icon:only-child,html.theme--catppuccin-frappe .navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}html.theme--catppuccin-frappe a.navbar-item,html.theme--catppuccin-frappe .navbar-link{cursor:pointer}html.theme--catppuccin-frappe a.navbar-item:focus,html.theme--catppuccin-frappe a.navbar-item:focus-within,html.theme--catppuccin-frappe a.navbar-item:hover,html.theme--catppuccin-frappe a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar-link:focus,html.theme--catppuccin-frappe .navbar-link:focus-within,html.theme--catppuccin-frappe .navbar-link:hover,html.theme--catppuccin-frappe .navbar-link.is-active{background-color:rgba(0,0,0,0);color:#8caaee}html.theme--catppuccin-frappe .navbar-item{flex-grow:0;flex-shrink:0}html.theme--catppuccin-frappe .navbar-item img{max-height:1.75rem}html.theme--catppuccin-frappe .navbar-item.has-dropdown{padding:0}html.theme--catppuccin-frappe .navbar-item.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .navbar-item.is-tab{border-bottom:1px solid transparent;min-height:4rem;padding-bottom:calc(0.5rem - 1px)}html.theme--catppuccin-frappe .navbar-item.is-tab:focus,html.theme--catppuccin-frappe .navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#8caaee}html.theme--catppuccin-frappe .navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#8caaee;border-bottom-style:solid;border-bottom-width:3px;color:#8caaee;padding-bottom:calc(0.5rem - 3px)}html.theme--catppuccin-frappe .navbar-content{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .navbar-link:not(.is-arrowless){padding-right:2.5em}html.theme--catppuccin-frappe .navbar-link:not(.is-arrowless)::after{border-color:#fff;margin-top:-0.375em;right:1.125em}html.theme--catppuccin-frappe .navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}html.theme--catppuccin-frappe .navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}html.theme--catppuccin-frappe .navbar-divider{background-color:rgba(0,0,0,0.2);border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .navbar>.container{display:block}html.theme--catppuccin-frappe .navbar-brand .navbar-item,html.theme--catppuccin-frappe .navbar-tabs .navbar-item{align-items:center;display:flex}html.theme--catppuccin-frappe .navbar-link::after{display:none}html.theme--catppuccin-frappe .navbar-menu{background-color:#8caaee;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}html.theme--catppuccin-frappe .navbar-menu.is-active{display:block}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-touch,html.theme--catppuccin-frappe .navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-touch{bottom:0}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .navbar.is-fixed-top-touch{top:0}html.theme--catppuccin-frappe .navbar.is-fixed-top .navbar-menu,html.theme--catppuccin-frappe .navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 4rem);overflow:auto}html.theme--catppuccin-frappe html.has-navbar-fixed-top-touch,html.theme--catppuccin-frappe body.has-navbar-fixed-top-touch{padding-top:4rem}html.theme--catppuccin-frappe html.has-navbar-fixed-bottom-touch,html.theme--catppuccin-frappe body.has-navbar-fixed-bottom-touch{padding-bottom:4rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .navbar,html.theme--catppuccin-frappe .navbar-menu,html.theme--catppuccin-frappe .navbar-start,html.theme--catppuccin-frappe .navbar-end{align-items:stretch;display:flex}html.theme--catppuccin-frappe .navbar{min-height:4rem}html.theme--catppuccin-frappe .navbar.is-spaced{padding:1rem 2rem}html.theme--catppuccin-frappe .navbar.is-spaced .navbar-start,html.theme--catppuccin-frappe .navbar.is-spaced .navbar-end{align-items:center}html.theme--catppuccin-frappe .navbar.is-spaced a.navbar-item,html.theme--catppuccin-frappe .navbar.is-spaced .navbar-link{border-radius:.4em}html.theme--catppuccin-frappe .navbar.is-transparent a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-transparent a.navbar-item:hover,html.theme--catppuccin-frappe .navbar.is-transparent a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-link:focus,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-link:hover,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}html.theme--catppuccin-frappe .navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}html.theme--catppuccin-frappe .navbar.is-transparent .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-frappe .navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#838ba7}html.theme--catppuccin-frappe .navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#8caaee}html.theme--catppuccin-frappe .navbar-burger{display:none}html.theme--catppuccin-frappe .navbar-item,html.theme--catppuccin-frappe .navbar-link{align-items:center;display:flex}html.theme--catppuccin-frappe .navbar-item.has-dropdown{align-items:stretch}html.theme--catppuccin-frappe .navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}html.theme--catppuccin-frappe .navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:1px solid rgba(0,0,0,0.2);border-radius:8px 8px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}html.theme--catppuccin-frappe .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced html.theme--catppuccin-frappe .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-frappe .navbar-item.is-hoverable:hover .navbar-dropdown,html.theme--catppuccin-frappe .navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}html.theme--catppuccin-frappe .navbar-menu{flex-grow:1;flex-shrink:0}html.theme--catppuccin-frappe .navbar-start{justify-content:flex-start;margin-right:auto}html.theme--catppuccin-frappe .navbar-end{justify-content:flex-end;margin-left:auto}html.theme--catppuccin-frappe .navbar-dropdown{background-color:#8caaee;border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid rgba(0,0,0,0.2);box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}html.theme--catppuccin-frappe .navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}html.theme--catppuccin-frappe .navbar-dropdown a.navbar-item{padding-right:3rem}html.theme--catppuccin-frappe .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-frappe .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#838ba7}html.theme--catppuccin-frappe .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#8caaee}.navbar.is-spaced html.theme--catppuccin-frappe .navbar-dropdown,html.theme--catppuccin-frappe .navbar-dropdown.is-boxed{border-radius:8px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}html.theme--catppuccin-frappe .navbar-dropdown.is-right{left:auto;right:0}html.theme--catppuccin-frappe .navbar-divider{display:block}html.theme--catppuccin-frappe .navbar>.container .navbar-brand,html.theme--catppuccin-frappe .container>.navbar .navbar-brand{margin-left:-.75rem}html.theme--catppuccin-frappe .navbar>.container .navbar-menu,html.theme--catppuccin-frappe .container>.navbar .navbar-menu{margin-right:-.75rem}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-desktop,html.theme--catppuccin-frappe .navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-desktop{bottom:0}html.theme--catppuccin-frappe .navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .navbar.is-fixed-top-desktop{top:0}html.theme--catppuccin-frappe html.has-navbar-fixed-top-desktop,html.theme--catppuccin-frappe body.has-navbar-fixed-top-desktop{padding-top:4rem}html.theme--catppuccin-frappe html.has-navbar-fixed-bottom-desktop,html.theme--catppuccin-frappe body.has-navbar-fixed-bottom-desktop{padding-bottom:4rem}html.theme--catppuccin-frappe html.has-spaced-navbar-fixed-top,html.theme--catppuccin-frappe body.has-spaced-navbar-fixed-top{padding-top:6rem}html.theme--catppuccin-frappe html.has-spaced-navbar-fixed-bottom,html.theme--catppuccin-frappe body.has-spaced-navbar-fixed-bottom{padding-bottom:6rem}html.theme--catppuccin-frappe a.navbar-item.is-active,html.theme--catppuccin-frappe .navbar-link.is-active{color:#8caaee}html.theme--catppuccin-frappe a.navbar-item.is-active:not(:focus):not(:hover),html.theme--catppuccin-frappe .navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}html.theme--catppuccin-frappe .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-frappe .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-frappe .navbar-item.has-dropdown.is-active .navbar-link{background-color:rgba(0,0,0,0)}}html.theme--catppuccin-frappe .hero.is-fullheight-with-navbar{min-height:calc(100vh - 4rem)}html.theme--catppuccin-frappe .pagination{font-size:1rem;margin:-.25rem}html.theme--catppuccin-frappe .pagination.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}html.theme--catppuccin-frappe .pagination.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .pagination.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .pagination.is-rounded .pagination-previous,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,html.theme--catppuccin-frappe .pagination.is-rounded .pagination-next,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}html.theme--catppuccin-frappe .pagination.is-rounded .pagination-link,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}html.theme--catppuccin-frappe .pagination,html.theme--catppuccin-frappe .pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe .pagination-link,html.theme--catppuccin-frappe .pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe .pagination-link{border-color:#626880;color:#8caaee;min-width:2.5em}html.theme--catppuccin-frappe .pagination-previous:hover,html.theme--catppuccin-frappe .pagination-next:hover,html.theme--catppuccin-frappe .pagination-link:hover{border-color:#737994;color:#99d1db}html.theme--catppuccin-frappe .pagination-previous:focus,html.theme--catppuccin-frappe .pagination-next:focus,html.theme--catppuccin-frappe .pagination-link:focus{border-color:#737994}html.theme--catppuccin-frappe .pagination-previous:active,html.theme--catppuccin-frappe .pagination-next:active,html.theme--catppuccin-frappe .pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}html.theme--catppuccin-frappe .pagination-previous[disabled],html.theme--catppuccin-frappe .pagination-previous.is-disabled,html.theme--catppuccin-frappe .pagination-next[disabled],html.theme--catppuccin-frappe .pagination-next.is-disabled,html.theme--catppuccin-frappe .pagination-link[disabled],html.theme--catppuccin-frappe .pagination-link.is-disabled{background-color:#626880;border-color:#626880;box-shadow:none;color:#f1f4fd;opacity:0.5}html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}html.theme--catppuccin-frappe .pagination-link.is-current{background-color:#8caaee;border-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .pagination-ellipsis{color:#737994;pointer-events:none}html.theme--catppuccin-frappe .pagination-list{flex-wrap:wrap}html.theme--catppuccin-frappe .pagination-list li{list-style:none}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .pagination{flex-wrap:wrap}html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe .pagination-link,html.theme--catppuccin-frappe .pagination-ellipsis{margin-bottom:0;margin-top:0}html.theme--catppuccin-frappe .pagination-previous{order:2}html.theme--catppuccin-frappe .pagination-next{order:3}html.theme--catppuccin-frappe .pagination{justify-content:space-between;margin-bottom:0;margin-top:0}html.theme--catppuccin-frappe .pagination.is-centered .pagination-previous{order:1}html.theme--catppuccin-frappe .pagination.is-centered .pagination-list{justify-content:center;order:2}html.theme--catppuccin-frappe .pagination.is-centered .pagination-next{order:3}html.theme--catppuccin-frappe .pagination.is-right .pagination-previous{order:1}html.theme--catppuccin-frappe .pagination.is-right .pagination-next{order:2}html.theme--catppuccin-frappe .pagination.is-right .pagination-list{justify-content:flex-end;order:3}}html.theme--catppuccin-frappe .panel{border-radius:8px;box-shadow:#171717;font-size:1rem}html.theme--catppuccin-frappe .panel:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-frappe .panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}html.theme--catppuccin-frappe .panel.is-white .panel-block.is-active .panel-icon{color:#fff}html.theme--catppuccin-frappe .panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}html.theme--catppuccin-frappe .panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}html.theme--catppuccin-frappe .panel.is-light .panel-heading{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .panel.is-light .panel-tabs a.is-active{border-bottom-color:#f5f5f5}html.theme--catppuccin-frappe .panel.is-light .panel-block.is-active .panel-icon{color:#f5f5f5}html.theme--catppuccin-frappe .panel.is-dark .panel-heading,html.theme--catppuccin-frappe .content kbd.panel .panel-heading{background-color:#414559;color:#fff}html.theme--catppuccin-frappe .panel.is-dark .panel-tabs a.is-active,html.theme--catppuccin-frappe .content kbd.panel .panel-tabs a.is-active{border-bottom-color:#414559}html.theme--catppuccin-frappe .panel.is-dark .panel-block.is-active .panel-icon,html.theme--catppuccin-frappe .content kbd.panel .panel-block.is-active .panel-icon{color:#414559}html.theme--catppuccin-frappe .panel.is-primary .panel-heading,html.theme--catppuccin-frappe .docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .panel.is-primary .panel-tabs a.is-active,html.theme--catppuccin-frappe .docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#8caaee}html.theme--catppuccin-frappe .panel.is-primary .panel-block.is-active .panel-icon,html.theme--catppuccin-frappe .docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#8caaee}html.theme--catppuccin-frappe .panel.is-link .panel-heading{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .panel.is-link .panel-tabs a.is-active{border-bottom-color:#8caaee}html.theme--catppuccin-frappe .panel.is-link .panel-block.is-active .panel-icon{color:#8caaee}html.theme--catppuccin-frappe .panel.is-info .panel-heading{background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .panel.is-info .panel-tabs a.is-active{border-bottom-color:#81c8be}html.theme--catppuccin-frappe .panel.is-info .panel-block.is-active .panel-icon{color:#81c8be}html.theme--catppuccin-frappe .panel.is-success .panel-heading{background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .panel.is-success .panel-tabs a.is-active{border-bottom-color:#a6d189}html.theme--catppuccin-frappe .panel.is-success .panel-block.is-active .panel-icon{color:#a6d189}html.theme--catppuccin-frappe .panel.is-warning .panel-heading{background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .panel.is-warning .panel-tabs a.is-active{border-bottom-color:#e5c890}html.theme--catppuccin-frappe .panel.is-warning .panel-block.is-active .panel-icon{color:#e5c890}html.theme--catppuccin-frappe .panel.is-danger .panel-heading{background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .panel.is-danger .panel-tabs a.is-active{border-bottom-color:#e78284}html.theme--catppuccin-frappe .panel.is-danger .panel-block.is-active .panel-icon{color:#e78284}html.theme--catppuccin-frappe .panel-tabs:not(:last-child),html.theme--catppuccin-frappe .panel-block:not(:last-child){border-bottom:1px solid #ededed}html.theme--catppuccin-frappe .panel-heading{background-color:#51576d;border-radius:8px 8px 0 0;color:#b0bef1;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}html.theme--catppuccin-frappe .panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}html.theme--catppuccin-frappe .panel-tabs a{border-bottom:1px solid #626880;margin-bottom:-1px;padding:0.5em}html.theme--catppuccin-frappe .panel-tabs a.is-active{border-bottom-color:#51576d;color:#769aeb}html.theme--catppuccin-frappe .panel-list a{color:#c6d0f5}html.theme--catppuccin-frappe .panel-list a:hover{color:#8caaee}html.theme--catppuccin-frappe .panel-block{align-items:center;color:#b0bef1;display:flex;justify-content:flex-start;padding:0.5em 0.75em}html.theme--catppuccin-frappe .panel-block input[type="checkbox"]{margin-right:.75em}html.theme--catppuccin-frappe .panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}html.theme--catppuccin-frappe .panel-block.is-wrapped{flex-wrap:wrap}html.theme--catppuccin-frappe .panel-block.is-active{border-left-color:#8caaee;color:#769aeb}html.theme--catppuccin-frappe .panel-block.is-active .panel-icon{color:#8caaee}html.theme--catppuccin-frappe .panel-block:last-child{border-bottom-left-radius:8px;border-bottom-right-radius:8px}html.theme--catppuccin-frappe a.panel-block,html.theme--catppuccin-frappe label.panel-block{cursor:pointer}html.theme--catppuccin-frappe a.panel-block:hover,html.theme--catppuccin-frappe label.panel-block:hover{background-color:#292c3c}html.theme--catppuccin-frappe .panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#f1f4fd;margin-right:.75em}html.theme--catppuccin-frappe .panel-icon .fa{font-size:inherit;line-height:inherit}html.theme--catppuccin-frappe .tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}html.theme--catppuccin-frappe .tabs a{align-items:center;border-bottom-color:#626880;border-bottom-style:solid;border-bottom-width:1px;color:#c6d0f5;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}html.theme--catppuccin-frappe .tabs a:hover{border-bottom-color:#b0bef1;color:#b0bef1}html.theme--catppuccin-frappe .tabs li{display:block}html.theme--catppuccin-frappe .tabs li.is-active a{border-bottom-color:#8caaee;color:#8caaee}html.theme--catppuccin-frappe .tabs ul{align-items:center;border-bottom-color:#626880;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}html.theme--catppuccin-frappe .tabs ul.is-left{padding-right:0.75em}html.theme--catppuccin-frappe .tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}html.theme--catppuccin-frappe .tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}html.theme--catppuccin-frappe .tabs .icon:first-child{margin-right:.5em}html.theme--catppuccin-frappe .tabs .icon:last-child{margin-left:.5em}html.theme--catppuccin-frappe .tabs.is-centered ul{justify-content:center}html.theme--catppuccin-frappe .tabs.is-right ul{justify-content:flex-end}html.theme--catppuccin-frappe .tabs.is-boxed a{border:1px solid transparent;border-radius:.4em .4em 0 0}html.theme--catppuccin-frappe .tabs.is-boxed a:hover{background-color:#292c3c;border-bottom-color:#626880}html.theme--catppuccin-frappe .tabs.is-boxed li.is-active a{background-color:#fff;border-color:#626880;border-bottom-color:rgba(0,0,0,0) !important}html.theme--catppuccin-frappe .tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}html.theme--catppuccin-frappe .tabs.is-toggle a{border-color:#626880;border-style:solid;border-width:1px;margin-bottom:0;position:relative}html.theme--catppuccin-frappe .tabs.is-toggle a:hover{background-color:#292c3c;border-color:#737994;z-index:2}html.theme--catppuccin-frappe .tabs.is-toggle li+li{margin-left:-1px}html.theme--catppuccin-frappe .tabs.is-toggle li:first-child a{border-top-left-radius:.4em;border-bottom-left-radius:.4em}html.theme--catppuccin-frappe .tabs.is-toggle li:last-child a{border-top-right-radius:.4em;border-bottom-right-radius:.4em}html.theme--catppuccin-frappe .tabs.is-toggle li.is-active a{background-color:#8caaee;border-color:#8caaee;color:#fff;z-index:1}html.theme--catppuccin-frappe .tabs.is-toggle ul{border-bottom:none}html.theme--catppuccin-frappe .tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}html.theme--catppuccin-frappe .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}html.theme--catppuccin-frappe .tabs.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}html.theme--catppuccin-frappe .tabs.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .tabs.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-narrow{flex:none;width:unset}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-full{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-half{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-half{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-0{flex:none;width:0%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-0{margin-left:0%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-3{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-3{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-6{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-6{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-9{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-9{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-12{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-frappe .column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .column.is-narrow-mobile{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full-mobile{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters-mobile{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds-mobile{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half-mobile{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third-mobile{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter-mobile{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth-mobile{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths-mobile{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths-mobile{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths-mobile{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters-mobile{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds-mobile{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half-mobile{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third-mobile{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter-mobile{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth-mobile{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths-mobile{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths-mobile{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths-mobile{margin-left:80%}html.theme--catppuccin-frappe .column.is-0-mobile{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0-mobile{margin-left:0%}html.theme--catppuccin-frappe .column.is-1-mobile{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1-mobile{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2-mobile{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2-mobile{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3-mobile{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3-mobile{margin-left:25%}html.theme--catppuccin-frappe .column.is-4-mobile{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4-mobile{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5-mobile{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5-mobile{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6-mobile{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6-mobile{margin-left:50%}html.theme--catppuccin-frappe .column.is-7-mobile{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7-mobile{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8-mobile{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8-mobile{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9-mobile{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9-mobile{margin-left:75%}html.theme--catppuccin-frappe .column.is-10-mobile{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10-mobile{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11-mobile{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11-mobile{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12-mobile{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .column.is-narrow,html.theme--catppuccin-frappe .column.is-narrow-tablet{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full,html.theme--catppuccin-frappe .column.is-full-tablet{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters,html.theme--catppuccin-frappe .column.is-three-quarters-tablet{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds,html.theme--catppuccin-frappe .column.is-two-thirds-tablet{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half,html.theme--catppuccin-frappe .column.is-half-tablet{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third,html.theme--catppuccin-frappe .column.is-one-third-tablet{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter,html.theme--catppuccin-frappe .column.is-one-quarter-tablet{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth,html.theme--catppuccin-frappe .column.is-one-fifth-tablet{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths,html.theme--catppuccin-frappe .column.is-two-fifths-tablet{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths,html.theme--catppuccin-frappe .column.is-three-fifths-tablet{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths,html.theme--catppuccin-frappe .column.is-four-fifths-tablet{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters,html.theme--catppuccin-frappe .column.is-offset-three-quarters-tablet{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds,html.theme--catppuccin-frappe .column.is-offset-two-thirds-tablet{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half,html.theme--catppuccin-frappe .column.is-offset-half-tablet{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third,html.theme--catppuccin-frappe .column.is-offset-one-third-tablet{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter,html.theme--catppuccin-frappe .column.is-offset-one-quarter-tablet{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth,html.theme--catppuccin-frappe .column.is-offset-one-fifth-tablet{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths,html.theme--catppuccin-frappe .column.is-offset-two-fifths-tablet{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths,html.theme--catppuccin-frappe .column.is-offset-three-fifths-tablet{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths,html.theme--catppuccin-frappe .column.is-offset-four-fifths-tablet{margin-left:80%}html.theme--catppuccin-frappe .column.is-0,html.theme--catppuccin-frappe .column.is-0-tablet{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0,html.theme--catppuccin-frappe .column.is-offset-0-tablet{margin-left:0%}html.theme--catppuccin-frappe .column.is-1,html.theme--catppuccin-frappe .column.is-1-tablet{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1,html.theme--catppuccin-frappe .column.is-offset-1-tablet{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2,html.theme--catppuccin-frappe .column.is-2-tablet{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2,html.theme--catppuccin-frappe .column.is-offset-2-tablet{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3,html.theme--catppuccin-frappe .column.is-3-tablet{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3,html.theme--catppuccin-frappe .column.is-offset-3-tablet{margin-left:25%}html.theme--catppuccin-frappe .column.is-4,html.theme--catppuccin-frappe .column.is-4-tablet{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4,html.theme--catppuccin-frappe .column.is-offset-4-tablet{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5,html.theme--catppuccin-frappe .column.is-5-tablet{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5,html.theme--catppuccin-frappe .column.is-offset-5-tablet{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6,html.theme--catppuccin-frappe .column.is-6-tablet{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6,html.theme--catppuccin-frappe .column.is-offset-6-tablet{margin-left:50%}html.theme--catppuccin-frappe .column.is-7,html.theme--catppuccin-frappe .column.is-7-tablet{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7,html.theme--catppuccin-frappe .column.is-offset-7-tablet{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8,html.theme--catppuccin-frappe .column.is-8-tablet{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8,html.theme--catppuccin-frappe .column.is-offset-8-tablet{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9,html.theme--catppuccin-frappe .column.is-9-tablet{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9,html.theme--catppuccin-frappe .column.is-offset-9-tablet{margin-left:75%}html.theme--catppuccin-frappe .column.is-10,html.theme--catppuccin-frappe .column.is-10-tablet{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10,html.theme--catppuccin-frappe .column.is-offset-10-tablet{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11,html.theme--catppuccin-frappe .column.is-11-tablet{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11,html.theme--catppuccin-frappe .column.is-offset-11-tablet{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12,html.theme--catppuccin-frappe .column.is-12-tablet{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12,html.theme--catppuccin-frappe .column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .column.is-narrow-touch{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full-touch{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters-touch{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds-touch{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half-touch{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third-touch{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter-touch{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth-touch{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths-touch{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths-touch{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths-touch{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters-touch{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds-touch{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half-touch{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third-touch{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter-touch{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth-touch{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths-touch{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths-touch{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths-touch{margin-left:80%}html.theme--catppuccin-frappe .column.is-0-touch{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0-touch{margin-left:0%}html.theme--catppuccin-frappe .column.is-1-touch{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1-touch{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2-touch{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2-touch{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3-touch{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3-touch{margin-left:25%}html.theme--catppuccin-frappe .column.is-4-touch{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4-touch{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5-touch{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5-touch{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6-touch{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6-touch{margin-left:50%}html.theme--catppuccin-frappe .column.is-7-touch{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7-touch{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8-touch{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8-touch{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9-touch{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9-touch{margin-left:75%}html.theme--catppuccin-frappe .column.is-10-touch{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10-touch{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11-touch{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11-touch{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12-touch{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .column.is-narrow-desktop{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full-desktop{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters-desktop{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds-desktop{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half-desktop{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third-desktop{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter-desktop{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth-desktop{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths-desktop{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths-desktop{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths-desktop{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters-desktop{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds-desktop{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half-desktop{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third-desktop{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter-desktop{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth-desktop{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths-desktop{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths-desktop{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths-desktop{margin-left:80%}html.theme--catppuccin-frappe .column.is-0-desktop{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0-desktop{margin-left:0%}html.theme--catppuccin-frappe .column.is-1-desktop{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1-desktop{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2-desktop{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2-desktop{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3-desktop{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3-desktop{margin-left:25%}html.theme--catppuccin-frappe .column.is-4-desktop{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4-desktop{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5-desktop{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5-desktop{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6-desktop{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6-desktop{margin-left:50%}html.theme--catppuccin-frappe .column.is-7-desktop{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7-desktop{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8-desktop{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8-desktop{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9-desktop{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9-desktop{margin-left:75%}html.theme--catppuccin-frappe .column.is-10-desktop{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10-desktop{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11-desktop{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11-desktop{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12-desktop{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .column.is-narrow-widescreen{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full-widescreen{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters-widescreen{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds-widescreen{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half-widescreen{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third-widescreen{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter-widescreen{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth-widescreen{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths-widescreen{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths-widescreen{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths-widescreen{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters-widescreen{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds-widescreen{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half-widescreen{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third-widescreen{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter-widescreen{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth-widescreen{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths-widescreen{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths-widescreen{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths-widescreen{margin-left:80%}html.theme--catppuccin-frappe .column.is-0-widescreen{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0-widescreen{margin-left:0%}html.theme--catppuccin-frappe .column.is-1-widescreen{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1-widescreen{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2-widescreen{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2-widescreen{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3-widescreen{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3-widescreen{margin-left:25%}html.theme--catppuccin-frappe .column.is-4-widescreen{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4-widescreen{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5-widescreen{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5-widescreen{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6-widescreen{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6-widescreen{margin-left:50%}html.theme--catppuccin-frappe .column.is-7-widescreen{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7-widescreen{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8-widescreen{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8-widescreen{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9-widescreen{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9-widescreen{margin-left:75%}html.theme--catppuccin-frappe .column.is-10-widescreen{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10-widescreen{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11-widescreen{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11-widescreen{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12-widescreen{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .column.is-narrow-fullhd{flex:none;width:unset}html.theme--catppuccin-frappe .column.is-full-fullhd{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-three-quarters-fullhd{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-two-thirds-fullhd{flex:none;width:66.6666%}html.theme--catppuccin-frappe .column.is-half-fullhd{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-one-third-fullhd{flex:none;width:33.3333%}html.theme--catppuccin-frappe .column.is-one-quarter-fullhd{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-one-fifth-fullhd{flex:none;width:20%}html.theme--catppuccin-frappe .column.is-two-fifths-fullhd{flex:none;width:40%}html.theme--catppuccin-frappe .column.is-three-fifths-fullhd{flex:none;width:60%}html.theme--catppuccin-frappe .column.is-four-fifths-fullhd{flex:none;width:80%}html.theme--catppuccin-frappe .column.is-offset-three-quarters-fullhd{margin-left:75%}html.theme--catppuccin-frappe .column.is-offset-two-thirds-fullhd{margin-left:66.6666%}html.theme--catppuccin-frappe .column.is-offset-half-fullhd{margin-left:50%}html.theme--catppuccin-frappe .column.is-offset-one-third-fullhd{margin-left:33.3333%}html.theme--catppuccin-frappe .column.is-offset-one-quarter-fullhd{margin-left:25%}html.theme--catppuccin-frappe .column.is-offset-one-fifth-fullhd{margin-left:20%}html.theme--catppuccin-frappe .column.is-offset-two-fifths-fullhd{margin-left:40%}html.theme--catppuccin-frappe .column.is-offset-three-fifths-fullhd{margin-left:60%}html.theme--catppuccin-frappe .column.is-offset-four-fifths-fullhd{margin-left:80%}html.theme--catppuccin-frappe .column.is-0-fullhd{flex:none;width:0%}html.theme--catppuccin-frappe .column.is-offset-0-fullhd{margin-left:0%}html.theme--catppuccin-frappe .column.is-1-fullhd{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .column.is-offset-1-fullhd{margin-left:8.33333337%}html.theme--catppuccin-frappe .column.is-2-fullhd{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .column.is-offset-2-fullhd{margin-left:16.66666674%}html.theme--catppuccin-frappe .column.is-3-fullhd{flex:none;width:25%}html.theme--catppuccin-frappe .column.is-offset-3-fullhd{margin-left:25%}html.theme--catppuccin-frappe .column.is-4-fullhd{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .column.is-offset-4-fullhd{margin-left:33.33333337%}html.theme--catppuccin-frappe .column.is-5-fullhd{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .column.is-offset-5-fullhd{margin-left:41.66666674%}html.theme--catppuccin-frappe .column.is-6-fullhd{flex:none;width:50%}html.theme--catppuccin-frappe .column.is-offset-6-fullhd{margin-left:50%}html.theme--catppuccin-frappe .column.is-7-fullhd{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .column.is-offset-7-fullhd{margin-left:58.33333337%}html.theme--catppuccin-frappe .column.is-8-fullhd{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .column.is-offset-8-fullhd{margin-left:66.66666674%}html.theme--catppuccin-frappe .column.is-9-fullhd{flex:none;width:75%}html.theme--catppuccin-frappe .column.is-offset-9-fullhd{margin-left:75%}html.theme--catppuccin-frappe .column.is-10-fullhd{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .column.is-offset-10-fullhd{margin-left:83.33333337%}html.theme--catppuccin-frappe .column.is-11-fullhd{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .column.is-offset-11-fullhd{margin-left:91.66666674%}html.theme--catppuccin-frappe .column.is-12-fullhd{flex:none;width:100%}html.theme--catppuccin-frappe .column.is-offset-12-fullhd{margin-left:100%}}html.theme--catppuccin-frappe .columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-frappe .columns:last-child{margin-bottom:-.75rem}html.theme--catppuccin-frappe .columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}html.theme--catppuccin-frappe .columns.is-centered{justify-content:center}html.theme--catppuccin-frappe .columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}html.theme--catppuccin-frappe .columns.is-gapless>.column{margin:0;padding:0 !important}html.theme--catppuccin-frappe .columns.is-gapless:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-frappe .columns.is-gapless:last-child{margin-bottom:0}html.theme--catppuccin-frappe .columns.is-mobile{display:flex}html.theme--catppuccin-frappe .columns.is-multiline{flex-wrap:wrap}html.theme--catppuccin-frappe .columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-desktop{display:flex}}html.theme--catppuccin-frappe .columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}html.theme--catppuccin-frappe .columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}html.theme--catppuccin-frappe .columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-0-fullhd{--columnGap: 0rem}}html.theme--catppuccin-frappe .columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-1-fullhd{--columnGap: .25rem}}html.theme--catppuccin-frappe .columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-2-fullhd{--columnGap: .5rem}}html.theme--catppuccin-frappe .columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-3-fullhd{--columnGap: .75rem}}html.theme--catppuccin-frappe .columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-4-fullhd{--columnGap: 1rem}}html.theme--catppuccin-frappe .columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}html.theme--catppuccin-frappe .columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}html.theme--catppuccin-frappe .columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}html.theme--catppuccin-frappe .columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-frappe .columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-frappe .columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-frappe .columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-frappe .columns.is-variable.is-8-fullhd{--columnGap: 2rem}}html.theme--catppuccin-frappe .tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}html.theme--catppuccin-frappe .tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-frappe .tile.is-ancestor:last-child{margin-bottom:-.75rem}html.theme--catppuccin-frappe .tile.is-ancestor:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-frappe .tile.is-child{margin:0 !important}html.theme--catppuccin-frappe .tile.is-parent{padding:.75rem}html.theme--catppuccin-frappe .tile.is-vertical{flex-direction:column}html.theme--catppuccin-frappe .tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .tile:not(.is-child){display:flex}html.theme--catppuccin-frappe .tile.is-1{flex:none;width:8.33333337%}html.theme--catppuccin-frappe .tile.is-2{flex:none;width:16.66666674%}html.theme--catppuccin-frappe .tile.is-3{flex:none;width:25%}html.theme--catppuccin-frappe .tile.is-4{flex:none;width:33.33333337%}html.theme--catppuccin-frappe .tile.is-5{flex:none;width:41.66666674%}html.theme--catppuccin-frappe .tile.is-6{flex:none;width:50%}html.theme--catppuccin-frappe .tile.is-7{flex:none;width:58.33333337%}html.theme--catppuccin-frappe .tile.is-8{flex:none;width:66.66666674%}html.theme--catppuccin-frappe .tile.is-9{flex:none;width:75%}html.theme--catppuccin-frappe .tile.is-10{flex:none;width:83.33333337%}html.theme--catppuccin-frappe .tile.is-11{flex:none;width:91.66666674%}html.theme--catppuccin-frappe .tile.is-12{flex:none;width:100%}}html.theme--catppuccin-frappe .hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}html.theme--catppuccin-frappe .hero .navbar{background:none}html.theme--catppuccin-frappe .hero .tabs ul{border-bottom:none}html.theme--catppuccin-frappe .hero.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-white strong{color:inherit}html.theme--catppuccin-frappe .hero.is-white .title{color:#0a0a0a}html.theme--catppuccin-frappe .hero.is-white .subtitle{color:rgba(10,10,10,0.9)}html.theme--catppuccin-frappe .hero.is-white .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-white .navbar-menu{background-color:#fff}}html.theme--catppuccin-frappe .hero.is-white .navbar-item,html.theme--catppuccin-frappe .hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}html.theme--catppuccin-frappe .hero.is-white a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-white a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-white .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-frappe .hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}html.theme--catppuccin-frappe .hero.is-white .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}html.theme--catppuccin-frappe .hero.is-white .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-white .tabs.is-toggle a{color:#0a0a0a}html.theme--catppuccin-frappe .hero.is-white .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-white .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-white .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-white .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}html.theme--catppuccin-frappe .hero.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-frappe .hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-black strong{color:inherit}html.theme--catppuccin-frappe .hero.is-black .title{color:#fff}html.theme--catppuccin-frappe .hero.is-black .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-frappe .hero.is-black .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-black .navbar-menu{background-color:#0a0a0a}}html.theme--catppuccin-frappe .hero.is-black .navbar-item,html.theme--catppuccin-frappe .hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-frappe .hero.is-black a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-black a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-black .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-frappe .hero.is-black .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-frappe .hero.is-black .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}html.theme--catppuccin-frappe .hero.is-black .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-black .tabs.is-toggle a{color:#fff}html.theme--catppuccin-frappe .hero.is-black .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-black .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-black .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-black .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-frappe .hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}html.theme--catppuccin-frappe .hero.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-light strong{color:inherit}html.theme--catppuccin-frappe .hero.is-light .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-light .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-frappe .hero.is-light .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-light .navbar-menu{background-color:#f5f5f5}}html.theme--catppuccin-frappe .hero.is-light .navbar-item,html.theme--catppuccin-frappe .hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-light a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-light a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-light .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-light .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-frappe .hero.is-light .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-light .tabs li.is-active a{color:#f5f5f5 !important;opacity:1}html.theme--catppuccin-frappe .hero.is-light .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-light .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-light .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-light .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-light .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-frappe .hero.is-light.is-bold{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}}html.theme--catppuccin-frappe .hero.is-dark,html.theme--catppuccin-frappe .content kbd.hero{background-color:#414559;color:#fff}html.theme--catppuccin-frappe .hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-dark strong,html.theme--catppuccin-frappe .content kbd.hero strong{color:inherit}html.theme--catppuccin-frappe .hero.is-dark .title,html.theme--catppuccin-frappe .content kbd.hero .title{color:#fff}html.theme--catppuccin-frappe .hero.is-dark .subtitle,html.theme--catppuccin-frappe .content kbd.hero .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-frappe .hero.is-dark .subtitle a:not(.button),html.theme--catppuccin-frappe .content kbd.hero .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-dark .subtitle strong,html.theme--catppuccin-frappe .content kbd.hero .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-dark .navbar-menu,html.theme--catppuccin-frappe .content kbd.hero .navbar-menu{background-color:#414559}}html.theme--catppuccin-frappe .hero.is-dark .navbar-item,html.theme--catppuccin-frappe .content kbd.hero .navbar-item,html.theme--catppuccin-frappe .hero.is-dark .navbar-link,html.theme--catppuccin-frappe .content kbd.hero .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-frappe .hero.is-dark a.navbar-item:hover,html.theme--catppuccin-frappe .content kbd.hero a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-dark a.navbar-item.is-active,html.theme--catppuccin-frappe .content kbd.hero a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-dark .navbar-link:hover,html.theme--catppuccin-frappe .content kbd.hero .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-dark .navbar-link.is-active,html.theme--catppuccin-frappe .content kbd.hero .navbar-link.is-active{background-color:#363a4a;color:#fff}html.theme--catppuccin-frappe .hero.is-dark .tabs a,html.theme--catppuccin-frappe .content kbd.hero .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-frappe .hero.is-dark .tabs a:hover,html.theme--catppuccin-frappe .content kbd.hero .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-dark .tabs li.is-active a,html.theme--catppuccin-frappe .content kbd.hero .tabs li.is-active a{color:#414559 !important;opacity:1}html.theme--catppuccin-frappe .hero.is-dark .tabs.is-boxed a,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-dark .tabs.is-toggle a,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-toggle a{color:#fff}html.theme--catppuccin-frappe .hero.is-dark .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-dark .tabs.is-toggle a:hover,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-dark .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-dark .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-dark .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .content kbd.hero .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#414559}html.theme--catppuccin-frappe .hero.is-dark.is-bold,html.theme--catppuccin-frappe .content kbd.hero.is-bold{background-image:linear-gradient(141deg, #262f41 0%, #414559 71%, #47476c 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-dark.is-bold .navbar-menu,html.theme--catppuccin-frappe .content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #262f41 0%, #414559 71%, #47476c 100%)}}html.theme--catppuccin-frappe .hero.is-primary,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-primary strong,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink strong{color:inherit}html.theme--catppuccin-frappe .hero.is-primary .title,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .title{color:#fff}html.theme--catppuccin-frappe .hero.is-primary .subtitle,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-frappe .hero.is-primary .subtitle a:not(.button),html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-primary .subtitle strong,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-primary .navbar-menu,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#8caaee}}html.theme--catppuccin-frappe .hero.is-primary .navbar-item,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .navbar-item,html.theme--catppuccin-frappe .hero.is-primary .navbar-link,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-frappe .hero.is-primary a.navbar-item:hover,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-primary a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-primary .navbar-link:hover,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-primary .navbar-link.is-active,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .hero.is-primary .tabs a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-frappe .hero.is-primary .tabs a:hover,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-primary .tabs li.is-active a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#8caaee !important;opacity:1}html.theme--catppuccin-frappe .hero.is-primary .tabs.is-boxed a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-primary .tabs.is-toggle a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}html.theme--catppuccin-frappe .hero.is-primary .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-primary .tabs.is-toggle a:hover,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-primary .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-primary .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-primary .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .hero.is-primary.is-bold,html.theme--catppuccin-frappe .docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #569ff1 0%, #8caaee 71%, #a0abf4 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-primary.is-bold .navbar-menu,html.theme--catppuccin-frappe .docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #569ff1 0%, #8caaee 71%, #a0abf4 100%)}}html.theme--catppuccin-frappe .hero.is-link{background-color:#8caaee;color:#fff}html.theme--catppuccin-frappe .hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-link strong{color:inherit}html.theme--catppuccin-frappe .hero.is-link .title{color:#fff}html.theme--catppuccin-frappe .hero.is-link .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-frappe .hero.is-link .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-link .navbar-menu{background-color:#8caaee}}html.theme--catppuccin-frappe .hero.is-link .navbar-item,html.theme--catppuccin-frappe .hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-frappe .hero.is-link a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-link a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-link .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-link .navbar-link.is-active{background-color:#769aeb;color:#fff}html.theme--catppuccin-frappe .hero.is-link .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-frappe .hero.is-link .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-link .tabs li.is-active a{color:#8caaee !important;opacity:1}html.theme--catppuccin-frappe .hero.is-link .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-link .tabs.is-toggle a{color:#fff}html.theme--catppuccin-frappe .hero.is-link .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-link .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-link .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-link .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#8caaee}html.theme--catppuccin-frappe .hero.is-link.is-bold{background-image:linear-gradient(141deg, #569ff1 0%, #8caaee 71%, #a0abf4 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #569ff1 0%, #8caaee 71%, #a0abf4 100%)}}html.theme--catppuccin-frappe .hero.is-info{background-color:#81c8be;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-info strong{color:inherit}html.theme--catppuccin-frappe .hero.is-info .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-info .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-frappe .hero.is-info .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-info .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-info .navbar-menu{background-color:#81c8be}}html.theme--catppuccin-frappe .hero.is-info .navbar-item,html.theme--catppuccin-frappe .hero.is-info .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-info a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-info a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-info .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-info .navbar-link.is-active{background-color:#6fc0b5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-info .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-frappe .hero.is-info .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-info .tabs li.is-active a{color:#81c8be !important;opacity:1}html.theme--catppuccin-frappe .hero.is-info .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-info .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-info .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-info .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-info .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-info .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#81c8be}html.theme--catppuccin-frappe .hero.is-info.is-bold{background-image:linear-gradient(141deg, #52c4a1 0%, #81c8be 71%, #8fd2d4 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #52c4a1 0%, #81c8be 71%, #8fd2d4 100%)}}html.theme--catppuccin-frappe .hero.is-success{background-color:#a6d189;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-success strong{color:inherit}html.theme--catppuccin-frappe .hero.is-success .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-success .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-frappe .hero.is-success .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-success .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-success .navbar-menu{background-color:#a6d189}}html.theme--catppuccin-frappe .hero.is-success .navbar-item,html.theme--catppuccin-frappe .hero.is-success .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-success a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-success a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-success .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-success .navbar-link.is-active{background-color:#98ca77;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-success .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-frappe .hero.is-success .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-success .tabs li.is-active a{color:#a6d189 !important;opacity:1}html.theme--catppuccin-frappe .hero.is-success .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-success .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-success .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-success .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-success .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-success .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#a6d189}html.theme--catppuccin-frappe .hero.is-success.is-bold{background-image:linear-gradient(141deg, #9ccd5a 0%, #a6d189 71%, #a8dc98 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #9ccd5a 0%, #a6d189 71%, #a8dc98 100%)}}html.theme--catppuccin-frappe .hero.is-warning{background-color:#e5c890;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-warning strong{color:inherit}html.theme--catppuccin-frappe .hero.is-warning .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-warning .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-frappe .hero.is-warning .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-warning .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-warning .navbar-menu{background-color:#e5c890}}html.theme--catppuccin-frappe .hero.is-warning .navbar-item,html.theme--catppuccin-frappe .hero.is-warning .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-warning a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-warning a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-warning .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-warning .navbar-link.is-active{background-color:#e0be7b;color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-warning .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-frappe .hero.is-warning .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-warning .tabs li.is-active a{color:#e5c890 !important;opacity:1}html.theme--catppuccin-frappe .hero.is-warning .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-warning .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-frappe .hero.is-warning .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-warning .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-warning .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-warning .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#e5c890}html.theme--catppuccin-frappe .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #e5a05d 0%, #e5c890 71%, #ede0a2 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e5a05d 0%, #e5c890 71%, #ede0a2 100%)}}html.theme--catppuccin-frappe .hero.is-danger{background-color:#e78284;color:#fff}html.theme--catppuccin-frappe .hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-frappe .hero.is-danger strong{color:inherit}html.theme--catppuccin-frappe .hero.is-danger .title{color:#fff}html.theme--catppuccin-frappe .hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-frappe .hero.is-danger .subtitle a:not(.button),html.theme--catppuccin-frappe .hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .hero.is-danger .navbar-menu{background-color:#e78284}}html.theme--catppuccin-frappe .hero.is-danger .navbar-item,html.theme--catppuccin-frappe .hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-frappe .hero.is-danger a.navbar-item:hover,html.theme--catppuccin-frappe .hero.is-danger a.navbar-item.is-active,html.theme--catppuccin-frappe .hero.is-danger .navbar-link:hover,html.theme--catppuccin-frappe .hero.is-danger .navbar-link.is-active{background-color:#e36d6f;color:#fff}html.theme--catppuccin-frappe .hero.is-danger .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-frappe .hero.is-danger .tabs a:hover{opacity:1}html.theme--catppuccin-frappe .hero.is-danger .tabs li.is-active a{color:#e78284 !important;opacity:1}html.theme--catppuccin-frappe .hero.is-danger .tabs.is-boxed a,html.theme--catppuccin-frappe .hero.is-danger .tabs.is-toggle a{color:#fff}html.theme--catppuccin-frappe .hero.is-danger .tabs.is-boxed a:hover,html.theme--catppuccin-frappe .hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-frappe .hero.is-danger .tabs.is-boxed li.is-active a,html.theme--catppuccin-frappe .hero.is-danger .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-frappe .hero.is-danger .tabs.is-toggle li.is-active a,html.theme--catppuccin-frappe .hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#e78284}html.theme--catppuccin-frappe .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #e94d6a 0%, #e78284 71%, #eea294 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e94d6a 0%, #e78284 71%, #eea294 100%)}}html.theme--catppuccin-frappe .hero.is-small .hero-body,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .hero.is-large .hero-body{padding:18rem 6rem}}html.theme--catppuccin-frappe .hero.is-halfheight .hero-body,html.theme--catppuccin-frappe .hero.is-fullheight .hero-body,html.theme--catppuccin-frappe .hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}html.theme--catppuccin-frappe .hero.is-halfheight .hero-body>.container,html.theme--catppuccin-frappe .hero.is-fullheight .hero-body>.container,html.theme--catppuccin-frappe .hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}html.theme--catppuccin-frappe .hero.is-halfheight{min-height:50vh}html.theme--catppuccin-frappe .hero.is-fullheight{min-height:100vh}html.theme--catppuccin-frappe .hero-video{overflow:hidden}html.theme--catppuccin-frappe .hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}html.theme--catppuccin-frappe .hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero-video{display:none}}html.theme--catppuccin-frappe .hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-frappe .hero-buttons .button{display:flex}html.theme--catppuccin-frappe .hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .hero-buttons{display:flex;justify-content:center}html.theme--catppuccin-frappe .hero-buttons .button:not(:last-child){margin-right:1.5rem}}html.theme--catppuccin-frappe .hero-head,html.theme--catppuccin-frappe .hero-foot{flex-grow:0;flex-shrink:0}html.theme--catppuccin-frappe .hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-frappe .hero-body{padding:3rem 3rem}}html.theme--catppuccin-frappe .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe .section{padding:3rem 3rem}html.theme--catppuccin-frappe .section.is-medium{padding:9rem 4.5rem}html.theme--catppuccin-frappe .section.is-large{padding:18rem 6rem}}html.theme--catppuccin-frappe .footer{background-color:#292c3c;padding:3rem 1.5rem 6rem}html.theme--catppuccin-frappe h1 .docs-heading-anchor,html.theme--catppuccin-frappe h1 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h1 .docs-heading-anchor:visited,html.theme--catppuccin-frappe h2 .docs-heading-anchor,html.theme--catppuccin-frappe h2 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h2 .docs-heading-anchor:visited,html.theme--catppuccin-frappe h3 .docs-heading-anchor,html.theme--catppuccin-frappe h3 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h3 .docs-heading-anchor:visited,html.theme--catppuccin-frappe h4 .docs-heading-anchor,html.theme--catppuccin-frappe h4 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h4 .docs-heading-anchor:visited,html.theme--catppuccin-frappe h5 .docs-heading-anchor,html.theme--catppuccin-frappe h5 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h5 .docs-heading-anchor:visited,html.theme--catppuccin-frappe h6 .docs-heading-anchor,html.theme--catppuccin-frappe h6 .docs-heading-anchor:hover,html.theme--catppuccin-frappe h6 .docs-heading-anchor:visited{color:#c6d0f5}html.theme--catppuccin-frappe h1 .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h2 .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h3 .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h4 .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h5 .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}html.theme--catppuccin-frappe h1 .docs-heading-anchor-permalink::before,html.theme--catppuccin-frappe h2 .docs-heading-anchor-permalink::before,html.theme--catppuccin-frappe h3 .docs-heading-anchor-permalink::before,html.theme--catppuccin-frappe h4 .docs-heading-anchor-permalink::before,html.theme--catppuccin-frappe h5 .docs-heading-anchor-permalink::before,html.theme--catppuccin-frappe h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}html.theme--catppuccin-frappe h1:hover .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h2:hover .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h3:hover .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h4:hover .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h5:hover .docs-heading-anchor-permalink,html.theme--catppuccin-frappe h6:hover .docs-heading-anchor-permalink{visibility:visible}html.theme--catppuccin-frappe .docs-light-only{display:none !important}html.theme--catppuccin-frappe pre{position:relative;overflow:hidden}html.theme--catppuccin-frappe pre code,html.theme--catppuccin-frappe pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}html.theme--catppuccin-frappe pre code:first-of-type,html.theme--catppuccin-frappe pre code.hljs:first-of-type{padding-top:0.5rem !important}html.theme--catppuccin-frappe pre code:last-of-type,html.theme--catppuccin-frappe pre code.hljs:last-of-type{padding-bottom:0.5rem !important}html.theme--catppuccin-frappe pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#c6d0f5;cursor:pointer;text-align:center}html.theme--catppuccin-frappe pre .copy-button:focus,html.theme--catppuccin-frappe pre .copy-button:hover{opacity:1;background:rgba(198,208,245,0.1);color:#8caaee}html.theme--catppuccin-frappe pre .copy-button.success{color:#a6d189;opacity:1}html.theme--catppuccin-frappe pre .copy-button.error{color:#e78284;opacity:1}html.theme--catppuccin-frappe pre:hover .copy-button{opacity:1}html.theme--catppuccin-frappe .admonition{background-color:#292c3c;border-style:solid;border-width:2px;border-color:#b5bfe2;border-radius:4px;font-size:1rem}html.theme--catppuccin-frappe .admonition strong{color:currentColor}html.theme--catppuccin-frappe .admonition.is-small,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}html.theme--catppuccin-frappe .admonition.is-medium{font-size:1.25rem}html.theme--catppuccin-frappe .admonition.is-large{font-size:1.5rem}html.theme--catppuccin-frappe .admonition.is-default{background-color:#292c3c;border-color:#b5bfe2}html.theme--catppuccin-frappe .admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#b5bfe2}html.theme--catppuccin-frappe .admonition.is-default>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition.is-info{background-color:#292c3c;border-color:#81c8be}html.theme--catppuccin-frappe .admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#81c8be}html.theme--catppuccin-frappe .admonition.is-info>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition.is-success{background-color:#292c3c;border-color:#a6d189}html.theme--catppuccin-frappe .admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#a6d189}html.theme--catppuccin-frappe .admonition.is-success>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition.is-warning{background-color:#292c3c;border-color:#e5c890}html.theme--catppuccin-frappe .admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#e5c890}html.theme--catppuccin-frappe .admonition.is-warning>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition.is-danger{background-color:#292c3c;border-color:#e78284}html.theme--catppuccin-frappe .admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#e78284}html.theme--catppuccin-frappe .admonition.is-danger>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition.is-compat{background-color:#292c3c;border-color:#99d1db}html.theme--catppuccin-frappe .admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#99d1db}html.theme--catppuccin-frappe .admonition.is-compat>.admonition-body{color:#c6d0f5}html.theme--catppuccin-frappe .admonition-header{color:#b5bfe2;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}html.theme--catppuccin-frappe .admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}html.theme--catppuccin-frappe details.admonition.is-details>.admonition-header{list-style:none}html.theme--catppuccin-frappe details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}html.theme--catppuccin-frappe details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}html.theme--catppuccin-frappe .admonition-body{color:#c6d0f5;padding:0.5rem .75rem}html.theme--catppuccin-frappe .admonition-body pre{background-color:#292c3c}html.theme--catppuccin-frappe .admonition-body code{background-color:#292c3c}html.theme--catppuccin-frappe .docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #626880;border-radius:4px;box-shadow:none;max-width:100%}html.theme--catppuccin-frappe .docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#292c3c;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #626880;overflow:auto}html.theme--catppuccin-frappe .docstring>header code{background-color:transparent}html.theme--catppuccin-frappe .docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}html.theme--catppuccin-frappe .docstring>header .docstring-binding{margin-right:0.3em}html.theme--catppuccin-frappe .docstring>header .docstring-category{margin-left:0.3em}html.theme--catppuccin-frappe .docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #626880}html.theme--catppuccin-frappe .docstring>section:last-child{border-bottom:none}html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:focus{opacity:1 !important}html.theme--catppuccin-frappe .docstring:hover>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-frappe .docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-frappe .docstring>section:hover a.docs-sourcelink{opacity:1}html.theme--catppuccin-frappe .documenter-example-output{background-color:#303446}html.theme--catppuccin-frappe .outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#292c3c;color:#c6d0f5;border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}html.theme--catppuccin-frappe .outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}html.theme--catppuccin-frappe .outdated-warning-overlay a{color:#8caaee}html.theme--catppuccin-frappe .outdated-warning-overlay a:hover{color:#99d1db}html.theme--catppuccin-frappe .content pre{border:2px solid #626880;border-radius:4px}html.theme--catppuccin-frappe .content code{font-weight:inherit}html.theme--catppuccin-frappe .content a code{color:#8caaee}html.theme--catppuccin-frappe .content a:hover code{color:#99d1db}html.theme--catppuccin-frappe .content h1 code,html.theme--catppuccin-frappe .content h2 code,html.theme--catppuccin-frappe .content h3 code,html.theme--catppuccin-frappe .content h4 code,html.theme--catppuccin-frappe .content h5 code,html.theme--catppuccin-frappe .content h6 code{color:#c6d0f5}html.theme--catppuccin-frappe .content table{display:block;width:initial;max-width:100%;overflow-x:auto}html.theme--catppuccin-frappe .content blockquote>ul:first-child,html.theme--catppuccin-frappe .content blockquote>ol:first-child,html.theme--catppuccin-frappe .content .admonition-body>ul:first-child,html.theme--catppuccin-frappe .content .admonition-body>ol:first-child{margin-top:0}html.theme--catppuccin-frappe pre,html.theme--catppuccin-frappe code{font-variant-ligatures:no-contextual}html.theme--catppuccin-frappe .breadcrumb a.is-disabled{cursor:default;pointer-events:none}html.theme--catppuccin-frappe .breadcrumb a.is-disabled,html.theme--catppuccin-frappe .breadcrumb a.is-disabled:hover{color:#b0bef1}html.theme--catppuccin-frappe .hljs{background:initial !important}html.theme--catppuccin-frappe .katex .katex-mathml{top:0;right:0}html.theme--catppuccin-frappe .katex-display,html.theme--catppuccin-frappe mjx-container,html.theme--catppuccin-frappe .MathJax_Display{margin:0.5em 0 !important}html.theme--catppuccin-frappe html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}html.theme--catppuccin-frappe li.no-marker{list-style:none}html.theme--catppuccin-frappe #documenter .docs-main>article{overflow-wrap:break-word}html.theme--catppuccin-frappe #documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe #documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe #documenter .docs-main{width:100%}html.theme--catppuccin-frappe #documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}html.theme--catppuccin-frappe #documenter .docs-main>header,html.theme--catppuccin-frappe #documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar{background-color:#303446;border-bottom:1px solid #626880;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-right .docs-icon,html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #171717;transition-duration:0.7s;-webkit-transition-duration:0.7s}html.theme--catppuccin-frappe #documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}html.theme--catppuccin-frappe #documenter .docs-main section.footnotes{border-top:1px solid #626880}html.theme--catppuccin-frappe #documenter .docs-main section.footnotes li .tag:first-child,html.theme--catppuccin-frappe #documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,html.theme--catppuccin-frappe #documenter .docs-main section.footnotes li .content kbd:first-child,html.theme--catppuccin-frappe .content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}html.theme--catppuccin-frappe #documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #626880;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe #documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}html.theme--catppuccin-frappe #documenter .docs-main .docs-footer .docs-footer-nextpage,html.theme--catppuccin-frappe #documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}html.theme--catppuccin-frappe #documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}html.theme--catppuccin-frappe #documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}html.theme--catppuccin-frappe #documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}html.theme--catppuccin-frappe #documenter .docs-sidebar{display:flex;flex-direction:column;color:#c6d0f5;background-color:#292c3c;border-right:1px solid #626880;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}html.theme--catppuccin-frappe #documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #171717}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe #documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe #documenter .docs-sidebar{left:0;top:0}}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-package-name a,html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-package-name a:hover{color:#c6d0f5}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-version-selector{border-top:1px solid #626880;display:none;padding:0.5rem}html.theme--catppuccin-frappe #documenter .docs-sidebar .docs-version-selector.visible{display:flex}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #626880;padding-bottom:1.5rem}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #626880}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu .tocitem,html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#c6d0f5;background:#292c3c}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu a.tocitem:hover,html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#c6d0f5;background-color:#313548}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #626880;border-bottom:1px solid #626880;background-color:#232634}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#232634;color:#c6d0f5}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#313548;color:#c6d0f5}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #626880}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input{width:14.4rem}html.theme--catppuccin-frappe #documenter .docs-sidebar #documenter-search-query{color:#868c98;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#3a3e54}html.theme--catppuccin-frappe #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#4a506c}}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe #documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-frappe #documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-frappe #documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#3a3e54}html.theme--catppuccin-frappe #documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#4a506c}}html.theme--catppuccin-frappe kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(245,245,245,0.6);box-shadow:0 2px 0 1px rgba(245,245,245,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}html.theme--catppuccin-frappe .search-min-width-50{min-width:50%}html.theme--catppuccin-frappe .search-min-height-100{min-height:100%}html.theme--catppuccin-frappe .search-modal-card-body{max-height:calc(100vh - 15rem)}html.theme--catppuccin-frappe .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-frappe .search-result-link:hover,html.theme--catppuccin-frappe .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--catppuccin-frappe .search-result-link .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-frappe .property-search-result-badge,html.theme--catppuccin-frappe .search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}html.theme--catppuccin-frappe .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link:hover .search-filter,html.theme--catppuccin-frappe .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link:focus .search-filter{color:#333;background-color:#f1f5f9}html.theme--catppuccin-frappe .search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}html.theme--catppuccin-frappe .search-filter:hover,html.theme--catppuccin-frappe .search-filter:focus{color:#333}html.theme--catppuccin-frappe .search-filter-selected{color:#414559;background-color:#babbf1}html.theme--catppuccin-frappe .search-filter-selected:hover,html.theme--catppuccin-frappe .search-filter-selected:focus{color:#414559}html.theme--catppuccin-frappe .search-result-highlight{background-color:#ffdd57;color:black}html.theme--catppuccin-frappe .search-divider{border-bottom:1px solid #626880}html.theme--catppuccin-frappe .search-result-title{width:85%;color:#f5f5f5}html.theme--catppuccin-frappe .search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-frappe #search-modal .modal-card-body::-webkit-scrollbar,html.theme--catppuccin-frappe #search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}html.theme--catppuccin-frappe #search-modal .modal-card-body::-webkit-scrollbar-thumb,html.theme--catppuccin-frappe #search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}html.theme--catppuccin-frappe #search-modal .modal-card-body::-webkit-scrollbar-track,html.theme--catppuccin-frappe #search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}html.theme--catppuccin-frappe .w-100{width:100%}html.theme--catppuccin-frappe .gap-2{gap:0.5rem}html.theme--catppuccin-frappe .gap-4{gap:1rem}html.theme--catppuccin-frappe .gap-8{gap:2rem}html.theme--catppuccin-frappe{background-color:#303446;font-size:16px;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-frappe a{transition:all 200ms ease}html.theme--catppuccin-frappe .label{color:#c6d0f5}html.theme--catppuccin-frappe .button,html.theme--catppuccin-frappe .control.has-icons-left .icon,html.theme--catppuccin-frappe .control.has-icons-right .icon,html.theme--catppuccin-frappe .input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe .pagination-ellipsis,html.theme--catppuccin-frappe .pagination-link,html.theme--catppuccin-frappe .pagination-next,html.theme--catppuccin-frappe .pagination-previous,html.theme--catppuccin-frappe .select,html.theme--catppuccin-frappe .select select,html.theme--catppuccin-frappe .textarea{height:2.5em;color:#c6d0f5}html.theme--catppuccin-frappe .input,html.theme--catppuccin-frappe #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-frappe .textarea{transition:all 200ms ease;box-shadow:none;border-width:1px;padding-left:1em;padding-right:1em;color:#c6d0f5}html.theme--catppuccin-frappe .select:after,html.theme--catppuccin-frappe .select select{border-width:1px}html.theme--catppuccin-frappe .menu-list a{transition:all 300ms ease}html.theme--catppuccin-frappe .modal-card-foot,html.theme--catppuccin-frappe .modal-card-head{border-color:#626880}html.theme--catppuccin-frappe .navbar{border-radius:.4em}html.theme--catppuccin-frappe .navbar.is-transparent{background:none}html.theme--catppuccin-frappe .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-frappe .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#8caaee}@media screen and (max-width: 1055px){html.theme--catppuccin-frappe .navbar .navbar-menu{background-color:#8caaee;border-radius:0 0 .4em .4em}}html.theme--catppuccin-frappe .docstring>section>a.docs-sourcelink:not(body){color:#414559}html.theme--catppuccin-frappe .tag.is-link:not(body),html.theme--catppuccin-frappe .docstring>section>a.is-link.docs-sourcelink:not(body),html.theme--catppuccin-frappe .content kbd.is-link:not(body){color:#414559}html.theme--catppuccin-frappe .ansi span.sgr1{font-weight:bolder}html.theme--catppuccin-frappe .ansi span.sgr2{font-weight:lighter}html.theme--catppuccin-frappe .ansi span.sgr3{font-style:italic}html.theme--catppuccin-frappe .ansi span.sgr4{text-decoration:underline}html.theme--catppuccin-frappe .ansi span.sgr7{color:#303446;background-color:#c6d0f5}html.theme--catppuccin-frappe .ansi span.sgr8{color:transparent}html.theme--catppuccin-frappe .ansi span.sgr8 span{color:transparent}html.theme--catppuccin-frappe .ansi span.sgr9{text-decoration:line-through}html.theme--catppuccin-frappe .ansi span.sgr30{color:#51576d}html.theme--catppuccin-frappe .ansi span.sgr31{color:#e78284}html.theme--catppuccin-frappe .ansi span.sgr32{color:#a6d189}html.theme--catppuccin-frappe .ansi span.sgr33{color:#e5c890}html.theme--catppuccin-frappe .ansi span.sgr34{color:#8caaee}html.theme--catppuccin-frappe .ansi span.sgr35{color:#f4b8e4}html.theme--catppuccin-frappe .ansi span.sgr36{color:#81c8be}html.theme--catppuccin-frappe .ansi span.sgr37{color:#b5bfe2}html.theme--catppuccin-frappe .ansi span.sgr40{background-color:#51576d}html.theme--catppuccin-frappe .ansi span.sgr41{background-color:#e78284}html.theme--catppuccin-frappe .ansi span.sgr42{background-color:#a6d189}html.theme--catppuccin-frappe .ansi span.sgr43{background-color:#e5c890}html.theme--catppuccin-frappe .ansi span.sgr44{background-color:#8caaee}html.theme--catppuccin-frappe .ansi span.sgr45{background-color:#f4b8e4}html.theme--catppuccin-frappe .ansi span.sgr46{background-color:#81c8be}html.theme--catppuccin-frappe .ansi span.sgr47{background-color:#b5bfe2}html.theme--catppuccin-frappe .ansi span.sgr90{color:#626880}html.theme--catppuccin-frappe .ansi span.sgr91{color:#e78284}html.theme--catppuccin-frappe .ansi span.sgr92{color:#a6d189}html.theme--catppuccin-frappe .ansi span.sgr93{color:#e5c890}html.theme--catppuccin-frappe .ansi span.sgr94{color:#8caaee}html.theme--catppuccin-frappe .ansi span.sgr95{color:#f4b8e4}html.theme--catppuccin-frappe .ansi span.sgr96{color:#81c8be}html.theme--catppuccin-frappe .ansi span.sgr97{color:#a5adce}html.theme--catppuccin-frappe .ansi span.sgr100{background-color:#626880}html.theme--catppuccin-frappe .ansi span.sgr101{background-color:#e78284}html.theme--catppuccin-frappe .ansi span.sgr102{background-color:#a6d189}html.theme--catppuccin-frappe .ansi span.sgr103{background-color:#e5c890}html.theme--catppuccin-frappe .ansi span.sgr104{background-color:#8caaee}html.theme--catppuccin-frappe .ansi span.sgr105{background-color:#f4b8e4}html.theme--catppuccin-frappe .ansi span.sgr106{background-color:#81c8be}html.theme--catppuccin-frappe .ansi span.sgr107{background-color:#a5adce}html.theme--catppuccin-frappe code.language-julia-repl>span.hljs-meta{color:#a6d189;font-weight:bolder}html.theme--catppuccin-frappe code .hljs{color:#c6d0f5;background:#303446}html.theme--catppuccin-frappe code .hljs-keyword{color:#ca9ee6}html.theme--catppuccin-frappe code .hljs-built_in{color:#e78284}html.theme--catppuccin-frappe code .hljs-type{color:#e5c890}html.theme--catppuccin-frappe code .hljs-literal{color:#ef9f76}html.theme--catppuccin-frappe code .hljs-number{color:#ef9f76}html.theme--catppuccin-frappe code .hljs-operator{color:#81c8be}html.theme--catppuccin-frappe code .hljs-punctuation{color:#b5bfe2}html.theme--catppuccin-frappe code .hljs-property{color:#81c8be}html.theme--catppuccin-frappe code .hljs-regexp{color:#f4b8e4}html.theme--catppuccin-frappe code .hljs-string{color:#a6d189}html.theme--catppuccin-frappe code .hljs-char.escape_{color:#a6d189}html.theme--catppuccin-frappe code .hljs-subst{color:#a5adce}html.theme--catppuccin-frappe code .hljs-symbol{color:#eebebe}html.theme--catppuccin-frappe code .hljs-variable{color:#ca9ee6}html.theme--catppuccin-frappe code .hljs-variable.language_{color:#ca9ee6}html.theme--catppuccin-frappe code .hljs-variable.constant_{color:#ef9f76}html.theme--catppuccin-frappe code .hljs-title{color:#8caaee}html.theme--catppuccin-frappe code .hljs-title.class_{color:#e5c890}html.theme--catppuccin-frappe code .hljs-title.function_{color:#8caaee}html.theme--catppuccin-frappe code .hljs-params{color:#c6d0f5}html.theme--catppuccin-frappe code .hljs-comment{color:#626880}html.theme--catppuccin-frappe code .hljs-doctag{color:#e78284}html.theme--catppuccin-frappe code .hljs-meta{color:#ef9f76}html.theme--catppuccin-frappe code .hljs-section{color:#8caaee}html.theme--catppuccin-frappe code .hljs-tag{color:#a5adce}html.theme--catppuccin-frappe code .hljs-name{color:#ca9ee6}html.theme--catppuccin-frappe code .hljs-attr{color:#8caaee}html.theme--catppuccin-frappe code .hljs-attribute{color:#a6d189}html.theme--catppuccin-frappe code .hljs-bullet{color:#81c8be}html.theme--catppuccin-frappe code .hljs-code{color:#a6d189}html.theme--catppuccin-frappe code .hljs-emphasis{color:#e78284;font-style:italic}html.theme--catppuccin-frappe code .hljs-strong{color:#e78284;font-weight:bold}html.theme--catppuccin-frappe code .hljs-formula{color:#81c8be}html.theme--catppuccin-frappe code .hljs-link{color:#85c1dc;font-style:italic}html.theme--catppuccin-frappe code .hljs-quote{color:#a6d189;font-style:italic}html.theme--catppuccin-frappe code .hljs-selector-tag{color:#e5c890}html.theme--catppuccin-frappe code .hljs-selector-id{color:#8caaee}html.theme--catppuccin-frappe code .hljs-selector-class{color:#81c8be}html.theme--catppuccin-frappe code .hljs-selector-attr{color:#ca9ee6}html.theme--catppuccin-frappe code .hljs-selector-pseudo{color:#81c8be}html.theme--catppuccin-frappe code .hljs-template-tag{color:#eebebe}html.theme--catppuccin-frappe code .hljs-template-variable{color:#eebebe}html.theme--catppuccin-frappe code .hljs-addition{color:#a6d189;background:rgba(166,227,161,0.15)}html.theme--catppuccin-frappe code .hljs-deletion{color:#e78284;background:rgba(243,139,168,0.15)}html.theme--catppuccin-frappe .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-frappe .search-result-link:hover,html.theme--catppuccin-frappe .search-result-link:focus{background-color:#414559}html.theme--catppuccin-frappe .search-result-link .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-frappe .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link:hover .search-filter,html.theme--catppuccin-frappe .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-frappe .search-result-link:focus .search-filter{color:#414559 !important;background-color:#babbf1 !important}html.theme--catppuccin-frappe .search-result-title{color:#c6d0f5}html.theme--catppuccin-frappe .search-result-highlight{background-color:#e78284;color:#292c3c}html.theme--catppuccin-frappe .search-divider{border-bottom:1px solid #5e6d6f50}html.theme--catppuccin-frappe .w-100{width:100%}html.theme--catppuccin-frappe .gap-2{gap:0.5rem}html.theme--catppuccin-frappe .gap-4{gap:1rem} diff --git a/v0.16.1/assets/themes/catppuccin-latte.css b/v0.16.1/assets/themes/catppuccin-latte.css new file mode 100644 index 000000000..ca172b630 --- /dev/null +++ b/v0.16.1/assets/themes/catppuccin-latte.css @@ -0,0 +1 @@ +html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte .pagination-ellipsis,html.theme--catppuccin-latte .file-cta,html.theme--catppuccin-latte .file-name,html.theme--catppuccin-latte .select select,html.theme--catppuccin-latte .textarea,html.theme--catppuccin-latte .input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte .button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:.4em;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}html.theme--catppuccin-latte .pagination-previous:focus,html.theme--catppuccin-latte .pagination-next:focus,html.theme--catppuccin-latte .pagination-link:focus,html.theme--catppuccin-latte .pagination-ellipsis:focus,html.theme--catppuccin-latte .file-cta:focus,html.theme--catppuccin-latte .file-name:focus,html.theme--catppuccin-latte .select select:focus,html.theme--catppuccin-latte .textarea:focus,html.theme--catppuccin-latte .input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-latte .button:focus,html.theme--catppuccin-latte .is-focused.pagination-previous,html.theme--catppuccin-latte .is-focused.pagination-next,html.theme--catppuccin-latte .is-focused.pagination-link,html.theme--catppuccin-latte .is-focused.pagination-ellipsis,html.theme--catppuccin-latte .is-focused.file-cta,html.theme--catppuccin-latte .is-focused.file-name,html.theme--catppuccin-latte .select select.is-focused,html.theme--catppuccin-latte .is-focused.textarea,html.theme--catppuccin-latte .is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-focused.button,html.theme--catppuccin-latte .pagination-previous:active,html.theme--catppuccin-latte .pagination-next:active,html.theme--catppuccin-latte .pagination-link:active,html.theme--catppuccin-latte .pagination-ellipsis:active,html.theme--catppuccin-latte .file-cta:active,html.theme--catppuccin-latte .file-name:active,html.theme--catppuccin-latte .select select:active,html.theme--catppuccin-latte .textarea:active,html.theme--catppuccin-latte .input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-latte .button:active,html.theme--catppuccin-latte .is-active.pagination-previous,html.theme--catppuccin-latte .is-active.pagination-next,html.theme--catppuccin-latte .is-active.pagination-link,html.theme--catppuccin-latte .is-active.pagination-ellipsis,html.theme--catppuccin-latte .is-active.file-cta,html.theme--catppuccin-latte .is-active.file-name,html.theme--catppuccin-latte .select select.is-active,html.theme--catppuccin-latte .is-active.textarea,html.theme--catppuccin-latte .is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-latte .is-active.button{outline:none}html.theme--catppuccin-latte .pagination-previous[disabled],html.theme--catppuccin-latte .pagination-next[disabled],html.theme--catppuccin-latte .pagination-link[disabled],html.theme--catppuccin-latte .pagination-ellipsis[disabled],html.theme--catppuccin-latte .file-cta[disabled],html.theme--catppuccin-latte .file-name[disabled],html.theme--catppuccin-latte .select select[disabled],html.theme--catppuccin-latte .textarea[disabled],html.theme--catppuccin-latte .input[disabled],html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled],html.theme--catppuccin-latte .button[disabled],fieldset[disabled] html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte fieldset[disabled] .pagination-previous,fieldset[disabled] html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte fieldset[disabled] .pagination-next,fieldset[disabled] html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte fieldset[disabled] .pagination-link,fieldset[disabled] html.theme--catppuccin-latte .pagination-ellipsis,html.theme--catppuccin-latte fieldset[disabled] .pagination-ellipsis,fieldset[disabled] html.theme--catppuccin-latte .file-cta,html.theme--catppuccin-latte fieldset[disabled] .file-cta,fieldset[disabled] html.theme--catppuccin-latte .file-name,html.theme--catppuccin-latte fieldset[disabled] .file-name,fieldset[disabled] html.theme--catppuccin-latte .select select,fieldset[disabled] html.theme--catppuccin-latte .textarea,fieldset[disabled] html.theme--catppuccin-latte .input,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte fieldset[disabled] .select select,html.theme--catppuccin-latte .select fieldset[disabled] select,html.theme--catppuccin-latte fieldset[disabled] .textarea,html.theme--catppuccin-latte fieldset[disabled] .input,html.theme--catppuccin-latte fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] html.theme--catppuccin-latte .button,html.theme--catppuccin-latte fieldset[disabled] .button{cursor:not-allowed}html.theme--catppuccin-latte .tabs,html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte .pagination-ellipsis,html.theme--catppuccin-latte .breadcrumb,html.theme--catppuccin-latte .file,html.theme--catppuccin-latte .button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}html.theme--catppuccin-latte .navbar-link:not(.is-arrowless)::after,html.theme--catppuccin-latte .select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}html.theme--catppuccin-latte .admonition:not(:last-child),html.theme--catppuccin-latte .tabs:not(:last-child),html.theme--catppuccin-latte .pagination:not(:last-child),html.theme--catppuccin-latte .message:not(:last-child),html.theme--catppuccin-latte .level:not(:last-child),html.theme--catppuccin-latte .breadcrumb:not(:last-child),html.theme--catppuccin-latte .block:not(:last-child),html.theme--catppuccin-latte .title:not(:last-child),html.theme--catppuccin-latte .subtitle:not(:last-child),html.theme--catppuccin-latte .table-container:not(:last-child),html.theme--catppuccin-latte .table:not(:last-child),html.theme--catppuccin-latte .progress:not(:last-child),html.theme--catppuccin-latte .notification:not(:last-child),html.theme--catppuccin-latte .content:not(:last-child),html.theme--catppuccin-latte .box:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-latte .modal-close,html.theme--catppuccin-latte .delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}html.theme--catppuccin-latte .modal-close::before,html.theme--catppuccin-latte .delete::before,html.theme--catppuccin-latte .modal-close::after,html.theme--catppuccin-latte .delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-latte .modal-close::before,html.theme--catppuccin-latte .delete::before{height:2px;width:50%}html.theme--catppuccin-latte .modal-close::after,html.theme--catppuccin-latte .delete::after{height:50%;width:2px}html.theme--catppuccin-latte .modal-close:hover,html.theme--catppuccin-latte .delete:hover,html.theme--catppuccin-latte .modal-close:focus,html.theme--catppuccin-latte .delete:focus{background-color:rgba(10,10,10,0.3)}html.theme--catppuccin-latte .modal-close:active,html.theme--catppuccin-latte .delete:active{background-color:rgba(10,10,10,0.4)}html.theme--catppuccin-latte .is-small.modal-close,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.modal-close,html.theme--catppuccin-latte .is-small.delete,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}html.theme--catppuccin-latte .is-medium.modal-close,html.theme--catppuccin-latte .is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}html.theme--catppuccin-latte .is-large.modal-close,html.theme--catppuccin-latte .is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}html.theme--catppuccin-latte .control.is-loading::after,html.theme--catppuccin-latte .select.is-loading::after,html.theme--catppuccin-latte .loader,html.theme--catppuccin-latte .button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #8c8fa1;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}html.theme--catppuccin-latte .hero-video,html.theme--catppuccin-latte .modal-background,html.theme--catppuccin-latte .modal,html.theme--catppuccin-latte .image.is-square img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-latte .image.is-square .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-latte .image.is-1by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-latte .image.is-1by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-latte .image.is-5by4 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-latte .image.is-5by4 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-latte .image.is-4by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-latte .image.is-4by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-latte .image.is-3by2 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-latte .image.is-3by2 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-latte .image.is-5by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-latte .image.is-5by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-latte .image.is-16by9 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-latte .image.is-16by9 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-latte .image.is-2by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-latte .image.is-2by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-latte .image.is-3by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-latte .image.is-3by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-latte .image.is-4by5 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-latte .image.is-4by5 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-latte .image.is-3by4 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-latte .image.is-3by4 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-latte .image.is-2by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-latte .image.is-2by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-latte .image.is-3by5 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-latte .image.is-3by5 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-latte .image.is-9by16 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-latte .image.is-9by16 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-latte .image.is-1by2 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-latte .image.is-1by2 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-latte .image.is-1by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-latte .image.is-1by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}html.theme--catppuccin-latte .navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#f5f5f5 !important}a.has-text-light:hover,a.has-text-light:focus{color:#dbdbdb !important}.has-background-light{background-color:#f5f5f5 !important}.has-text-dark{color:#ccd0da !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#aeb5c5 !important}.has-background-dark{background-color:#ccd0da !important}.has-text-primary{color:#1e66f5 !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#0a4ed6 !important}.has-background-primary{background-color:#1e66f5 !important}.has-text-primary-light{color:#ebf2fe !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#bbd1fc !important}.has-background-primary-light{background-color:#ebf2fe !important}.has-text-primary-dark{color:#0a52e1 !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#286df5 !important}.has-background-primary-dark{background-color:#0a52e1 !important}.has-text-link{color:#1e66f5 !important}a.has-text-link:hover,a.has-text-link:focus{color:#0a4ed6 !important}.has-background-link{background-color:#1e66f5 !important}.has-text-link-light{color:#ebf2fe !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#bbd1fc !important}.has-background-link-light{background-color:#ebf2fe !important}.has-text-link-dark{color:#0a52e1 !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#286df5 !important}.has-background-link-dark{background-color:#0a52e1 !important}.has-text-info{color:#179299 !important}a.has-text-info:hover,a.has-text-info:focus{color:#10686d !important}.has-background-info{background-color:#179299 !important}.has-text-info-light{color:#edfcfc !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#c1f3f6 !important}.has-background-info-light{background-color:#edfcfc !important}.has-text-info-dark{color:#1cb2ba !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#2ad5df !important}.has-background-info-dark{background-color:#1cb2ba !important}.has-text-success{color:#40a02b !important}a.has-text-success:hover,a.has-text-success:focus{color:#307820 !important}.has-background-success{background-color:#40a02b !important}.has-text-success-light{color:#f1fbef !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#cef0c7 !important}.has-background-success-light{background-color:#f1fbef !important}.has-text-success-dark{color:#40a12b !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#50c936 !important}.has-background-success-dark{background-color:#40a12b !important}.has-text-warning{color:#df8e1d !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#b27117 !important}.has-background-warning{background-color:#df8e1d !important}.has-text-warning-light{color:#fdf6ed !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#f7e0c0 !important}.has-background-warning-light{background-color:#fdf6ed !important}.has-text-warning-dark{color:#9e6515 !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#cb811a !important}.has-background-warning-dark{background-color:#9e6515 !important}.has-text-danger{color:#d20f39 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#a20c2c !important}.has-background-danger{background-color:#d20f39 !important}.has-text-danger-light{color:#feecf0 !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#fabcca !important}.has-background-danger-light{background-color:#feecf0 !important}.has-text-danger-dark{color:#e9113f !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#f13c63 !important}.has-background-danger-dark{background-color:#e9113f !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#ccd0da !important}.has-background-grey-darker{background-color:#ccd0da !important}.has-text-grey-dark{color:#bcc0cc !important}.has-background-grey-dark{background-color:#bcc0cc !important}.has-text-grey{color:#acb0be !important}.has-background-grey{background-color:#acb0be !important}.has-text-grey-light{color:#9ca0b0 !important}.has-background-grey-light{background-color:#9ca0b0 !important}.has-text-grey-lighter{color:#8c8fa1 !important}.has-background-grey-lighter{background-color:#8c8fa1 !important}.has-text-white-ter{color:#f5f5f5 !important}.has-background-white-ter{background-color:#f5f5f5 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}html.theme--catppuccin-latte html{background-color:#eff1f5;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-latte article,html.theme--catppuccin-latte aside,html.theme--catppuccin-latte figure,html.theme--catppuccin-latte footer,html.theme--catppuccin-latte header,html.theme--catppuccin-latte hgroup,html.theme--catppuccin-latte section{display:block}html.theme--catppuccin-latte body,html.theme--catppuccin-latte button,html.theme--catppuccin-latte input,html.theme--catppuccin-latte optgroup,html.theme--catppuccin-latte select,html.theme--catppuccin-latte textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}html.theme--catppuccin-latte code,html.theme--catppuccin-latte pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-latte body{color:#4c4f69;font-size:1em;font-weight:400;line-height:1.5}html.theme--catppuccin-latte a{color:#1e66f5;cursor:pointer;text-decoration:none}html.theme--catppuccin-latte a strong{color:currentColor}html.theme--catppuccin-latte a:hover{color:#04a5e5}html.theme--catppuccin-latte code{background-color:#e6e9ef;color:#4c4f69;font-size:.875em;font-weight:normal;padding:.1em}html.theme--catppuccin-latte hr{background-color:#e6e9ef;border:none;display:block;height:2px;margin:1.5rem 0}html.theme--catppuccin-latte img{height:auto;max-width:100%}html.theme--catppuccin-latte input[type="checkbox"],html.theme--catppuccin-latte input[type="radio"]{vertical-align:baseline}html.theme--catppuccin-latte small{font-size:.875em}html.theme--catppuccin-latte span{font-style:inherit;font-weight:inherit}html.theme--catppuccin-latte strong{color:#41445a;font-weight:700}html.theme--catppuccin-latte fieldset{border:none}html.theme--catppuccin-latte pre{-webkit-overflow-scrolling:touch;background-color:#e6e9ef;color:#4c4f69;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}html.theme--catppuccin-latte pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}html.theme--catppuccin-latte table td,html.theme--catppuccin-latte table th{vertical-align:top}html.theme--catppuccin-latte table td:not([align]),html.theme--catppuccin-latte table th:not([align]){text-align:inherit}html.theme--catppuccin-latte table th{color:#41445a}html.theme--catppuccin-latte .box{background-color:#bcc0cc;border-radius:8px;box-shadow:none;color:#4c4f69;display:block;padding:1.25rem}html.theme--catppuccin-latte a.box:hover,html.theme--catppuccin-latte a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #1e66f5}html.theme--catppuccin-latte a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #1e66f5}html.theme--catppuccin-latte .button{background-color:#e6e9ef;border-color:#fff;border-width:1px;color:#1e66f5;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}html.theme--catppuccin-latte .button strong{color:inherit}html.theme--catppuccin-latte .button .icon,html.theme--catppuccin-latte .button .icon.is-small,html.theme--catppuccin-latte .button #documenter .docs-sidebar form.docs-search>input.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .button form.docs-search>input.icon,html.theme--catppuccin-latte .button .icon.is-medium,html.theme--catppuccin-latte .button .icon.is-large{height:1.5em;width:1.5em}html.theme--catppuccin-latte .button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}html.theme--catppuccin-latte .button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-latte .button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-latte .button:hover,html.theme--catppuccin-latte .button.is-hovered{border-color:#9ca0b0;color:#41445a}html.theme--catppuccin-latte .button:focus,html.theme--catppuccin-latte .button.is-focused{border-color:#9ca0b0;color:#0b57ef}html.theme--catppuccin-latte .button:focus:not(:active),html.theme--catppuccin-latte .button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .button:active,html.theme--catppuccin-latte .button.is-active{border-color:#bcc0cc;color:#41445a}html.theme--catppuccin-latte .button.is-text{background-color:transparent;border-color:transparent;color:#4c4f69;text-decoration:underline}html.theme--catppuccin-latte .button.is-text:hover,html.theme--catppuccin-latte .button.is-text.is-hovered,html.theme--catppuccin-latte .button.is-text:focus,html.theme--catppuccin-latte .button.is-text.is-focused{background-color:#e6e9ef;color:#41445a}html.theme--catppuccin-latte .button.is-text:active,html.theme--catppuccin-latte .button.is-text.is-active{background-color:#d6dbe5;color:#41445a}html.theme--catppuccin-latte .button.is-text[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}html.theme--catppuccin-latte .button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#1e66f5;text-decoration:none}html.theme--catppuccin-latte .button.is-ghost:hover,html.theme--catppuccin-latte .button.is-ghost.is-hovered{color:#1e66f5;text-decoration:underline}html.theme--catppuccin-latte .button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white:hover,html.theme--catppuccin-latte .button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white:focus,html.theme--catppuccin-latte .button.is-white.is-focused{border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white:focus:not(:active),html.theme--catppuccin-latte .button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-latte .button.is-white:active,html.theme--catppuccin-latte .button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}html.theme--catppuccin-latte .button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .button.is-white.is-inverted:hover,html.theme--catppuccin-latte .button.is-white.is-inverted.is-hovered{background-color:#000}html.theme--catppuccin-latte .button.is-white.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-latte .button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-white.is-outlined:hover,html.theme--catppuccin-latte .button.is-white.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-white.is-outlined:focus,html.theme--catppuccin-latte .button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-white.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-white.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-white.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-latte .button.is-white.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-black:hover,html.theme--catppuccin-latte .button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-black:focus,html.theme--catppuccin-latte .button.is-black.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-black:focus:not(:active),html.theme--catppuccin-latte .button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-latte .button.is-black:active,html.theme--catppuccin-latte .button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-black[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}html.theme--catppuccin-latte .button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black.is-inverted:hover,html.theme--catppuccin-latte .button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-black.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black.is-outlined:hover,html.theme--catppuccin-latte .button.is-black.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-black.is-outlined:focus,html.theme--catppuccin-latte .button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-latte .button.is-black.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-black.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-black.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-black.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-light{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light:hover,html.theme--catppuccin-latte .button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light:focus,html.theme--catppuccin-latte .button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light:focus:not(:active),html.theme--catppuccin-latte .button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-latte .button.is-light:active,html.theme--catppuccin-latte .button.is-light.is-active{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-light{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none}html.theme--catppuccin-latte .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-latte .button.is-light.is-inverted:hover,html.theme--catppuccin-latte .button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-latte .button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-latte .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;color:#f5f5f5}html.theme--catppuccin-latte .button.is-light.is-outlined:hover,html.theme--catppuccin-latte .button.is-light.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-light.is-outlined:focus,html.theme--catppuccin-latte .button.is-light.is-outlined.is-focused{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-latte .button.is-light.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-light.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-light.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-latte .button.is-light.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark,html.theme--catppuccin-latte .content kbd.button{background-color:#ccd0da;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark:hover,html.theme--catppuccin-latte .content kbd.button:hover,html.theme--catppuccin-latte .button.is-dark.is-hovered,html.theme--catppuccin-latte .content kbd.button.is-hovered{background-color:#c5c9d5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark:focus,html.theme--catppuccin-latte .content kbd.button:focus,html.theme--catppuccin-latte .button.is-dark.is-focused,html.theme--catppuccin-latte .content kbd.button.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark:focus:not(:active),html.theme--catppuccin-latte .content kbd.button:focus:not(:active),html.theme--catppuccin-latte .button.is-dark.is-focused:not(:active),html.theme--catppuccin-latte .content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(204,208,218,0.25)}html.theme--catppuccin-latte .button.is-dark:active,html.theme--catppuccin-latte .content kbd.button:active,html.theme--catppuccin-latte .button.is-dark.is-active,html.theme--catppuccin-latte .content kbd.button.is-active{background-color:#bdc2cf;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark[disabled],html.theme--catppuccin-latte .content kbd.button[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-dark,fieldset[disabled] html.theme--catppuccin-latte .content kbd.button{background-color:#ccd0da;border-color:#ccd0da;box-shadow:none}html.theme--catppuccin-latte .button.is-dark.is-inverted,html.theme--catppuccin-latte .content kbd.button.is-inverted{background-color:rgba(0,0,0,0.7);color:#ccd0da}html.theme--catppuccin-latte .button.is-dark.is-inverted:hover,html.theme--catppuccin-latte .content kbd.button.is-inverted:hover,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-hovered,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark.is-inverted[disabled],html.theme--catppuccin-latte .content kbd.button.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-dark.is-inverted,fieldset[disabled] html.theme--catppuccin-latte .content kbd.button.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#ccd0da}html.theme--catppuccin-latte .button.is-dark.is-loading::after,html.theme--catppuccin-latte .content kbd.button.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-latte .button.is-dark.is-outlined,html.theme--catppuccin-latte .content kbd.button.is-outlined{background-color:transparent;border-color:#ccd0da;color:#ccd0da}html.theme--catppuccin-latte .button.is-dark.is-outlined:hover,html.theme--catppuccin-latte .content kbd.button.is-outlined:hover,html.theme--catppuccin-latte .button.is-dark.is-outlined.is-hovered,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-dark.is-outlined:focus,html.theme--catppuccin-latte .content kbd.button.is-outlined:focus,html.theme--catppuccin-latte .button.is-dark.is-outlined.is-focused,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-focused{background-color:#ccd0da;border-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark.is-outlined.is-loading::after,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #ccd0da #ccd0da !important}html.theme--catppuccin-latte .button.is-dark.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-dark.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-dark.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-dark.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-latte .content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-latte .button.is-dark.is-outlined[disabled],html.theme--catppuccin-latte .content kbd.button.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-dark.is-outlined,fieldset[disabled] html.theme--catppuccin-latte .content kbd.button.is-outlined{background-color:transparent;border-color:#ccd0da;box-shadow:none;color:#ccd0da}html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-focused,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#ccd0da}html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #ccd0da #ccd0da !important}html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined[disabled],html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-dark.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-latte .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .button.is-primary,html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink{background-color:#1e66f5;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-primary:hover,html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink:hover,html.theme--catppuccin-latte .button.is-primary.is-hovered,html.theme--catppuccin-latte .docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#125ef4;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-primary:focus,html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink:focus,html.theme--catppuccin-latte .button.is-primary.is-focused,html.theme--catppuccin-latte .docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-primary:focus:not(:active),html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink:focus:not(:active),html.theme--catppuccin-latte .button.is-primary.is-focused:not(:active),html.theme--catppuccin-latte .docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .button.is-primary:active,html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink:active,html.theme--catppuccin-latte .button.is-primary.is-active,html.theme--catppuccin-latte .docstring>section>a.button.is-active.docs-sourcelink{background-color:#0b57ef;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-primary[disabled],html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-primary,fieldset[disabled] html.theme--catppuccin-latte .docstring>section>a.button.docs-sourcelink{background-color:#1e66f5;border-color:#1e66f5;box-shadow:none}html.theme--catppuccin-latte .button.is-primary.is-inverted,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .button.is-primary.is-inverted:hover,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.docs-sourcelink:hover,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-hovered,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-primary.is-inverted[disabled],html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-primary.is-inverted,fieldset[disabled] html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#1e66f5}html.theme--catppuccin-latte .button.is-primary.is-loading::after,html.theme--catppuccin-latte .docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-primary.is-outlined,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#1e66f5;color:#1e66f5}html.theme--catppuccin-latte .button.is-primary.is-outlined:hover,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-latte .button.is-primary.is-outlined.is-hovered,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-latte .button.is-primary.is-outlined:focus,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-latte .button.is-primary.is-outlined.is-focused,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#1e66f5;border-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .button.is-primary.is-outlined.is-loading::after,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #1e66f5 #1e66f5 !important}html.theme--catppuccin-latte .button.is-primary.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-latte .button.is-primary.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-latte .button.is-primary.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-latte .button.is-primary.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-primary.is-outlined[disabled],html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-primary.is-outlined,fieldset[disabled] html.theme--catppuccin-latte .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#1e66f5;box-shadow:none;color:#1e66f5}html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-focused,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #1e66f5 #1e66f5 !important}html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined[disabled],html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-primary.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-latte .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-primary.is-light,html.theme--catppuccin-latte .docstring>section>a.button.is-light.docs-sourcelink{background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .button.is-primary.is-light:hover,html.theme--catppuccin-latte .docstring>section>a.button.is-light.docs-sourcelink:hover,html.theme--catppuccin-latte .button.is-primary.is-light.is-hovered,html.theme--catppuccin-latte .docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#dfe9fe;border-color:transparent;color:#0a52e1}html.theme--catppuccin-latte .button.is-primary.is-light:active,html.theme--catppuccin-latte .docstring>section>a.button.is-light.docs-sourcelink:active,html.theme--catppuccin-latte .button.is-primary.is-light.is-active,html.theme--catppuccin-latte .docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#d3e1fd;border-color:transparent;color:#0a52e1}html.theme--catppuccin-latte .button.is-link{background-color:#1e66f5;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-link:hover,html.theme--catppuccin-latte .button.is-link.is-hovered{background-color:#125ef4;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-link:focus,html.theme--catppuccin-latte .button.is-link.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-link:focus:not(:active),html.theme--catppuccin-latte .button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .button.is-link:active,html.theme--catppuccin-latte .button.is-link.is-active{background-color:#0b57ef;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-link[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-link{background-color:#1e66f5;border-color:#1e66f5;box-shadow:none}html.theme--catppuccin-latte .button.is-link.is-inverted{background-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .button.is-link.is-inverted:hover,html.theme--catppuccin-latte .button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-link.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#1e66f5}html.theme--catppuccin-latte .button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-link.is-outlined{background-color:transparent;border-color:#1e66f5;color:#1e66f5}html.theme--catppuccin-latte .button.is-link.is-outlined:hover,html.theme--catppuccin-latte .button.is-link.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-link.is-outlined:focus,html.theme--catppuccin-latte .button.is-link.is-outlined.is-focused{background-color:#1e66f5;border-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #1e66f5 #1e66f5 !important}html.theme--catppuccin-latte .button.is-link.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-link.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-link.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-link.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-link.is-outlined{background-color:transparent;border-color:#1e66f5;box-shadow:none;color:#1e66f5}html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #1e66f5 #1e66f5 !important}html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-link.is-light{background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .button.is-link.is-light:hover,html.theme--catppuccin-latte .button.is-link.is-light.is-hovered{background-color:#dfe9fe;border-color:transparent;color:#0a52e1}html.theme--catppuccin-latte .button.is-link.is-light:active,html.theme--catppuccin-latte .button.is-link.is-light.is-active{background-color:#d3e1fd;border-color:transparent;color:#0a52e1}html.theme--catppuccin-latte .button.is-info{background-color:#179299;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-info:hover,html.theme--catppuccin-latte .button.is-info.is-hovered{background-color:#15878e;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-info:focus,html.theme--catppuccin-latte .button.is-info.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-info:focus:not(:active),html.theme--catppuccin-latte .button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(23,146,153,0.25)}html.theme--catppuccin-latte .button.is-info:active,html.theme--catppuccin-latte .button.is-info.is-active{background-color:#147d83;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-info[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-info{background-color:#179299;border-color:#179299;box-shadow:none}html.theme--catppuccin-latte .button.is-info.is-inverted{background-color:#fff;color:#179299}html.theme--catppuccin-latte .button.is-info.is-inverted:hover,html.theme--catppuccin-latte .button.is-info.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-info.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-info.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#179299}html.theme--catppuccin-latte .button.is-info.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-info.is-outlined{background-color:transparent;border-color:#179299;color:#179299}html.theme--catppuccin-latte .button.is-info.is-outlined:hover,html.theme--catppuccin-latte .button.is-info.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-info.is-outlined:focus,html.theme--catppuccin-latte .button.is-info.is-outlined.is-focused{background-color:#179299;border-color:#179299;color:#fff}html.theme--catppuccin-latte .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #179299 #179299 !important}html.theme--catppuccin-latte .button.is-info.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-info.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-info.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-info.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-info.is-outlined{background-color:transparent;border-color:#179299;box-shadow:none;color:#179299}html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-focused{background-color:#fff;color:#179299}html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #179299 #179299 !important}html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-info.is-light{background-color:#edfcfc;color:#1cb2ba}html.theme--catppuccin-latte .button.is-info.is-light:hover,html.theme--catppuccin-latte .button.is-info.is-light.is-hovered{background-color:#e2f9fb;border-color:transparent;color:#1cb2ba}html.theme--catppuccin-latte .button.is-info.is-light:active,html.theme--catppuccin-latte .button.is-info.is-light.is-active{background-color:#d7f7f9;border-color:transparent;color:#1cb2ba}html.theme--catppuccin-latte .button.is-success{background-color:#40a02b;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-success:hover,html.theme--catppuccin-latte .button.is-success.is-hovered{background-color:#3c9628;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-success:focus,html.theme--catppuccin-latte .button.is-success.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-success:focus:not(:active),html.theme--catppuccin-latte .button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(64,160,43,0.25)}html.theme--catppuccin-latte .button.is-success:active,html.theme--catppuccin-latte .button.is-success.is-active{background-color:#388c26;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-success[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-success{background-color:#40a02b;border-color:#40a02b;box-shadow:none}html.theme--catppuccin-latte .button.is-success.is-inverted{background-color:#fff;color:#40a02b}html.theme--catppuccin-latte .button.is-success.is-inverted:hover,html.theme--catppuccin-latte .button.is-success.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-success.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-success.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#40a02b}html.theme--catppuccin-latte .button.is-success.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-success.is-outlined{background-color:transparent;border-color:#40a02b;color:#40a02b}html.theme--catppuccin-latte .button.is-success.is-outlined:hover,html.theme--catppuccin-latte .button.is-success.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-success.is-outlined:focus,html.theme--catppuccin-latte .button.is-success.is-outlined.is-focused{background-color:#40a02b;border-color:#40a02b;color:#fff}html.theme--catppuccin-latte .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #40a02b #40a02b !important}html.theme--catppuccin-latte .button.is-success.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-success.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-success.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-success.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-success.is-outlined{background-color:transparent;border-color:#40a02b;box-shadow:none;color:#40a02b}html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-focused{background-color:#fff;color:#40a02b}html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #40a02b #40a02b !important}html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-success.is-light{background-color:#f1fbef;color:#40a12b}html.theme--catppuccin-latte .button.is-success.is-light:hover,html.theme--catppuccin-latte .button.is-success.is-light.is-hovered{background-color:#e8f8e5;border-color:transparent;color:#40a12b}html.theme--catppuccin-latte .button.is-success.is-light:active,html.theme--catppuccin-latte .button.is-success.is-light.is-active{background-color:#e0f5db;border-color:transparent;color:#40a12b}html.theme--catppuccin-latte .button.is-warning{background-color:#df8e1d;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-warning:hover,html.theme--catppuccin-latte .button.is-warning.is-hovered{background-color:#d4871c;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-warning:focus,html.theme--catppuccin-latte .button.is-warning.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-warning:focus:not(:active),html.theme--catppuccin-latte .button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(223,142,29,0.25)}html.theme--catppuccin-latte .button.is-warning:active,html.theme--catppuccin-latte .button.is-warning.is-active{background-color:#c8801a;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-warning[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-warning{background-color:#df8e1d;border-color:#df8e1d;box-shadow:none}html.theme--catppuccin-latte .button.is-warning.is-inverted{background-color:#fff;color:#df8e1d}html.theme--catppuccin-latte .button.is-warning.is-inverted:hover,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-warning.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#df8e1d}html.theme--catppuccin-latte .button.is-warning.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-warning.is-outlined{background-color:transparent;border-color:#df8e1d;color:#df8e1d}html.theme--catppuccin-latte .button.is-warning.is-outlined:hover,html.theme--catppuccin-latte .button.is-warning.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-warning.is-outlined:focus,html.theme--catppuccin-latte .button.is-warning.is-outlined.is-focused{background-color:#df8e1d;border-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #df8e1d #df8e1d !important}html.theme--catppuccin-latte .button.is-warning.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-warning.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-warning.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-warning.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-warning.is-outlined{background-color:transparent;border-color:#df8e1d;box-shadow:none;color:#df8e1d}html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-focused{background-color:#fff;color:#df8e1d}html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #df8e1d #df8e1d !important}html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-warning.is-light{background-color:#fdf6ed;color:#9e6515}html.theme--catppuccin-latte .button.is-warning.is-light:hover,html.theme--catppuccin-latte .button.is-warning.is-light.is-hovered{background-color:#fbf1e2;border-color:transparent;color:#9e6515}html.theme--catppuccin-latte .button.is-warning.is-light:active,html.theme--catppuccin-latte .button.is-warning.is-light.is-active{background-color:#faebd6;border-color:transparent;color:#9e6515}html.theme--catppuccin-latte .button.is-danger{background-color:#d20f39;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-danger:hover,html.theme--catppuccin-latte .button.is-danger.is-hovered{background-color:#c60e36;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-danger:focus,html.theme--catppuccin-latte .button.is-danger.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-danger:focus:not(:active),html.theme--catppuccin-latte .button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(210,15,57,0.25)}html.theme--catppuccin-latte .button.is-danger:active,html.theme--catppuccin-latte .button.is-danger.is-active{background-color:#ba0d33;border-color:transparent;color:#fff}html.theme--catppuccin-latte .button.is-danger[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-danger{background-color:#d20f39;border-color:#d20f39;box-shadow:none}html.theme--catppuccin-latte .button.is-danger.is-inverted{background-color:#fff;color:#d20f39}html.theme--catppuccin-latte .button.is-danger.is-inverted:hover,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-latte .button.is-danger.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#d20f39}html.theme--catppuccin-latte .button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-danger.is-outlined{background-color:transparent;border-color:#d20f39;color:#d20f39}html.theme--catppuccin-latte .button.is-danger.is-outlined:hover,html.theme--catppuccin-latte .button.is-danger.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-danger.is-outlined:focus,html.theme--catppuccin-latte .button.is-danger.is-outlined.is-focused{background-color:#d20f39;border-color:#d20f39;color:#fff}html.theme--catppuccin-latte .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #d20f39 #d20f39 !important}html.theme--catppuccin-latte .button.is-danger.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-danger.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-danger.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-latte .button.is-danger.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-danger.is-outlined{background-color:transparent;border-color:#d20f39;box-shadow:none;color:#d20f39}html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined:hover,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined:focus,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#d20f39}html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #d20f39 #d20f39 !important}html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-latte .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-latte .button.is-danger.is-light{background-color:#feecf0;color:#e9113f}html.theme--catppuccin-latte .button.is-danger.is-light:hover,html.theme--catppuccin-latte .button.is-danger.is-light.is-hovered{background-color:#fde0e6;border-color:transparent;color:#e9113f}html.theme--catppuccin-latte .button.is-danger.is-light:active,html.theme--catppuccin-latte .button.is-danger.is-light.is-active{background-color:#fcd4dd;border-color:transparent;color:#e9113f}html.theme--catppuccin-latte .button.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}html.theme--catppuccin-latte .button.is-small:not(.is-rounded),html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:3px}html.theme--catppuccin-latte .button.is-normal{font-size:1rem}html.theme--catppuccin-latte .button.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .button.is-large{font-size:1.5rem}html.theme--catppuccin-latte .button[disabled],fieldset[disabled] html.theme--catppuccin-latte .button{background-color:#9ca0b0;border-color:#acb0be;box-shadow:none;opacity:.5}html.theme--catppuccin-latte .button.is-fullwidth{display:flex;width:100%}html.theme--catppuccin-latte .button.is-loading{color:transparent !important;pointer-events:none}html.theme--catppuccin-latte .button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}html.theme--catppuccin-latte .button.is-static{background-color:#e6e9ef;border-color:#acb0be;color:#8c8fa1;box-shadow:none;pointer-events:none}html.theme--catppuccin-latte .button.is-rounded,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}html.theme--catppuccin-latte .buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-latte .buttons .button{margin-bottom:0.5rem}html.theme--catppuccin-latte .buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}html.theme--catppuccin-latte .buttons:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-latte .buttons:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-latte .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}html.theme--catppuccin-latte .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:3px}html.theme--catppuccin-latte .buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}html.theme--catppuccin-latte .buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}html.theme--catppuccin-latte .buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-latte .buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}html.theme--catppuccin-latte .buttons.has-addons .button:last-child{margin-right:0}html.theme--catppuccin-latte .buttons.has-addons .button:hover,html.theme--catppuccin-latte .buttons.has-addons .button.is-hovered{z-index:2}html.theme--catppuccin-latte .buttons.has-addons .button:focus,html.theme--catppuccin-latte .buttons.has-addons .button.is-focused,html.theme--catppuccin-latte .buttons.has-addons .button:active,html.theme--catppuccin-latte .buttons.has-addons .button.is-active,html.theme--catppuccin-latte .buttons.has-addons .button.is-selected{z-index:3}html.theme--catppuccin-latte .buttons.has-addons .button:focus:hover,html.theme--catppuccin-latte .buttons.has-addons .button.is-focused:hover,html.theme--catppuccin-latte .buttons.has-addons .button:active:hover,html.theme--catppuccin-latte .buttons.has-addons .button.is-active:hover,html.theme--catppuccin-latte .buttons.has-addons .button.is-selected:hover{z-index:4}html.theme--catppuccin-latte .buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .buttons.is-centered{justify-content:center}html.theme--catppuccin-latte .buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}html.theme--catppuccin-latte .buttons.is-right{justify-content:flex-end}html.theme--catppuccin-latte .buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .button.is-responsive.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}html.theme--catppuccin-latte .button.is-responsive,html.theme--catppuccin-latte .button.is-responsive.is-normal{font-size:.65625rem}html.theme--catppuccin-latte .button.is-responsive.is-medium{font-size:.75rem}html.theme--catppuccin-latte .button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .button.is-responsive.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}html.theme--catppuccin-latte .button.is-responsive,html.theme--catppuccin-latte .button.is-responsive.is-normal{font-size:.75rem}html.theme--catppuccin-latte .button.is-responsive.is-medium{font-size:1rem}html.theme--catppuccin-latte .button.is-responsive.is-large{font-size:1.25rem}}html.theme--catppuccin-latte .container{flex-grow:1;margin:0 auto;position:relative;width:auto}html.theme--catppuccin-latte .container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .container{max-width:992px}}@media screen and (max-width: 1215px){html.theme--catppuccin-latte .container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){html.theme--catppuccin-latte .container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}html.theme--catppuccin-latte .content li+li{margin-top:0.25em}html.theme--catppuccin-latte .content p:not(:last-child),html.theme--catppuccin-latte .content dl:not(:last-child),html.theme--catppuccin-latte .content ol:not(:last-child),html.theme--catppuccin-latte .content ul:not(:last-child),html.theme--catppuccin-latte .content blockquote:not(:last-child),html.theme--catppuccin-latte .content pre:not(:last-child),html.theme--catppuccin-latte .content table:not(:last-child){margin-bottom:1em}html.theme--catppuccin-latte .content h1,html.theme--catppuccin-latte .content h2,html.theme--catppuccin-latte .content h3,html.theme--catppuccin-latte .content h4,html.theme--catppuccin-latte .content h5,html.theme--catppuccin-latte .content h6{color:#4c4f69;font-weight:600;line-height:1.125}html.theme--catppuccin-latte .content h1{font-size:2em;margin-bottom:0.5em}html.theme--catppuccin-latte .content h1:not(:first-child){margin-top:1em}html.theme--catppuccin-latte .content h2{font-size:1.75em;margin-bottom:0.5714em}html.theme--catppuccin-latte .content h2:not(:first-child){margin-top:1.1428em}html.theme--catppuccin-latte .content h3{font-size:1.5em;margin-bottom:0.6666em}html.theme--catppuccin-latte .content h3:not(:first-child){margin-top:1.3333em}html.theme--catppuccin-latte .content h4{font-size:1.25em;margin-bottom:0.8em}html.theme--catppuccin-latte .content h5{font-size:1.125em;margin-bottom:0.8888em}html.theme--catppuccin-latte .content h6{font-size:1em;margin-bottom:1em}html.theme--catppuccin-latte .content blockquote{background-color:#e6e9ef;border-left:5px solid #acb0be;padding:1.25em 1.5em}html.theme--catppuccin-latte .content ol{list-style-position:outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-latte .content ol:not([type]){list-style-type:decimal}html.theme--catppuccin-latte .content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}html.theme--catppuccin-latte .content ol.is-lower-roman:not([type]){list-style-type:lower-roman}html.theme--catppuccin-latte .content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}html.theme--catppuccin-latte .content ol.is-upper-roman:not([type]){list-style-type:upper-roman}html.theme--catppuccin-latte .content ul{list-style:disc outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-latte .content ul ul{list-style-type:circle;margin-top:0.5em}html.theme--catppuccin-latte .content ul ul ul{list-style-type:square}html.theme--catppuccin-latte .content dd{margin-left:2em}html.theme--catppuccin-latte .content figure{margin-left:2em;margin-right:2em;text-align:center}html.theme--catppuccin-latte .content figure:not(:first-child){margin-top:2em}html.theme--catppuccin-latte .content figure:not(:last-child){margin-bottom:2em}html.theme--catppuccin-latte .content figure img{display:inline-block}html.theme--catppuccin-latte .content figure figcaption{font-style:italic}html.theme--catppuccin-latte .content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}html.theme--catppuccin-latte .content sup,html.theme--catppuccin-latte .content sub{font-size:75%}html.theme--catppuccin-latte .content table{width:100%}html.theme--catppuccin-latte .content table td,html.theme--catppuccin-latte .content table th{border:1px solid #acb0be;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-latte .content table th{color:#41445a}html.theme--catppuccin-latte .content table th:not([align]){text-align:inherit}html.theme--catppuccin-latte .content table thead td,html.theme--catppuccin-latte .content table thead th{border-width:0 0 2px;color:#41445a}html.theme--catppuccin-latte .content table tfoot td,html.theme--catppuccin-latte .content table tfoot th{border-width:2px 0 0;color:#41445a}html.theme--catppuccin-latte .content table tbody tr:last-child td,html.theme--catppuccin-latte .content table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-latte .content .tabs li+li{margin-top:0}html.theme--catppuccin-latte .content.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}html.theme--catppuccin-latte .content.is-normal{font-size:1rem}html.theme--catppuccin-latte .content.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .content.is-large{font-size:1.5rem}html.theme--catppuccin-latte .icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}html.theme--catppuccin-latte .icon.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}html.theme--catppuccin-latte .icon.is-medium{height:2rem;width:2rem}html.theme--catppuccin-latte .icon.is-large{height:3rem;width:3rem}html.theme--catppuccin-latte .icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}html.theme--catppuccin-latte .icon-text .icon{flex-grow:0;flex-shrink:0}html.theme--catppuccin-latte .icon-text .icon:not(:last-child){margin-right:.25em}html.theme--catppuccin-latte .icon-text .icon:not(:first-child){margin-left:.25em}html.theme--catppuccin-latte div.icon-text{display:flex}html.theme--catppuccin-latte .image,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img{display:block;position:relative}html.theme--catppuccin-latte .image img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}html.theme--catppuccin-latte .image img.is-rounded,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}html.theme--catppuccin-latte .image.is-fullwidth,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}html.theme--catppuccin-latte .image.is-square img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-latte .image.is-square .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-latte .image.is-1by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-latte .image.is-1by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-latte .image.is-5by4 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-latte .image.is-5by4 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-latte .image.is-4by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-latte .image.is-4by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-latte .image.is-3by2 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-latte .image.is-3by2 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-latte .image.is-5by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-latte .image.is-5by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-latte .image.is-16by9 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-latte .image.is-16by9 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-latte .image.is-2by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-latte .image.is-2by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-latte .image.is-3by1 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-latte .image.is-3by1 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-latte .image.is-4by5 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-latte .image.is-4by5 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-latte .image.is-3by4 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-latte .image.is-3by4 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-latte .image.is-2by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-latte .image.is-2by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-latte .image.is-3by5 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-latte .image.is-3by5 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-latte .image.is-9by16 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-latte .image.is-9by16 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-latte .image.is-1by2 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-latte .image.is-1by2 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-latte .image.is-1by3 img,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-latte .image.is-1by3 .has-ratio,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}html.theme--catppuccin-latte .image.is-square,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-square,html.theme--catppuccin-latte .image.is-1by1,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}html.theme--catppuccin-latte .image.is-5by4,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}html.theme--catppuccin-latte .image.is-4by3,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}html.theme--catppuccin-latte .image.is-3by2,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}html.theme--catppuccin-latte .image.is-5by3,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}html.theme--catppuccin-latte .image.is-16by9,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}html.theme--catppuccin-latte .image.is-2by1,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}html.theme--catppuccin-latte .image.is-3by1,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}html.theme--catppuccin-latte .image.is-4by5,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}html.theme--catppuccin-latte .image.is-3by4,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}html.theme--catppuccin-latte .image.is-2by3,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}html.theme--catppuccin-latte .image.is-3by5,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}html.theme--catppuccin-latte .image.is-9by16,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}html.theme--catppuccin-latte .image.is-1by2,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}html.theme--catppuccin-latte .image.is-1by3,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}html.theme--catppuccin-latte .image.is-16x16,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}html.theme--catppuccin-latte .image.is-24x24,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}html.theme--catppuccin-latte .image.is-32x32,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}html.theme--catppuccin-latte .image.is-48x48,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}html.theme--catppuccin-latte .image.is-64x64,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}html.theme--catppuccin-latte .image.is-96x96,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}html.theme--catppuccin-latte .image.is-128x128,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}html.theme--catppuccin-latte .notification{background-color:#e6e9ef;border-radius:.4em;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}html.theme--catppuccin-latte .notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-latte .notification strong{color:currentColor}html.theme--catppuccin-latte .notification code,html.theme--catppuccin-latte .notification pre{background:#fff}html.theme--catppuccin-latte .notification pre code{background:transparent}html.theme--catppuccin-latte .notification>.delete{right:.5rem;position:absolute;top:0.5rem}html.theme--catppuccin-latte .notification .title,html.theme--catppuccin-latte .notification .subtitle,html.theme--catppuccin-latte .notification .content{color:currentColor}html.theme--catppuccin-latte .notification.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .notification.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .notification.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .notification.is-dark,html.theme--catppuccin-latte .content kbd.notification{background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .notification.is-primary,html.theme--catppuccin-latte .docstring>section>a.notification.docs-sourcelink{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .notification.is-primary.is-light,html.theme--catppuccin-latte .docstring>section>a.notification.is-light.docs-sourcelink{background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .notification.is-link{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .notification.is-link.is-light{background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .notification.is-info{background-color:#179299;color:#fff}html.theme--catppuccin-latte .notification.is-info.is-light{background-color:#edfcfc;color:#1cb2ba}html.theme--catppuccin-latte .notification.is-success{background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .notification.is-success.is-light{background-color:#f1fbef;color:#40a12b}html.theme--catppuccin-latte .notification.is-warning{background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .notification.is-warning.is-light{background-color:#fdf6ed;color:#9e6515}html.theme--catppuccin-latte .notification.is-danger{background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .notification.is-danger.is-light{background-color:#feecf0;color:#e9113f}html.theme--catppuccin-latte .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}html.theme--catppuccin-latte .progress::-webkit-progress-bar{background-color:#bcc0cc}html.theme--catppuccin-latte .progress::-webkit-progress-value{background-color:#8c8fa1}html.theme--catppuccin-latte .progress::-moz-progress-bar{background-color:#8c8fa1}html.theme--catppuccin-latte .progress::-ms-fill{background-color:#8c8fa1;border:none}html.theme--catppuccin-latte .progress.is-white::-webkit-progress-value{background-color:#fff}html.theme--catppuccin-latte .progress.is-white::-moz-progress-bar{background-color:#fff}html.theme--catppuccin-latte .progress.is-white::-ms-fill{background-color:#fff}html.theme--catppuccin-latte .progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-black::-webkit-progress-value{background-color:#0a0a0a}html.theme--catppuccin-latte .progress.is-black::-moz-progress-bar{background-color:#0a0a0a}html.theme--catppuccin-latte .progress.is-black::-ms-fill{background-color:#0a0a0a}html.theme--catppuccin-latte .progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-light::-webkit-progress-value{background-color:#f5f5f5}html.theme--catppuccin-latte .progress.is-light::-moz-progress-bar{background-color:#f5f5f5}html.theme--catppuccin-latte .progress.is-light::-ms-fill{background-color:#f5f5f5}html.theme--catppuccin-latte .progress.is-light:indeterminate{background-image:linear-gradient(to right, #f5f5f5 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-dark::-webkit-progress-value,html.theme--catppuccin-latte .content kbd.progress::-webkit-progress-value{background-color:#ccd0da}html.theme--catppuccin-latte .progress.is-dark::-moz-progress-bar,html.theme--catppuccin-latte .content kbd.progress::-moz-progress-bar{background-color:#ccd0da}html.theme--catppuccin-latte .progress.is-dark::-ms-fill,html.theme--catppuccin-latte .content kbd.progress::-ms-fill{background-color:#ccd0da}html.theme--catppuccin-latte .progress.is-dark:indeterminate,html.theme--catppuccin-latte .content kbd.progress:indeterminate{background-image:linear-gradient(to right, #ccd0da 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-primary::-webkit-progress-value,html.theme--catppuccin-latte .docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-primary::-moz-progress-bar,html.theme--catppuccin-latte .docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-primary::-ms-fill,html.theme--catppuccin-latte .docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-primary:indeterminate,html.theme--catppuccin-latte .docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #1e66f5 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-link::-webkit-progress-value{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-link::-moz-progress-bar{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-link::-ms-fill{background-color:#1e66f5}html.theme--catppuccin-latte .progress.is-link:indeterminate{background-image:linear-gradient(to right, #1e66f5 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-info::-webkit-progress-value{background-color:#179299}html.theme--catppuccin-latte .progress.is-info::-moz-progress-bar{background-color:#179299}html.theme--catppuccin-latte .progress.is-info::-ms-fill{background-color:#179299}html.theme--catppuccin-latte .progress.is-info:indeterminate{background-image:linear-gradient(to right, #179299 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-success::-webkit-progress-value{background-color:#40a02b}html.theme--catppuccin-latte .progress.is-success::-moz-progress-bar{background-color:#40a02b}html.theme--catppuccin-latte .progress.is-success::-ms-fill{background-color:#40a02b}html.theme--catppuccin-latte .progress.is-success:indeterminate{background-image:linear-gradient(to right, #40a02b 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-warning::-webkit-progress-value{background-color:#df8e1d}html.theme--catppuccin-latte .progress.is-warning::-moz-progress-bar{background-color:#df8e1d}html.theme--catppuccin-latte .progress.is-warning::-ms-fill{background-color:#df8e1d}html.theme--catppuccin-latte .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #df8e1d 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress.is-danger::-webkit-progress-value{background-color:#d20f39}html.theme--catppuccin-latte .progress.is-danger::-moz-progress-bar{background-color:#d20f39}html.theme--catppuccin-latte .progress.is-danger::-ms-fill{background-color:#d20f39}html.theme--catppuccin-latte .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #d20f39 30%, #bcc0cc 30%)}html.theme--catppuccin-latte .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#bcc0cc;background-image:linear-gradient(to right, #4c4f69 30%, #bcc0cc 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}html.theme--catppuccin-latte .progress:indeterminate::-webkit-progress-bar{background-color:transparent}html.theme--catppuccin-latte .progress:indeterminate::-moz-progress-bar{background-color:transparent}html.theme--catppuccin-latte .progress:indeterminate::-ms-fill{animation-name:none}html.theme--catppuccin-latte .progress.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}html.theme--catppuccin-latte .progress.is-medium{height:1.25rem}html.theme--catppuccin-latte .progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}html.theme--catppuccin-latte .table{background-color:#bcc0cc;color:#4c4f69}html.theme--catppuccin-latte .table td,html.theme--catppuccin-latte .table th{border:1px solid #acb0be;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-latte .table td.is-white,html.theme--catppuccin-latte .table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .table td.is-black,html.theme--catppuccin-latte .table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .table td.is-light,html.theme--catppuccin-latte .table th.is-light{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .table td.is-dark,html.theme--catppuccin-latte .table th.is-dark{background-color:#ccd0da;border-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .table td.is-primary,html.theme--catppuccin-latte .table th.is-primary{background-color:#1e66f5;border-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .table td.is-link,html.theme--catppuccin-latte .table th.is-link{background-color:#1e66f5;border-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .table td.is-info,html.theme--catppuccin-latte .table th.is-info{background-color:#179299;border-color:#179299;color:#fff}html.theme--catppuccin-latte .table td.is-success,html.theme--catppuccin-latte .table th.is-success{background-color:#40a02b;border-color:#40a02b;color:#fff}html.theme--catppuccin-latte .table td.is-warning,html.theme--catppuccin-latte .table th.is-warning{background-color:#df8e1d;border-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .table td.is-danger,html.theme--catppuccin-latte .table th.is-danger{background-color:#d20f39;border-color:#d20f39;color:#fff}html.theme--catppuccin-latte .table td.is-narrow,html.theme--catppuccin-latte .table th.is-narrow{white-space:nowrap;width:1%}html.theme--catppuccin-latte .table td.is-selected,html.theme--catppuccin-latte .table th.is-selected{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .table td.is-selected a,html.theme--catppuccin-latte .table td.is-selected strong,html.theme--catppuccin-latte .table th.is-selected a,html.theme--catppuccin-latte .table th.is-selected strong{color:currentColor}html.theme--catppuccin-latte .table td.is-vcentered,html.theme--catppuccin-latte .table th.is-vcentered{vertical-align:middle}html.theme--catppuccin-latte .table th{color:#41445a}html.theme--catppuccin-latte .table th:not([align]){text-align:left}html.theme--catppuccin-latte .table tr.is-selected{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .table tr.is-selected a,html.theme--catppuccin-latte .table tr.is-selected strong{color:currentColor}html.theme--catppuccin-latte .table tr.is-selected td,html.theme--catppuccin-latte .table tr.is-selected th{border-color:#fff;color:currentColor}html.theme--catppuccin-latte .table thead{background-color:rgba(0,0,0,0)}html.theme--catppuccin-latte .table thead td,html.theme--catppuccin-latte .table thead th{border-width:0 0 2px;color:#41445a}html.theme--catppuccin-latte .table tfoot{background-color:rgba(0,0,0,0)}html.theme--catppuccin-latte .table tfoot td,html.theme--catppuccin-latte .table tfoot th{border-width:2px 0 0;color:#41445a}html.theme--catppuccin-latte .table tbody{background-color:rgba(0,0,0,0)}html.theme--catppuccin-latte .table tbody tr:last-child td,html.theme--catppuccin-latte .table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-latte .table.is-bordered td,html.theme--catppuccin-latte .table.is-bordered th{border-width:1px}html.theme--catppuccin-latte .table.is-bordered tr:last-child td,html.theme--catppuccin-latte .table.is-bordered tr:last-child th{border-bottom-width:1px}html.theme--catppuccin-latte .table.is-fullwidth{width:100%}html.theme--catppuccin-latte .table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#ccd0da}html.theme--catppuccin-latte .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#ccd0da}html.theme--catppuccin-latte .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#d2d5de}html.theme--catppuccin-latte .table.is-narrow td,html.theme--catppuccin-latte .table.is-narrow th{padding:0.25em 0.5em}html.theme--catppuccin-latte .table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#ccd0da}html.theme--catppuccin-latte .table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}html.theme--catppuccin-latte .tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-latte .tags .tag,html.theme--catppuccin-latte .tags .content kbd,html.theme--catppuccin-latte .content .tags kbd,html.theme--catppuccin-latte .tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}html.theme--catppuccin-latte .tags .tag:not(:last-child),html.theme--catppuccin-latte .tags .content kbd:not(:last-child),html.theme--catppuccin-latte .content .tags kbd:not(:last-child),html.theme--catppuccin-latte .tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}html.theme--catppuccin-latte .tags:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-latte .tags:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-latte .tags.are-medium .tag:not(.is-normal):not(.is-large),html.theme--catppuccin-latte .tags.are-medium .content kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-latte .content .tags.are-medium kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-latte .tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}html.theme--catppuccin-latte .tags.are-large .tag:not(.is-normal):not(.is-medium),html.theme--catppuccin-latte .tags.are-large .content kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-latte .content .tags.are-large kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-latte .tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}html.theme--catppuccin-latte .tags.is-centered{justify-content:center}html.theme--catppuccin-latte .tags.is-centered .tag,html.theme--catppuccin-latte .tags.is-centered .content kbd,html.theme--catppuccin-latte .content .tags.is-centered kbd,html.theme--catppuccin-latte .tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}html.theme--catppuccin-latte .tags.is-right{justify-content:flex-end}html.theme--catppuccin-latte .tags.is-right .tag:not(:first-child),html.theme--catppuccin-latte .tags.is-right .content kbd:not(:first-child),html.theme--catppuccin-latte .content .tags.is-right kbd:not(:first-child),html.theme--catppuccin-latte .tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}html.theme--catppuccin-latte .tags.is-right .tag:not(:last-child),html.theme--catppuccin-latte .tags.is-right .content kbd:not(:last-child),html.theme--catppuccin-latte .content .tags.is-right kbd:not(:last-child),html.theme--catppuccin-latte .tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}html.theme--catppuccin-latte .tags.has-addons .tag,html.theme--catppuccin-latte .tags.has-addons .content kbd,html.theme--catppuccin-latte .content .tags.has-addons kbd,html.theme--catppuccin-latte .tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}html.theme--catppuccin-latte .tags.has-addons .tag:not(:first-child),html.theme--catppuccin-latte .tags.has-addons .content kbd:not(:first-child),html.theme--catppuccin-latte .content .tags.has-addons kbd:not(:first-child),html.theme--catppuccin-latte .tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}html.theme--catppuccin-latte .tags.has-addons .tag:not(:last-child),html.theme--catppuccin-latte .tags.has-addons .content kbd:not(:last-child),html.theme--catppuccin-latte .content .tags.has-addons kbd:not(:last-child),html.theme--catppuccin-latte .tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}html.theme--catppuccin-latte .tag:not(body),html.theme--catppuccin-latte .content kbd:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#e6e9ef;border-radius:.4em;color:#4c4f69;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}html.theme--catppuccin-latte .tag:not(body) .delete,html.theme--catppuccin-latte .content kbd:not(body) .delete,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}html.theme--catppuccin-latte .tag.is-white:not(body),html.theme--catppuccin-latte .content kbd.is-white:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .tag.is-black:not(body),html.theme--catppuccin-latte .content kbd.is-black:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .tag.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .tag.is-dark:not(body),html.theme--catppuccin-latte .content kbd:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-dark:not(body),html.theme--catppuccin-latte .content .docstring>section>kbd:not(body){background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .tag.is-primary:not(body),html.theme--catppuccin-latte .content kbd.is-primary:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body){background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .tag.is-primary.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-primary.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .tag.is-link:not(body),html.theme--catppuccin-latte .content kbd.is-link:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .tag.is-link.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-link.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#ebf2fe;color:#0a52e1}html.theme--catppuccin-latte .tag.is-info:not(body),html.theme--catppuccin-latte .content kbd.is-info:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#179299;color:#fff}html.theme--catppuccin-latte .tag.is-info.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-info.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#edfcfc;color:#1cb2ba}html.theme--catppuccin-latte .tag.is-success:not(body),html.theme--catppuccin-latte .content kbd.is-success:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .tag.is-success.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-success.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#f1fbef;color:#40a12b}html.theme--catppuccin-latte .tag.is-warning:not(body),html.theme--catppuccin-latte .content kbd.is-warning:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .tag.is-warning.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-warning.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fdf6ed;color:#9e6515}html.theme--catppuccin-latte .tag.is-danger:not(body),html.theme--catppuccin-latte .content kbd.is-danger:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .tag.is-danger.is-light:not(body),html.theme--catppuccin-latte .content kbd.is-danger.is-light:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#feecf0;color:#e9113f}html.theme--catppuccin-latte .tag.is-normal:not(body),html.theme--catppuccin-latte .content kbd.is-normal:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}html.theme--catppuccin-latte .tag.is-medium:not(body),html.theme--catppuccin-latte .content kbd.is-medium:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}html.theme--catppuccin-latte .tag.is-large:not(body),html.theme--catppuccin-latte .content kbd.is-large:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}html.theme--catppuccin-latte .tag:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-latte .content kbd:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}html.theme--catppuccin-latte .tag:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-latte .content kbd:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}html.theme--catppuccin-latte .tag:not(body) .icon:first-child:last-child,html.theme--catppuccin-latte .content kbd:not(body) .icon:first-child:last-child,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}html.theme--catppuccin-latte .tag.is-delete:not(body),html.theme--catppuccin-latte .content kbd.is-delete:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}html.theme--catppuccin-latte .tag.is-delete:not(body)::before,html.theme--catppuccin-latte .content kbd.is-delete:not(body)::before,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body)::before,html.theme--catppuccin-latte .tag.is-delete:not(body)::after,html.theme--catppuccin-latte .content kbd.is-delete:not(body)::after,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-latte .tag.is-delete:not(body)::before,html.theme--catppuccin-latte .content kbd.is-delete:not(body)::before,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}html.theme--catppuccin-latte .tag.is-delete:not(body)::after,html.theme--catppuccin-latte .content kbd.is-delete:not(body)::after,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}html.theme--catppuccin-latte .tag.is-delete:not(body):hover,html.theme--catppuccin-latte .content kbd.is-delete:not(body):hover,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body):hover,html.theme--catppuccin-latte .tag.is-delete:not(body):focus,html.theme--catppuccin-latte .content kbd.is-delete:not(body):focus,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#d6dbe5}html.theme--catppuccin-latte .tag.is-delete:not(body):active,html.theme--catppuccin-latte .content kbd.is-delete:not(body):active,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#c7cedb}html.theme--catppuccin-latte .tag.is-rounded:not(body),html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:not(body),html.theme--catppuccin-latte .content kbd.is-rounded:not(body),html.theme--catppuccin-latte #documenter .docs-sidebar .content form.docs-search>input:not(body),html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}html.theme--catppuccin-latte a.tag:hover,html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:hover{text-decoration:underline}html.theme--catppuccin-latte .title,html.theme--catppuccin-latte .subtitle{word-break:break-word}html.theme--catppuccin-latte .title em,html.theme--catppuccin-latte .title span,html.theme--catppuccin-latte .subtitle em,html.theme--catppuccin-latte .subtitle span{font-weight:inherit}html.theme--catppuccin-latte .title sub,html.theme--catppuccin-latte .subtitle sub{font-size:.75em}html.theme--catppuccin-latte .title sup,html.theme--catppuccin-latte .subtitle sup{font-size:.75em}html.theme--catppuccin-latte .title .tag,html.theme--catppuccin-latte .title .content kbd,html.theme--catppuccin-latte .content .title kbd,html.theme--catppuccin-latte .title .docstring>section>a.docs-sourcelink,html.theme--catppuccin-latte .subtitle .tag,html.theme--catppuccin-latte .subtitle .content kbd,html.theme--catppuccin-latte .content .subtitle kbd,html.theme--catppuccin-latte .subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}html.theme--catppuccin-latte .title{color:#fff;font-size:2rem;font-weight:500;line-height:1.125}html.theme--catppuccin-latte .title strong{color:inherit;font-weight:inherit}html.theme--catppuccin-latte .title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}html.theme--catppuccin-latte .title.is-1{font-size:3rem}html.theme--catppuccin-latte .title.is-2{font-size:2.5rem}html.theme--catppuccin-latte .title.is-3{font-size:2rem}html.theme--catppuccin-latte .title.is-4{font-size:1.5rem}html.theme--catppuccin-latte .title.is-5{font-size:1.25rem}html.theme--catppuccin-latte .title.is-6{font-size:1rem}html.theme--catppuccin-latte .title.is-7{font-size:.75rem}html.theme--catppuccin-latte .subtitle{color:#9ca0b0;font-size:1.25rem;font-weight:400;line-height:1.25}html.theme--catppuccin-latte .subtitle strong{color:#9ca0b0;font-weight:600}html.theme--catppuccin-latte .subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}html.theme--catppuccin-latte .subtitle.is-1{font-size:3rem}html.theme--catppuccin-latte .subtitle.is-2{font-size:2.5rem}html.theme--catppuccin-latte .subtitle.is-3{font-size:2rem}html.theme--catppuccin-latte .subtitle.is-4{font-size:1.5rem}html.theme--catppuccin-latte .subtitle.is-5{font-size:1.25rem}html.theme--catppuccin-latte .subtitle.is-6{font-size:1rem}html.theme--catppuccin-latte .subtitle.is-7{font-size:.75rem}html.theme--catppuccin-latte .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--catppuccin-latte .number{align-items:center;background-color:#e6e9ef;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}html.theme--catppuccin-latte .select select,html.theme--catppuccin-latte .textarea,html.theme--catppuccin-latte .input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{background-color:#eff1f5;border-color:#acb0be;border-radius:.4em;color:#8c8fa1}html.theme--catppuccin-latte .select select::-moz-placeholder,html.theme--catppuccin-latte .textarea::-moz-placeholder,html.theme--catppuccin-latte .input::-moz-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#868c98}html.theme--catppuccin-latte .select select::-webkit-input-placeholder,html.theme--catppuccin-latte .textarea::-webkit-input-placeholder,html.theme--catppuccin-latte .input::-webkit-input-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#868c98}html.theme--catppuccin-latte .select select:-moz-placeholder,html.theme--catppuccin-latte .textarea:-moz-placeholder,html.theme--catppuccin-latte .input:-moz-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#868c98}html.theme--catppuccin-latte .select select:-ms-input-placeholder,html.theme--catppuccin-latte .textarea:-ms-input-placeholder,html.theme--catppuccin-latte .input:-ms-input-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#868c98}html.theme--catppuccin-latte .select select:hover,html.theme--catppuccin-latte .textarea:hover,html.theme--catppuccin-latte .input:hover,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:hover,html.theme--catppuccin-latte .select select.is-hovered,html.theme--catppuccin-latte .is-hovered.textarea,html.theme--catppuccin-latte .is-hovered.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#9ca0b0}html.theme--catppuccin-latte .select select:focus,html.theme--catppuccin-latte .textarea:focus,html.theme--catppuccin-latte .input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-latte .select select.is-focused,html.theme--catppuccin-latte .is-focused.textarea,html.theme--catppuccin-latte .is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .select select:active,html.theme--catppuccin-latte .textarea:active,html.theme--catppuccin-latte .input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-latte .select select.is-active,html.theme--catppuccin-latte .is-active.textarea,html.theme--catppuccin-latte .is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{border-color:#1e66f5;box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .select select[disabled],html.theme--catppuccin-latte .textarea[disabled],html.theme--catppuccin-latte .input[disabled],html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] html.theme--catppuccin-latte .select select,fieldset[disabled] html.theme--catppuccin-latte .textarea,fieldset[disabled] html.theme--catppuccin-latte .input,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{background-color:#9ca0b0;border-color:#e6e9ef;box-shadow:none;color:#616587}html.theme--catppuccin-latte .select select[disabled]::-moz-placeholder,html.theme--catppuccin-latte .textarea[disabled]::-moz-placeholder,html.theme--catppuccin-latte .input[disabled]::-moz-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .select select::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .textarea::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .input::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(97,101,135,0.3)}html.theme--catppuccin-latte .select select[disabled]::-webkit-input-placeholder,html.theme--catppuccin-latte .textarea[disabled]::-webkit-input-placeholder,html.theme--catppuccin-latte .input[disabled]::-webkit-input-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .select select::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .textarea::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .input::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(97,101,135,0.3)}html.theme--catppuccin-latte .select select[disabled]:-moz-placeholder,html.theme--catppuccin-latte .textarea[disabled]:-moz-placeholder,html.theme--catppuccin-latte .input[disabled]:-moz-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .select select:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .textarea:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte .input:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(97,101,135,0.3)}html.theme--catppuccin-latte .select select[disabled]:-ms-input-placeholder,html.theme--catppuccin-latte .textarea[disabled]:-ms-input-placeholder,html.theme--catppuccin-latte .input[disabled]:-ms-input-placeholder,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .select select:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .textarea:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte .input:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(97,101,135,0.3)}html.theme--catppuccin-latte .textarea,html.theme--catppuccin-latte .input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}html.theme--catppuccin-latte .textarea[readonly],html.theme--catppuccin-latte .input[readonly],html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}html.theme--catppuccin-latte .is-white.textarea,html.theme--catppuccin-latte .is-white.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}html.theme--catppuccin-latte .is-white.textarea:focus,html.theme--catppuccin-latte .is-white.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-white:focus,html.theme--catppuccin-latte .is-white.is-focused.textarea,html.theme--catppuccin-latte .is-white.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-white.textarea:active,html.theme--catppuccin-latte .is-white.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-white:active,html.theme--catppuccin-latte .is-white.is-active.textarea,html.theme--catppuccin-latte .is-white.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-latte .is-black.textarea,html.theme--catppuccin-latte .is-black.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}html.theme--catppuccin-latte .is-black.textarea:focus,html.theme--catppuccin-latte .is-black.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-black:focus,html.theme--catppuccin-latte .is-black.is-focused.textarea,html.theme--catppuccin-latte .is-black.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-black.textarea:active,html.theme--catppuccin-latte .is-black.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-black:active,html.theme--catppuccin-latte .is-black.is-active.textarea,html.theme--catppuccin-latte .is-black.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-latte .is-light.textarea,html.theme--catppuccin-latte .is-light.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-light{border-color:#f5f5f5}html.theme--catppuccin-latte .is-light.textarea:focus,html.theme--catppuccin-latte .is-light.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-light:focus,html.theme--catppuccin-latte .is-light.is-focused.textarea,html.theme--catppuccin-latte .is-light.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-light.textarea:active,html.theme--catppuccin-latte .is-light.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-light:active,html.theme--catppuccin-latte .is-light.is-active.textarea,html.theme--catppuccin-latte .is-light.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-latte .is-dark.textarea,html.theme--catppuccin-latte .content kbd.textarea,html.theme--catppuccin-latte .is-dark.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-dark,html.theme--catppuccin-latte .content kbd.input{border-color:#ccd0da}html.theme--catppuccin-latte .is-dark.textarea:focus,html.theme--catppuccin-latte .content kbd.textarea:focus,html.theme--catppuccin-latte .is-dark.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-dark:focus,html.theme--catppuccin-latte .content kbd.input:focus,html.theme--catppuccin-latte .is-dark.is-focused.textarea,html.theme--catppuccin-latte .content kbd.is-focused.textarea,html.theme--catppuccin-latte .is-dark.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .content kbd.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar .content form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-dark.textarea:active,html.theme--catppuccin-latte .content kbd.textarea:active,html.theme--catppuccin-latte .is-dark.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-dark:active,html.theme--catppuccin-latte .content kbd.input:active,html.theme--catppuccin-latte .is-dark.is-active.textarea,html.theme--catppuccin-latte .content kbd.is-active.textarea,html.theme--catppuccin-latte .is-dark.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-latte .content kbd.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(204,208,218,0.25)}html.theme--catppuccin-latte .is-primary.textarea,html.theme--catppuccin-latte .docstring>section>a.textarea.docs-sourcelink,html.theme--catppuccin-latte .is-primary.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-primary,html.theme--catppuccin-latte .docstring>section>a.input.docs-sourcelink{border-color:#1e66f5}html.theme--catppuccin-latte .is-primary.textarea:focus,html.theme--catppuccin-latte .docstring>section>a.textarea.docs-sourcelink:focus,html.theme--catppuccin-latte .is-primary.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-primary:focus,html.theme--catppuccin-latte .docstring>section>a.input.docs-sourcelink:focus,html.theme--catppuccin-latte .is-primary.is-focused.textarea,html.theme--catppuccin-latte .docstring>section>a.is-focused.textarea.docs-sourcelink,html.theme--catppuccin-latte .is-primary.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .docstring>section>a.is-focused.input.docs-sourcelink,html.theme--catppuccin-latte .is-primary.textarea:active,html.theme--catppuccin-latte .docstring>section>a.textarea.docs-sourcelink:active,html.theme--catppuccin-latte .is-primary.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-primary:active,html.theme--catppuccin-latte .docstring>section>a.input.docs-sourcelink:active,html.theme--catppuccin-latte .is-primary.is-active.textarea,html.theme--catppuccin-latte .docstring>section>a.is-active.textarea.docs-sourcelink,html.theme--catppuccin-latte .is-primary.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-latte .docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .is-link.textarea,html.theme--catppuccin-latte .is-link.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-link{border-color:#1e66f5}html.theme--catppuccin-latte .is-link.textarea:focus,html.theme--catppuccin-latte .is-link.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-link:focus,html.theme--catppuccin-latte .is-link.is-focused.textarea,html.theme--catppuccin-latte .is-link.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-link.textarea:active,html.theme--catppuccin-latte .is-link.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-link:active,html.theme--catppuccin-latte .is-link.is-active.textarea,html.theme--catppuccin-latte .is-link.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .is-info.textarea,html.theme--catppuccin-latte .is-info.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-info{border-color:#179299}html.theme--catppuccin-latte .is-info.textarea:focus,html.theme--catppuccin-latte .is-info.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-info:focus,html.theme--catppuccin-latte .is-info.is-focused.textarea,html.theme--catppuccin-latte .is-info.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-info.textarea:active,html.theme--catppuccin-latte .is-info.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-info:active,html.theme--catppuccin-latte .is-info.is-active.textarea,html.theme--catppuccin-latte .is-info.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(23,146,153,0.25)}html.theme--catppuccin-latte .is-success.textarea,html.theme--catppuccin-latte .is-success.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-success{border-color:#40a02b}html.theme--catppuccin-latte .is-success.textarea:focus,html.theme--catppuccin-latte .is-success.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-success:focus,html.theme--catppuccin-latte .is-success.is-focused.textarea,html.theme--catppuccin-latte .is-success.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-success.textarea:active,html.theme--catppuccin-latte .is-success.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-success:active,html.theme--catppuccin-latte .is-success.is-active.textarea,html.theme--catppuccin-latte .is-success.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(64,160,43,0.25)}html.theme--catppuccin-latte .is-warning.textarea,html.theme--catppuccin-latte .is-warning.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#df8e1d}html.theme--catppuccin-latte .is-warning.textarea:focus,html.theme--catppuccin-latte .is-warning.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-warning:focus,html.theme--catppuccin-latte .is-warning.is-focused.textarea,html.theme--catppuccin-latte .is-warning.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-warning.textarea:active,html.theme--catppuccin-latte .is-warning.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-warning:active,html.theme--catppuccin-latte .is-warning.is-active.textarea,html.theme--catppuccin-latte .is-warning.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(223,142,29,0.25)}html.theme--catppuccin-latte .is-danger.textarea,html.theme--catppuccin-latte .is-danger.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#d20f39}html.theme--catppuccin-latte .is-danger.textarea:focus,html.theme--catppuccin-latte .is-danger.input:focus,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-danger:focus,html.theme--catppuccin-latte .is-danger.is-focused.textarea,html.theme--catppuccin-latte .is-danger.is-focused.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-latte .is-danger.textarea:active,html.theme--catppuccin-latte .is-danger.input:active,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-danger:active,html.theme--catppuccin-latte .is-danger.is-active.textarea,html.theme--catppuccin-latte .is-danger.is-active.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(210,15,57,0.25)}html.theme--catppuccin-latte .is-small.textarea,html.theme--catppuccin-latte .is-small.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{border-radius:3px;font-size:.75rem}html.theme--catppuccin-latte .is-medium.textarea,html.theme--catppuccin-latte .is-medium.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .is-large.textarea,html.theme--catppuccin-latte .is-large.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}html.theme--catppuccin-latte .is-fullwidth.textarea,html.theme--catppuccin-latte .is-fullwidth.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}html.theme--catppuccin-latte .is-inline.textarea,html.theme--catppuccin-latte .is-inline.input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}html.theme--catppuccin-latte .input.is-rounded,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}html.theme--catppuccin-latte .input.is-static,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}html.theme--catppuccin-latte .textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}html.theme--catppuccin-latte .textarea:not([rows]){max-height:40em;min-height:8em}html.theme--catppuccin-latte .textarea[rows]{height:initial}html.theme--catppuccin-latte .textarea.has-fixed-size{resize:none}html.theme--catppuccin-latte .radio,html.theme--catppuccin-latte .checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}html.theme--catppuccin-latte .radio input,html.theme--catppuccin-latte .checkbox input{cursor:pointer}html.theme--catppuccin-latte .radio:hover,html.theme--catppuccin-latte .checkbox:hover{color:#04a5e5}html.theme--catppuccin-latte .radio[disabled],html.theme--catppuccin-latte .checkbox[disabled],fieldset[disabled] html.theme--catppuccin-latte .radio,fieldset[disabled] html.theme--catppuccin-latte .checkbox,html.theme--catppuccin-latte .radio input[disabled],html.theme--catppuccin-latte .checkbox input[disabled]{color:#616587;cursor:not-allowed}html.theme--catppuccin-latte .radio+.radio{margin-left:.5em}html.theme--catppuccin-latte .select{display:inline-block;max-width:100%;position:relative;vertical-align:top}html.theme--catppuccin-latte .select:not(.is-multiple){height:2.5em}html.theme--catppuccin-latte .select:not(.is-multiple):not(.is-loading)::after{border-color:#1e66f5;right:1.125em;z-index:4}html.theme--catppuccin-latte .select.is-rounded select,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}html.theme--catppuccin-latte .select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}html.theme--catppuccin-latte .select select::-ms-expand{display:none}html.theme--catppuccin-latte .select select[disabled]:hover,fieldset[disabled] html.theme--catppuccin-latte .select select:hover{border-color:#e6e9ef}html.theme--catppuccin-latte .select select:not([multiple]){padding-right:2.5em}html.theme--catppuccin-latte .select select[multiple]{height:auto;padding:0}html.theme--catppuccin-latte .select select[multiple] option{padding:0.5em 1em}html.theme--catppuccin-latte .select:not(.is-multiple):not(.is-loading):hover::after{border-color:#04a5e5}html.theme--catppuccin-latte .select.is-white:not(:hover)::after{border-color:#fff}html.theme--catppuccin-latte .select.is-white select{border-color:#fff}html.theme--catppuccin-latte .select.is-white select:hover,html.theme--catppuccin-latte .select.is-white select.is-hovered{border-color:#f2f2f2}html.theme--catppuccin-latte .select.is-white select:focus,html.theme--catppuccin-latte .select.is-white select.is-focused,html.theme--catppuccin-latte .select.is-white select:active,html.theme--catppuccin-latte .select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-latte .select.is-black:not(:hover)::after{border-color:#0a0a0a}html.theme--catppuccin-latte .select.is-black select{border-color:#0a0a0a}html.theme--catppuccin-latte .select.is-black select:hover,html.theme--catppuccin-latte .select.is-black select.is-hovered{border-color:#000}html.theme--catppuccin-latte .select.is-black select:focus,html.theme--catppuccin-latte .select.is-black select.is-focused,html.theme--catppuccin-latte .select.is-black select:active,html.theme--catppuccin-latte .select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-latte .select.is-light:not(:hover)::after{border-color:#f5f5f5}html.theme--catppuccin-latte .select.is-light select{border-color:#f5f5f5}html.theme--catppuccin-latte .select.is-light select:hover,html.theme--catppuccin-latte .select.is-light select.is-hovered{border-color:#e8e8e8}html.theme--catppuccin-latte .select.is-light select:focus,html.theme--catppuccin-latte .select.is-light select.is-focused,html.theme--catppuccin-latte .select.is-light select:active,html.theme--catppuccin-latte .select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-latte .select.is-dark:not(:hover)::after,html.theme--catppuccin-latte .content kbd.select:not(:hover)::after{border-color:#ccd0da}html.theme--catppuccin-latte .select.is-dark select,html.theme--catppuccin-latte .content kbd.select select{border-color:#ccd0da}html.theme--catppuccin-latte .select.is-dark select:hover,html.theme--catppuccin-latte .content kbd.select select:hover,html.theme--catppuccin-latte .select.is-dark select.is-hovered,html.theme--catppuccin-latte .content kbd.select select.is-hovered{border-color:#bdc2cf}html.theme--catppuccin-latte .select.is-dark select:focus,html.theme--catppuccin-latte .content kbd.select select:focus,html.theme--catppuccin-latte .select.is-dark select.is-focused,html.theme--catppuccin-latte .content kbd.select select.is-focused,html.theme--catppuccin-latte .select.is-dark select:active,html.theme--catppuccin-latte .content kbd.select select:active,html.theme--catppuccin-latte .select.is-dark select.is-active,html.theme--catppuccin-latte .content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(204,208,218,0.25)}html.theme--catppuccin-latte .select.is-primary:not(:hover)::after,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#1e66f5}html.theme--catppuccin-latte .select.is-primary select,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select{border-color:#1e66f5}html.theme--catppuccin-latte .select.is-primary select:hover,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select:hover,html.theme--catppuccin-latte .select.is-primary select.is-hovered,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#0b57ef}html.theme--catppuccin-latte .select.is-primary select:focus,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select:focus,html.theme--catppuccin-latte .select.is-primary select.is-focused,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select.is-focused,html.theme--catppuccin-latte .select.is-primary select:active,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select:active,html.theme--catppuccin-latte .select.is-primary select.is-active,html.theme--catppuccin-latte .docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .select.is-link:not(:hover)::after{border-color:#1e66f5}html.theme--catppuccin-latte .select.is-link select{border-color:#1e66f5}html.theme--catppuccin-latte .select.is-link select:hover,html.theme--catppuccin-latte .select.is-link select.is-hovered{border-color:#0b57ef}html.theme--catppuccin-latte .select.is-link select:focus,html.theme--catppuccin-latte .select.is-link select.is-focused,html.theme--catppuccin-latte .select.is-link select:active,html.theme--catppuccin-latte .select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(30,102,245,0.25)}html.theme--catppuccin-latte .select.is-info:not(:hover)::after{border-color:#179299}html.theme--catppuccin-latte .select.is-info select{border-color:#179299}html.theme--catppuccin-latte .select.is-info select:hover,html.theme--catppuccin-latte .select.is-info select.is-hovered{border-color:#147d83}html.theme--catppuccin-latte .select.is-info select:focus,html.theme--catppuccin-latte .select.is-info select.is-focused,html.theme--catppuccin-latte .select.is-info select:active,html.theme--catppuccin-latte .select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(23,146,153,0.25)}html.theme--catppuccin-latte .select.is-success:not(:hover)::after{border-color:#40a02b}html.theme--catppuccin-latte .select.is-success select{border-color:#40a02b}html.theme--catppuccin-latte .select.is-success select:hover,html.theme--catppuccin-latte .select.is-success select.is-hovered{border-color:#388c26}html.theme--catppuccin-latte .select.is-success select:focus,html.theme--catppuccin-latte .select.is-success select.is-focused,html.theme--catppuccin-latte .select.is-success select:active,html.theme--catppuccin-latte .select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(64,160,43,0.25)}html.theme--catppuccin-latte .select.is-warning:not(:hover)::after{border-color:#df8e1d}html.theme--catppuccin-latte .select.is-warning select{border-color:#df8e1d}html.theme--catppuccin-latte .select.is-warning select:hover,html.theme--catppuccin-latte .select.is-warning select.is-hovered{border-color:#c8801a}html.theme--catppuccin-latte .select.is-warning select:focus,html.theme--catppuccin-latte .select.is-warning select.is-focused,html.theme--catppuccin-latte .select.is-warning select:active,html.theme--catppuccin-latte .select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(223,142,29,0.25)}html.theme--catppuccin-latte .select.is-danger:not(:hover)::after{border-color:#d20f39}html.theme--catppuccin-latte .select.is-danger select{border-color:#d20f39}html.theme--catppuccin-latte .select.is-danger select:hover,html.theme--catppuccin-latte .select.is-danger select.is-hovered{border-color:#ba0d33}html.theme--catppuccin-latte .select.is-danger select:focus,html.theme--catppuccin-latte .select.is-danger select.is-focused,html.theme--catppuccin-latte .select.is-danger select:active,html.theme--catppuccin-latte .select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(210,15,57,0.25)}html.theme--catppuccin-latte .select.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.select{border-radius:3px;font-size:.75rem}html.theme--catppuccin-latte .select.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .select.is-large{font-size:1.5rem}html.theme--catppuccin-latte .select.is-disabled::after{border-color:#616587 !important;opacity:0.5}html.theme--catppuccin-latte .select.is-fullwidth{width:100%}html.theme--catppuccin-latte .select.is-fullwidth select{width:100%}html.theme--catppuccin-latte .select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}html.theme--catppuccin-latte .select.is-loading.is-small:after,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-latte .select.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-latte .select.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-latte .file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}html.theme--catppuccin-latte .file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .file.is-white:hover .file-cta,html.theme--catppuccin-latte .file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .file.is-white:focus .file-cta,html.theme--catppuccin-latte .file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}html.theme--catppuccin-latte .file.is-white:active .file-cta,html.theme--catppuccin-latte .file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-latte .file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-black:hover .file-cta,html.theme--catppuccin-latte .file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-black:focus .file-cta,html.theme--catppuccin-latte .file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}html.theme--catppuccin-latte .file.is-black:active .file-cta,html.theme--catppuccin-latte .file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-light .file-cta{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-light:hover .file-cta,html.theme--catppuccin-latte .file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-light:focus .file-cta,html.theme--catppuccin-latte .file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(245,245,245,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-light:active .file-cta,html.theme--catppuccin-latte .file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-dark .file-cta,html.theme--catppuccin-latte .content kbd.file .file-cta{background-color:#ccd0da;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-dark:hover .file-cta,html.theme--catppuccin-latte .content kbd.file:hover .file-cta,html.theme--catppuccin-latte .file.is-dark.is-hovered .file-cta,html.theme--catppuccin-latte .content kbd.file.is-hovered .file-cta{background-color:#c5c9d5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-dark:focus .file-cta,html.theme--catppuccin-latte .content kbd.file:focus .file-cta,html.theme--catppuccin-latte .file.is-dark.is-focused .file-cta,html.theme--catppuccin-latte .content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(204,208,218,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-dark:active .file-cta,html.theme--catppuccin-latte .content kbd.file:active .file-cta,html.theme--catppuccin-latte .file.is-dark.is-active .file-cta,html.theme--catppuccin-latte .content kbd.file.is-active .file-cta{background-color:#bdc2cf;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .file.is-primary .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.docs-sourcelink .file-cta{background-color:#1e66f5;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-primary:hover .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.docs-sourcelink:hover .file-cta,html.theme--catppuccin-latte .file.is-primary.is-hovered .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#125ef4;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-primary:focus .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.docs-sourcelink:focus .file-cta,html.theme--catppuccin-latte .file.is-primary.is-focused .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(30,102,245,0.25);color:#fff}html.theme--catppuccin-latte .file.is-primary:active .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.docs-sourcelink:active .file-cta,html.theme--catppuccin-latte .file.is-primary.is-active .file-cta,html.theme--catppuccin-latte .docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#0b57ef;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-link .file-cta{background-color:#1e66f5;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-link:hover .file-cta,html.theme--catppuccin-latte .file.is-link.is-hovered .file-cta{background-color:#125ef4;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-link:focus .file-cta,html.theme--catppuccin-latte .file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(30,102,245,0.25);color:#fff}html.theme--catppuccin-latte .file.is-link:active .file-cta,html.theme--catppuccin-latte .file.is-link.is-active .file-cta{background-color:#0b57ef;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-info .file-cta{background-color:#179299;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-info:hover .file-cta,html.theme--catppuccin-latte .file.is-info.is-hovered .file-cta{background-color:#15878e;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-info:focus .file-cta,html.theme--catppuccin-latte .file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(23,146,153,0.25);color:#fff}html.theme--catppuccin-latte .file.is-info:active .file-cta,html.theme--catppuccin-latte .file.is-info.is-active .file-cta{background-color:#147d83;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-success .file-cta{background-color:#40a02b;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-success:hover .file-cta,html.theme--catppuccin-latte .file.is-success.is-hovered .file-cta{background-color:#3c9628;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-success:focus .file-cta,html.theme--catppuccin-latte .file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(64,160,43,0.25);color:#fff}html.theme--catppuccin-latte .file.is-success:active .file-cta,html.theme--catppuccin-latte .file.is-success.is-active .file-cta{background-color:#388c26;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-warning .file-cta{background-color:#df8e1d;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-warning:hover .file-cta,html.theme--catppuccin-latte .file.is-warning.is-hovered .file-cta{background-color:#d4871c;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-warning:focus .file-cta,html.theme--catppuccin-latte .file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(223,142,29,0.25);color:#fff}html.theme--catppuccin-latte .file.is-warning:active .file-cta,html.theme--catppuccin-latte .file.is-warning.is-active .file-cta{background-color:#c8801a;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-danger .file-cta{background-color:#d20f39;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-danger:hover .file-cta,html.theme--catppuccin-latte .file.is-danger.is-hovered .file-cta{background-color:#c60e36;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-danger:focus .file-cta,html.theme--catppuccin-latte .file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(210,15,57,0.25);color:#fff}html.theme--catppuccin-latte .file.is-danger:active .file-cta,html.theme--catppuccin-latte .file.is-danger.is-active .file-cta{background-color:#ba0d33;border-color:transparent;color:#fff}html.theme--catppuccin-latte .file.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}html.theme--catppuccin-latte .file.is-normal{font-size:1rem}html.theme--catppuccin-latte .file.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .file.is-medium .file-icon .fa{font-size:21px}html.theme--catppuccin-latte .file.is-large{font-size:1.5rem}html.theme--catppuccin-latte .file.is-large .file-icon .fa{font-size:28px}html.theme--catppuccin-latte .file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-latte .file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-latte .file.has-name.is-empty .file-cta{border-radius:.4em}html.theme--catppuccin-latte .file.has-name.is-empty .file-name{display:none}html.theme--catppuccin-latte .file.is-boxed .file-label{flex-direction:column}html.theme--catppuccin-latte .file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}html.theme--catppuccin-latte .file.is-boxed .file-name{border-width:0 1px 1px}html.theme--catppuccin-latte .file.is-boxed .file-icon{height:1.5em;width:1.5em}html.theme--catppuccin-latte .file.is-boxed .file-icon .fa{font-size:21px}html.theme--catppuccin-latte .file.is-boxed.is-small .file-icon .fa,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}html.theme--catppuccin-latte .file.is-boxed.is-medium .file-icon .fa{font-size:28px}html.theme--catppuccin-latte .file.is-boxed.is-large .file-icon .fa{font-size:35px}html.theme--catppuccin-latte .file.is-boxed.has-name .file-cta{border-radius:.4em .4em 0 0}html.theme--catppuccin-latte .file.is-boxed.has-name .file-name{border-radius:0 0 .4em .4em;border-width:0 1px 1px}html.theme--catppuccin-latte .file.is-centered{justify-content:center}html.theme--catppuccin-latte .file.is-fullwidth .file-label{width:100%}html.theme--catppuccin-latte .file.is-fullwidth .file-name{flex-grow:1;max-width:none}html.theme--catppuccin-latte .file.is-right{justify-content:flex-end}html.theme--catppuccin-latte .file.is-right .file-cta{border-radius:0 .4em .4em 0}html.theme--catppuccin-latte .file.is-right .file-name{border-radius:.4em 0 0 .4em;border-width:1px 0 1px 1px;order:-1}html.theme--catppuccin-latte .file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}html.theme--catppuccin-latte .file-label:hover .file-cta{background-color:#c5c9d5;color:#41445a}html.theme--catppuccin-latte .file-label:hover .file-name{border-color:#a5a9b8}html.theme--catppuccin-latte .file-label:active .file-cta{background-color:#bdc2cf;color:#41445a}html.theme--catppuccin-latte .file-label:active .file-name{border-color:#9ea2b3}html.theme--catppuccin-latte .file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}html.theme--catppuccin-latte .file-cta,html.theme--catppuccin-latte .file-name{border-color:#acb0be;border-radius:.4em;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}html.theme--catppuccin-latte .file-cta{background-color:#ccd0da;color:#4c4f69}html.theme--catppuccin-latte .file-name{border-color:#acb0be;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}html.theme--catppuccin-latte .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}html.theme--catppuccin-latte .file-icon .fa{font-size:14px}html.theme--catppuccin-latte .label{color:#41445a;display:block;font-size:1rem;font-weight:700}html.theme--catppuccin-latte .label:not(:last-child){margin-bottom:0.5em}html.theme--catppuccin-latte .label.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}html.theme--catppuccin-latte .label.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .label.is-large{font-size:1.5rem}html.theme--catppuccin-latte .help{display:block;font-size:.75rem;margin-top:0.25rem}html.theme--catppuccin-latte .help.is-white{color:#fff}html.theme--catppuccin-latte .help.is-black{color:#0a0a0a}html.theme--catppuccin-latte .help.is-light{color:#f5f5f5}html.theme--catppuccin-latte .help.is-dark,html.theme--catppuccin-latte .content kbd.help{color:#ccd0da}html.theme--catppuccin-latte .help.is-primary,html.theme--catppuccin-latte .docstring>section>a.help.docs-sourcelink{color:#1e66f5}html.theme--catppuccin-latte .help.is-link{color:#1e66f5}html.theme--catppuccin-latte .help.is-info{color:#179299}html.theme--catppuccin-latte .help.is-success{color:#40a02b}html.theme--catppuccin-latte .help.is-warning{color:#df8e1d}html.theme--catppuccin-latte .help.is-danger{color:#d20f39}html.theme--catppuccin-latte .field:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-latte .field.has-addons{display:flex;justify-content:flex-start}html.theme--catppuccin-latte .field.has-addons .control:not(:last-child){margin-right:-1px}html.theme--catppuccin-latte .field.has-addons .control:not(:first-child):not(:last-child) .button,html.theme--catppuccin-latte .field.has-addons .control:not(:first-child):not(:last-child) .input,html.theme--catppuccin-latte .field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,html.theme--catppuccin-latte .field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}html.theme--catppuccin-latte .field.has-addons .control:first-child:not(:only-child) .button,html.theme--catppuccin-latte .field.has-addons .control:first-child:not(:only-child) .input,html.theme--catppuccin-latte .field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-latte .field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-latte .field.has-addons .control:last-child:not(:only-child) .button,html.theme--catppuccin-latte .field.has-addons .control:last-child:not(:only-child) .input,html.theme--catppuccin-latte .field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-latte .field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-latte .field.has-addons .control .button:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .button.is-hovered:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .input:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .input.is-hovered:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .select select:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}html.theme--catppuccin-latte .field.has-addons .control .button:not([disabled]):focus,html.theme--catppuccin-latte .field.has-addons .control .button.is-focused:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .button:not([disabled]):active,html.theme--catppuccin-latte .field.has-addons .control .button.is-active:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .input:not([disabled]):focus,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-latte .field.has-addons .control .input.is-focused:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .input:not([disabled]):active,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,html.theme--catppuccin-latte .field.has-addons .control .input.is-active:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .select select:not([disabled]):focus,html.theme--catppuccin-latte .field.has-addons .control .select select.is-focused:not([disabled]),html.theme--catppuccin-latte .field.has-addons .control .select select:not([disabled]):active,html.theme--catppuccin-latte .field.has-addons .control .select select.is-active:not([disabled]){z-index:3}html.theme--catppuccin-latte .field.has-addons .control .button:not([disabled]):focus:hover,html.theme--catppuccin-latte .field.has-addons .control .button.is-focused:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .button:not([disabled]):active:hover,html.theme--catppuccin-latte .field.has-addons .control .button.is-active:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .input:not([disabled]):focus:hover,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-latte .field.has-addons .control .input.is-focused:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .input:not([disabled]):active:hover,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-latte .field.has-addons .control .input.is-active:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-latte #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .select select:not([disabled]):focus:hover,html.theme--catppuccin-latte .field.has-addons .control .select select.is-focused:not([disabled]):hover,html.theme--catppuccin-latte .field.has-addons .control .select select:not([disabled]):active:hover,html.theme--catppuccin-latte .field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}html.theme--catppuccin-latte .field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .field.has-addons.has-addons-centered{justify-content:center}html.theme--catppuccin-latte .field.has-addons.has-addons-right{justify-content:flex-end}html.theme--catppuccin-latte .field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}html.theme--catppuccin-latte .field.is-grouped{display:flex;justify-content:flex-start}html.theme--catppuccin-latte .field.is-grouped>.control{flex-shrink:0}html.theme--catppuccin-latte .field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-latte .field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .field.is-grouped.is-grouped-centered{justify-content:center}html.theme--catppuccin-latte .field.is-grouped.is-grouped-right{justify-content:flex-end}html.theme--catppuccin-latte .field.is-grouped.is-grouped-multiline{flex-wrap:wrap}html.theme--catppuccin-latte .field.is-grouped.is-grouped-multiline>.control:last-child,html.theme--catppuccin-latte .field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-latte .field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}html.theme--catppuccin-latte .field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .field.is-horizontal{display:flex}}html.theme--catppuccin-latte .field-label .label{font-size:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-latte .field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}html.theme--catppuccin-latte .field-label.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}html.theme--catppuccin-latte .field-label.is-normal{padding-top:0.375em}html.theme--catppuccin-latte .field-label.is-medium{font-size:1.25rem;padding-top:0.375em}html.theme--catppuccin-latte .field-label.is-large{font-size:1.5rem;padding-top:0.375em}}html.theme--catppuccin-latte .field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}html.theme--catppuccin-latte .field-body .field{margin-bottom:0}html.theme--catppuccin-latte .field-body>.field{flex-shrink:1}html.theme--catppuccin-latte .field-body>.field:not(.is-narrow){flex-grow:1}html.theme--catppuccin-latte .field-body>.field:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-latte .control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}html.theme--catppuccin-latte .control.has-icons-left .input:focus~.icon,html.theme--catppuccin-latte .control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,html.theme--catppuccin-latte .control.has-icons-left .select:focus~.icon,html.theme--catppuccin-latte .control.has-icons-right .input:focus~.icon,html.theme--catppuccin-latte .control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,html.theme--catppuccin-latte .control.has-icons-right .select:focus~.icon{color:#ccd0da}html.theme--catppuccin-latte .control.has-icons-left .input.is-small~.icon,html.theme--catppuccin-latte .control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,html.theme--catppuccin-latte .control.has-icons-left .select.is-small~.icon,html.theme--catppuccin-latte .control.has-icons-right .input.is-small~.icon,html.theme--catppuccin-latte .control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,html.theme--catppuccin-latte .control.has-icons-right .select.is-small~.icon{font-size:.75rem}html.theme--catppuccin-latte .control.has-icons-left .input.is-medium~.icon,html.theme--catppuccin-latte .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,html.theme--catppuccin-latte .control.has-icons-left .select.is-medium~.icon,html.theme--catppuccin-latte .control.has-icons-right .input.is-medium~.icon,html.theme--catppuccin-latte .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,html.theme--catppuccin-latte .control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}html.theme--catppuccin-latte .control.has-icons-left .input.is-large~.icon,html.theme--catppuccin-latte .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,html.theme--catppuccin-latte .control.has-icons-left .select.is-large~.icon,html.theme--catppuccin-latte .control.has-icons-right .input.is-large~.icon,html.theme--catppuccin-latte .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,html.theme--catppuccin-latte .control.has-icons-right .select.is-large~.icon{font-size:1.5rem}html.theme--catppuccin-latte .control.has-icons-left .icon,html.theme--catppuccin-latte .control.has-icons-right .icon{color:#acb0be;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}html.theme--catppuccin-latte .control.has-icons-left .input,html.theme--catppuccin-latte .control.has-icons-left #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-left form.docs-search>input,html.theme--catppuccin-latte .control.has-icons-left .select select{padding-left:2.5em}html.theme--catppuccin-latte .control.has-icons-left .icon.is-left{left:0}html.theme--catppuccin-latte .control.has-icons-right .input,html.theme--catppuccin-latte .control.has-icons-right #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte #documenter .docs-sidebar .control.has-icons-right form.docs-search>input,html.theme--catppuccin-latte .control.has-icons-right .select select{padding-right:2.5em}html.theme--catppuccin-latte .control.has-icons-right .icon.is-right{right:0}html.theme--catppuccin-latte .control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}html.theme--catppuccin-latte .control.is-loading.is-small:after,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-latte .control.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-latte .control.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-latte .breadcrumb{font-size:1rem;white-space:nowrap}html.theme--catppuccin-latte .breadcrumb a{align-items:center;color:#1e66f5;display:flex;justify-content:center;padding:0 .75em}html.theme--catppuccin-latte .breadcrumb a:hover{color:#04a5e5}html.theme--catppuccin-latte .breadcrumb li{align-items:center;display:flex}html.theme--catppuccin-latte .breadcrumb li:first-child a{padding-left:0}html.theme--catppuccin-latte .breadcrumb li.is-active a{color:#41445a;cursor:default;pointer-events:none}html.theme--catppuccin-latte .breadcrumb li+li::before{color:#9ca0b0;content:"\0002f"}html.theme--catppuccin-latte .breadcrumb ul,html.theme--catppuccin-latte .breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-latte .breadcrumb .icon:first-child{margin-right:.5em}html.theme--catppuccin-latte .breadcrumb .icon:last-child{margin-left:.5em}html.theme--catppuccin-latte .breadcrumb.is-centered ol,html.theme--catppuccin-latte .breadcrumb.is-centered ul{justify-content:center}html.theme--catppuccin-latte .breadcrumb.is-right ol,html.theme--catppuccin-latte .breadcrumb.is-right ul{justify-content:flex-end}html.theme--catppuccin-latte .breadcrumb.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}html.theme--catppuccin-latte .breadcrumb.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .breadcrumb.is-large{font-size:1.5rem}html.theme--catppuccin-latte .breadcrumb.has-arrow-separator li+li::before{content:"\02192"}html.theme--catppuccin-latte .breadcrumb.has-bullet-separator li+li::before{content:"\02022"}html.theme--catppuccin-latte .breadcrumb.has-dot-separator li+li::before{content:"\000b7"}html.theme--catppuccin-latte .breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}html.theme--catppuccin-latte .card{background-color:#fff;border-radius:.25rem;box-shadow:#171717;color:#4c4f69;max-width:100%;position:relative}html.theme--catppuccin-latte .card-footer:first-child,html.theme--catppuccin-latte .card-content:first-child,html.theme--catppuccin-latte .card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-latte .card-footer:last-child,html.theme--catppuccin-latte .card-content:last-child,html.theme--catppuccin-latte .card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-latte .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}html.theme--catppuccin-latte .card-header-title{align-items:center;color:#41445a;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}html.theme--catppuccin-latte .card-header-title.is-centered{justify-content:center}html.theme--catppuccin-latte .card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}html.theme--catppuccin-latte .card-image{display:block;position:relative}html.theme--catppuccin-latte .card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-latte .card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-latte .card-content{background-color:rgba(0,0,0,0);padding:1.5rem}html.theme--catppuccin-latte .card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}html.theme--catppuccin-latte .card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}html.theme--catppuccin-latte .card-footer-item:not(:last-child){border-right:1px solid #ededed}html.theme--catppuccin-latte .card .media:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-latte .dropdown{display:inline-flex;position:relative;vertical-align:top}html.theme--catppuccin-latte .dropdown.is-active .dropdown-menu,html.theme--catppuccin-latte .dropdown.is-hoverable:hover .dropdown-menu{display:block}html.theme--catppuccin-latte .dropdown.is-right .dropdown-menu{left:auto;right:0}html.theme--catppuccin-latte .dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}html.theme--catppuccin-latte .dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}html.theme--catppuccin-latte .dropdown-content{background-color:#e6e9ef;border-radius:.4em;box-shadow:#171717;padding-bottom:.5rem;padding-top:.5rem}html.theme--catppuccin-latte .dropdown-item{color:#4c4f69;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}html.theme--catppuccin-latte a.dropdown-item,html.theme--catppuccin-latte button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}html.theme--catppuccin-latte a.dropdown-item:hover,html.theme--catppuccin-latte button.dropdown-item:hover{background-color:#e6e9ef;color:#0a0a0a}html.theme--catppuccin-latte a.dropdown-item.is-active,html.theme--catppuccin-latte button.dropdown-item.is-active{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}html.theme--catppuccin-latte .level{align-items:center;justify-content:space-between}html.theme--catppuccin-latte .level code{border-radius:.4em}html.theme--catppuccin-latte .level img{display:inline-block;vertical-align:top}html.theme--catppuccin-latte .level.is-mobile{display:flex}html.theme--catppuccin-latte .level.is-mobile .level-left,html.theme--catppuccin-latte .level.is-mobile .level-right{display:flex}html.theme--catppuccin-latte .level.is-mobile .level-left+.level-right{margin-top:0}html.theme--catppuccin-latte .level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-latte .level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .level{display:flex}html.theme--catppuccin-latte .level>.level-item:not(.is-narrow){flex-grow:1}}html.theme--catppuccin-latte .level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}html.theme--catppuccin-latte .level-item .title,html.theme--catppuccin-latte .level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){html.theme--catppuccin-latte .level-item:not(:last-child){margin-bottom:.75rem}}html.theme--catppuccin-latte .level-left,html.theme--catppuccin-latte .level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-latte .level-left .level-item.is-flexible,html.theme--catppuccin-latte .level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .level-left .level-item:not(:last-child),html.theme--catppuccin-latte .level-right .level-item:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-latte .level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){html.theme--catppuccin-latte .level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .level-left{display:flex}}html.theme--catppuccin-latte .level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .level-right{display:flex}}html.theme--catppuccin-latte .media{align-items:flex-start;display:flex;text-align:inherit}html.theme--catppuccin-latte .media .content:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-latte .media .media{border-top:1px solid rgba(172,176,190,0.5);display:flex;padding-top:.75rem}html.theme--catppuccin-latte .media .media .content:not(:last-child),html.theme--catppuccin-latte .media .media .control:not(:last-child){margin-bottom:.5rem}html.theme--catppuccin-latte .media .media .media{padding-top:.5rem}html.theme--catppuccin-latte .media .media .media+.media{margin-top:.5rem}html.theme--catppuccin-latte .media+.media{border-top:1px solid rgba(172,176,190,0.5);margin-top:1rem;padding-top:1rem}html.theme--catppuccin-latte .media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}html.theme--catppuccin-latte .media-left,html.theme--catppuccin-latte .media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-latte .media-left{margin-right:1rem}html.theme--catppuccin-latte .media-right{margin-left:1rem}html.theme--catppuccin-latte .media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-latte .media-content{overflow-x:auto}}html.theme--catppuccin-latte .menu{font-size:1rem}html.theme--catppuccin-latte .menu.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}html.theme--catppuccin-latte .menu.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .menu.is-large{font-size:1.5rem}html.theme--catppuccin-latte .menu-list{line-height:1.25}html.theme--catppuccin-latte .menu-list a{border-radius:3px;color:#4c4f69;display:block;padding:0.5em 0.75em}html.theme--catppuccin-latte .menu-list a:hover{background-color:#e6e9ef;color:#41445a}html.theme--catppuccin-latte .menu-list a.is-active{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .menu-list li ul{border-left:1px solid #acb0be;margin:.75em;padding-left:.75em}html.theme--catppuccin-latte .menu-label{color:#616587;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}html.theme--catppuccin-latte .menu-label:not(:first-child){margin-top:1em}html.theme--catppuccin-latte .menu-label:not(:last-child){margin-bottom:1em}html.theme--catppuccin-latte .message{background-color:#e6e9ef;border-radius:.4em;font-size:1rem}html.theme--catppuccin-latte .message strong{color:currentColor}html.theme--catppuccin-latte .message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-latte .message.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}html.theme--catppuccin-latte .message.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .message.is-large{font-size:1.5rem}html.theme--catppuccin-latte .message.is-white{background-color:#fff}html.theme--catppuccin-latte .message.is-white .message-header{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .message.is-white .message-body{border-color:#fff}html.theme--catppuccin-latte .message.is-black{background-color:#fafafa}html.theme--catppuccin-latte .message.is-black .message-header{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .message.is-black .message-body{border-color:#0a0a0a}html.theme--catppuccin-latte .message.is-light{background-color:#fafafa}html.theme--catppuccin-latte .message.is-light .message-header{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .message.is-light .message-body{border-color:#f5f5f5}html.theme--catppuccin-latte .message.is-dark,html.theme--catppuccin-latte .content kbd.message{background-color:#f9fafb}html.theme--catppuccin-latte .message.is-dark .message-header,html.theme--catppuccin-latte .content kbd.message .message-header{background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .message.is-dark .message-body,html.theme--catppuccin-latte .content kbd.message .message-body{border-color:#ccd0da}html.theme--catppuccin-latte .message.is-primary,html.theme--catppuccin-latte .docstring>section>a.message.docs-sourcelink{background-color:#ebf2fe}html.theme--catppuccin-latte .message.is-primary .message-header,html.theme--catppuccin-latte .docstring>section>a.message.docs-sourcelink .message-header{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .message.is-primary .message-body,html.theme--catppuccin-latte .docstring>section>a.message.docs-sourcelink .message-body{border-color:#1e66f5;color:#0a52e1}html.theme--catppuccin-latte .message.is-link{background-color:#ebf2fe}html.theme--catppuccin-latte .message.is-link .message-header{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .message.is-link .message-body{border-color:#1e66f5;color:#0a52e1}html.theme--catppuccin-latte .message.is-info{background-color:#edfcfc}html.theme--catppuccin-latte .message.is-info .message-header{background-color:#179299;color:#fff}html.theme--catppuccin-latte .message.is-info .message-body{border-color:#179299;color:#1cb2ba}html.theme--catppuccin-latte .message.is-success{background-color:#f1fbef}html.theme--catppuccin-latte .message.is-success .message-header{background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .message.is-success .message-body{border-color:#40a02b;color:#40a12b}html.theme--catppuccin-latte .message.is-warning{background-color:#fdf6ed}html.theme--catppuccin-latte .message.is-warning .message-header{background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .message.is-warning .message-body{border-color:#df8e1d;color:#9e6515}html.theme--catppuccin-latte .message.is-danger{background-color:#feecf0}html.theme--catppuccin-latte .message.is-danger .message-header{background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .message.is-danger .message-body{border-color:#d20f39;color:#e9113f}html.theme--catppuccin-latte .message-header{align-items:center;background-color:#4c4f69;border-radius:.4em .4em 0 0;color:#fff;display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}html.theme--catppuccin-latte .message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}html.theme--catppuccin-latte .message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}html.theme--catppuccin-latte .message-body{border-color:#acb0be;border-radius:.4em;border-style:solid;border-width:0 0 0 4px;color:#4c4f69;padding:1.25em 1.5em}html.theme--catppuccin-latte .message-body code,html.theme--catppuccin-latte .message-body pre{background-color:#fff}html.theme--catppuccin-latte .message-body pre code{background-color:rgba(0,0,0,0)}html.theme--catppuccin-latte .modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}html.theme--catppuccin-latte .modal.is-active{display:flex}html.theme--catppuccin-latte .modal-background{background-color:rgba(10,10,10,0.86)}html.theme--catppuccin-latte .modal-content,html.theme--catppuccin-latte .modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){html.theme--catppuccin-latte .modal-content,html.theme--catppuccin-latte .modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}html.theme--catppuccin-latte .modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}html.theme--catppuccin-latte .modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}html.theme--catppuccin-latte .modal-card-head,html.theme--catppuccin-latte .modal-card-foot{align-items:center;background-color:#e6e9ef;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}html.theme--catppuccin-latte .modal-card-head{border-bottom:1px solid #acb0be;border-top-left-radius:8px;border-top-right-radius:8px}html.theme--catppuccin-latte .modal-card-title{color:#4c4f69;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}html.theme--catppuccin-latte .modal-card-foot{border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid #acb0be}html.theme--catppuccin-latte .modal-card-foot .button:not(:last-child){margin-right:.5em}html.theme--catppuccin-latte .modal-card-body{-webkit-overflow-scrolling:touch;background-color:#eff1f5;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}html.theme--catppuccin-latte .navbar{background-color:#1e66f5;min-height:4rem;position:relative;z-index:30}html.theme--catppuccin-latte .navbar.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-white .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-white .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-white .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-white .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-white .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-white .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-white .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-white .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-latte .navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}html.theme--catppuccin-latte .navbar.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-black .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-black .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-black .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-black .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-black .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-black .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-black .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-black .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-black .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-black .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}html.theme--catppuccin-latte .navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}html.theme--catppuccin-latte .navbar.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-light .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-light .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-light .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-light .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-light .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-light .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-light .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-light .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-light .navbar-end .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-latte .navbar.is-dark,html.theme--catppuccin-latte .content kbd.navbar{background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-brand>.navbar-item,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-brand .navbar-link.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#bdc2cf;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-brand .navbar-link::after,html.theme--catppuccin-latte .content kbd.navbar .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-burger,html.theme--catppuccin-latte .content kbd.navbar .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-dark .navbar-start>.navbar-item,html.theme--catppuccin-latte .content kbd.navbar .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-dark .navbar-start .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-dark .navbar-end>.navbar-item,html.theme--catppuccin-latte .content kbd.navbar .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-dark .navbar-end .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-dark .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-dark .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-dark .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .content kbd.navbar .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-dark .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .content kbd.navbar .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-dark .navbar-end .navbar-link.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#bdc2cf;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-start .navbar-link::after,html.theme--catppuccin-latte .content kbd.navbar .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-dark .navbar-end .navbar-link::after,html.theme--catppuccin-latte .content kbd.navbar .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-latte .content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#bdc2cf;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .navbar.is-dark .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-latte .content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#ccd0da;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-latte .navbar.is-primary,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-brand>.navbar-item,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-brand .navbar-link.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-brand .navbar-link::after,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-burger,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-primary .navbar-start>.navbar-item,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-primary .navbar-start .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-primary .navbar-end>.navbar-item,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-primary .navbar-end .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-primary .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-primary .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-primary .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-primary .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-primary .navbar-end .navbar-link.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-start .navbar-link::after,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-primary .navbar-end .navbar-link::after,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#1e66f5;color:#fff}}html.theme--catppuccin-latte .navbar.is-link{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-link .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-link .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-link .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-link .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-link .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-link .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-link .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-link .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-link .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-link .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-link .navbar-end .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#1e66f5;color:#fff}}html.theme--catppuccin-latte .navbar.is-info{background-color:#179299;color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-info .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-info .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#147d83;color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-info .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-info .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-info .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-info .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-info .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-info .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-info .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-info .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-info .navbar-end .navbar-link.is-active{background-color:#147d83;color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-info .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#147d83;color:#fff}html.theme--catppuccin-latte .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#179299;color:#fff}}html.theme--catppuccin-latte .navbar.is-success{background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-success .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-success .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#388c26;color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-success .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-success .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-success .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-success .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-success .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-success .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-success .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-success .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-success .navbar-end .navbar-link.is-active{background-color:#388c26;color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-success .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#388c26;color:#fff}html.theme--catppuccin-latte .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#40a02b;color:#fff}}html.theme--catppuccin-latte .navbar.is-warning{background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#c8801a;color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-warning .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-warning .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-warning .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-warning .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-warning .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-warning .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-warning .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-warning .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#c8801a;color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-warning .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#c8801a;color:#fff}html.theme--catppuccin-latte .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#df8e1d;color:#fff}}html.theme--catppuccin-latte .navbar.is-danger{background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-brand>.navbar-item,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#ba0d33;color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar.is-danger .navbar-start>.navbar-item,html.theme--catppuccin-latte .navbar.is-danger .navbar-start .navbar-link,html.theme--catppuccin-latte .navbar.is-danger .navbar-end>.navbar-item,html.theme--catppuccin-latte .navbar.is-danger .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-start>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-start>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-danger .navbar-start .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-start .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-start .navbar-link.is-active,html.theme--catppuccin-latte .navbar.is-danger .navbar-end>a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-end>a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-danger .navbar-end .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-danger .navbar-end .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#ba0d33;color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-start .navbar-link::after,html.theme--catppuccin-latte .navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#ba0d33;color:#fff}html.theme--catppuccin-latte .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#d20f39;color:#fff}}html.theme--catppuccin-latte .navbar>.container{align-items:stretch;display:flex;min-height:4rem;width:100%}html.theme--catppuccin-latte .navbar.has-shadow{box-shadow:0 2px 0 0 #e6e9ef}html.theme--catppuccin-latte .navbar.is-fixed-bottom,html.theme--catppuccin-latte .navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-latte .navbar.is-fixed-bottom{bottom:0}html.theme--catppuccin-latte .navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #e6e9ef}html.theme--catppuccin-latte .navbar.is-fixed-top{top:0}html.theme--catppuccin-latte html.has-navbar-fixed-top,html.theme--catppuccin-latte body.has-navbar-fixed-top{padding-top:4rem}html.theme--catppuccin-latte html.has-navbar-fixed-bottom,html.theme--catppuccin-latte body.has-navbar-fixed-bottom{padding-bottom:4rem}html.theme--catppuccin-latte .navbar-brand,html.theme--catppuccin-latte .navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:4rem}html.theme--catppuccin-latte .navbar-brand a.navbar-item:focus,html.theme--catppuccin-latte .navbar-brand a.navbar-item:hover{background-color:transparent}html.theme--catppuccin-latte .navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}html.theme--catppuccin-latte .navbar-burger{color:#4c4f69;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:4rem;position:relative;width:4rem;margin-left:auto}html.theme--catppuccin-latte .navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}html.theme--catppuccin-latte .navbar-burger span:nth-child(1){top:calc(50% - 6px)}html.theme--catppuccin-latte .navbar-burger span:nth-child(2){top:calc(50% - 1px)}html.theme--catppuccin-latte .navbar-burger span:nth-child(3){top:calc(50% + 4px)}html.theme--catppuccin-latte .navbar-burger:hover{background-color:rgba(0,0,0,0.05)}html.theme--catppuccin-latte .navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}html.theme--catppuccin-latte .navbar-burger.is-active span:nth-child(2){opacity:0}html.theme--catppuccin-latte .navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}html.theme--catppuccin-latte .navbar-menu{display:none}html.theme--catppuccin-latte .navbar-item,html.theme--catppuccin-latte .navbar-link{color:#4c4f69;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}html.theme--catppuccin-latte .navbar-item .icon:only-child,html.theme--catppuccin-latte .navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}html.theme--catppuccin-latte a.navbar-item,html.theme--catppuccin-latte .navbar-link{cursor:pointer}html.theme--catppuccin-latte a.navbar-item:focus,html.theme--catppuccin-latte a.navbar-item:focus-within,html.theme--catppuccin-latte a.navbar-item:hover,html.theme--catppuccin-latte a.navbar-item.is-active,html.theme--catppuccin-latte .navbar-link:focus,html.theme--catppuccin-latte .navbar-link:focus-within,html.theme--catppuccin-latte .navbar-link:hover,html.theme--catppuccin-latte .navbar-link.is-active{background-color:rgba(0,0,0,0);color:#1e66f5}html.theme--catppuccin-latte .navbar-item{flex-grow:0;flex-shrink:0}html.theme--catppuccin-latte .navbar-item img{max-height:1.75rem}html.theme--catppuccin-latte .navbar-item.has-dropdown{padding:0}html.theme--catppuccin-latte .navbar-item.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .navbar-item.is-tab{border-bottom:1px solid transparent;min-height:4rem;padding-bottom:calc(0.5rem - 1px)}html.theme--catppuccin-latte .navbar-item.is-tab:focus,html.theme--catppuccin-latte .navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#1e66f5}html.theme--catppuccin-latte .navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#1e66f5;border-bottom-style:solid;border-bottom-width:3px;color:#1e66f5;padding-bottom:calc(0.5rem - 3px)}html.theme--catppuccin-latte .navbar-content{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .navbar-link:not(.is-arrowless){padding-right:2.5em}html.theme--catppuccin-latte .navbar-link:not(.is-arrowless)::after{border-color:#fff;margin-top:-0.375em;right:1.125em}html.theme--catppuccin-latte .navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}html.theme--catppuccin-latte .navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}html.theme--catppuccin-latte .navbar-divider{background-color:rgba(0,0,0,0.2);border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .navbar>.container{display:block}html.theme--catppuccin-latte .navbar-brand .navbar-item,html.theme--catppuccin-latte .navbar-tabs .navbar-item{align-items:center;display:flex}html.theme--catppuccin-latte .navbar-link::after{display:none}html.theme--catppuccin-latte .navbar-menu{background-color:#1e66f5;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}html.theme--catppuccin-latte .navbar-menu.is-active{display:block}html.theme--catppuccin-latte .navbar.is-fixed-bottom-touch,html.theme--catppuccin-latte .navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-latte .navbar.is-fixed-bottom-touch{bottom:0}html.theme--catppuccin-latte .navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-latte .navbar.is-fixed-top-touch{top:0}html.theme--catppuccin-latte .navbar.is-fixed-top .navbar-menu,html.theme--catppuccin-latte .navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 4rem);overflow:auto}html.theme--catppuccin-latte html.has-navbar-fixed-top-touch,html.theme--catppuccin-latte body.has-navbar-fixed-top-touch{padding-top:4rem}html.theme--catppuccin-latte html.has-navbar-fixed-bottom-touch,html.theme--catppuccin-latte body.has-navbar-fixed-bottom-touch{padding-bottom:4rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .navbar,html.theme--catppuccin-latte .navbar-menu,html.theme--catppuccin-latte .navbar-start,html.theme--catppuccin-latte .navbar-end{align-items:stretch;display:flex}html.theme--catppuccin-latte .navbar{min-height:4rem}html.theme--catppuccin-latte .navbar.is-spaced{padding:1rem 2rem}html.theme--catppuccin-latte .navbar.is-spaced .navbar-start,html.theme--catppuccin-latte .navbar.is-spaced .navbar-end{align-items:center}html.theme--catppuccin-latte .navbar.is-spaced a.navbar-item,html.theme--catppuccin-latte .navbar.is-spaced .navbar-link{border-radius:.4em}html.theme--catppuccin-latte .navbar.is-transparent a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-transparent a.navbar-item:hover,html.theme--catppuccin-latte .navbar.is-transparent a.navbar-item.is-active,html.theme--catppuccin-latte .navbar.is-transparent .navbar-link:focus,html.theme--catppuccin-latte .navbar.is-transparent .navbar-link:hover,html.theme--catppuccin-latte .navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}html.theme--catppuccin-latte .navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-latte .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,html.theme--catppuccin-latte .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,html.theme--catppuccin-latte .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}html.theme--catppuccin-latte .navbar.is-transparent .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-latte .navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#8c8fa1}html.theme--catppuccin-latte .navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#1e66f5}html.theme--catppuccin-latte .navbar-burger{display:none}html.theme--catppuccin-latte .navbar-item,html.theme--catppuccin-latte .navbar-link{align-items:center;display:flex}html.theme--catppuccin-latte .navbar-item.has-dropdown{align-items:stretch}html.theme--catppuccin-latte .navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}html.theme--catppuccin-latte .navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:1px solid rgba(0,0,0,0.2);border-radius:8px 8px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}html.theme--catppuccin-latte .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced html.theme--catppuccin-latte .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-latte .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-latte .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-latte .navbar-item.is-hoverable:hover .navbar-dropdown,html.theme--catppuccin-latte .navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}html.theme--catppuccin-latte .navbar-menu{flex-grow:1;flex-shrink:0}html.theme--catppuccin-latte .navbar-start{justify-content:flex-start;margin-right:auto}html.theme--catppuccin-latte .navbar-end{justify-content:flex-end;margin-left:auto}html.theme--catppuccin-latte .navbar-dropdown{background-color:#1e66f5;border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid rgba(0,0,0,0.2);box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}html.theme--catppuccin-latte .navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}html.theme--catppuccin-latte .navbar-dropdown a.navbar-item{padding-right:3rem}html.theme--catppuccin-latte .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-latte .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#8c8fa1}html.theme--catppuccin-latte .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#1e66f5}.navbar.is-spaced html.theme--catppuccin-latte .navbar-dropdown,html.theme--catppuccin-latte .navbar-dropdown.is-boxed{border-radius:8px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}html.theme--catppuccin-latte .navbar-dropdown.is-right{left:auto;right:0}html.theme--catppuccin-latte .navbar-divider{display:block}html.theme--catppuccin-latte .navbar>.container .navbar-brand,html.theme--catppuccin-latte .container>.navbar .navbar-brand{margin-left:-.75rem}html.theme--catppuccin-latte .navbar>.container .navbar-menu,html.theme--catppuccin-latte .container>.navbar .navbar-menu{margin-right:-.75rem}html.theme--catppuccin-latte .navbar.is-fixed-bottom-desktop,html.theme--catppuccin-latte .navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-latte .navbar.is-fixed-bottom-desktop{bottom:0}html.theme--catppuccin-latte .navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-latte .navbar.is-fixed-top-desktop{top:0}html.theme--catppuccin-latte html.has-navbar-fixed-top-desktop,html.theme--catppuccin-latte body.has-navbar-fixed-top-desktop{padding-top:4rem}html.theme--catppuccin-latte html.has-navbar-fixed-bottom-desktop,html.theme--catppuccin-latte body.has-navbar-fixed-bottom-desktop{padding-bottom:4rem}html.theme--catppuccin-latte html.has-spaced-navbar-fixed-top,html.theme--catppuccin-latte body.has-spaced-navbar-fixed-top{padding-top:6rem}html.theme--catppuccin-latte html.has-spaced-navbar-fixed-bottom,html.theme--catppuccin-latte body.has-spaced-navbar-fixed-bottom{padding-bottom:6rem}html.theme--catppuccin-latte a.navbar-item.is-active,html.theme--catppuccin-latte .navbar-link.is-active{color:#1e66f5}html.theme--catppuccin-latte a.navbar-item.is-active:not(:focus):not(:hover),html.theme--catppuccin-latte .navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}html.theme--catppuccin-latte .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-latte .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-latte .navbar-item.has-dropdown.is-active .navbar-link{background-color:rgba(0,0,0,0)}}html.theme--catppuccin-latte .hero.is-fullheight-with-navbar{min-height:calc(100vh - 4rem)}html.theme--catppuccin-latte .pagination{font-size:1rem;margin:-.25rem}html.theme--catppuccin-latte .pagination.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}html.theme--catppuccin-latte .pagination.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .pagination.is-large{font-size:1.5rem}html.theme--catppuccin-latte .pagination.is-rounded .pagination-previous,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,html.theme--catppuccin-latte .pagination.is-rounded .pagination-next,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}html.theme--catppuccin-latte .pagination.is-rounded .pagination-link,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}html.theme--catppuccin-latte .pagination,html.theme--catppuccin-latte .pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte .pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-link{border-color:#acb0be;color:#1e66f5;min-width:2.5em}html.theme--catppuccin-latte .pagination-previous:hover,html.theme--catppuccin-latte .pagination-next:hover,html.theme--catppuccin-latte .pagination-link:hover{border-color:#9ca0b0;color:#04a5e5}html.theme--catppuccin-latte .pagination-previous:focus,html.theme--catppuccin-latte .pagination-next:focus,html.theme--catppuccin-latte .pagination-link:focus{border-color:#9ca0b0}html.theme--catppuccin-latte .pagination-previous:active,html.theme--catppuccin-latte .pagination-next:active,html.theme--catppuccin-latte .pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}html.theme--catppuccin-latte .pagination-previous[disabled],html.theme--catppuccin-latte .pagination-previous.is-disabled,html.theme--catppuccin-latte .pagination-next[disabled],html.theme--catppuccin-latte .pagination-next.is-disabled,html.theme--catppuccin-latte .pagination-link[disabled],html.theme--catppuccin-latte .pagination-link.is-disabled{background-color:#acb0be;border-color:#acb0be;box-shadow:none;color:#616587;opacity:0.5}html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}html.theme--catppuccin-latte .pagination-link.is-current{background-color:#1e66f5;border-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .pagination-ellipsis{color:#9ca0b0;pointer-events:none}html.theme--catppuccin-latte .pagination-list{flex-wrap:wrap}html.theme--catppuccin-latte .pagination-list li{list-style:none}@media screen and (max-width: 768px){html.theme--catppuccin-latte .pagination{flex-wrap:wrap}html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte .pagination-ellipsis{margin-bottom:0;margin-top:0}html.theme--catppuccin-latte .pagination-previous{order:2}html.theme--catppuccin-latte .pagination-next{order:3}html.theme--catppuccin-latte .pagination{justify-content:space-between;margin-bottom:0;margin-top:0}html.theme--catppuccin-latte .pagination.is-centered .pagination-previous{order:1}html.theme--catppuccin-latte .pagination.is-centered .pagination-list{justify-content:center;order:2}html.theme--catppuccin-latte .pagination.is-centered .pagination-next{order:3}html.theme--catppuccin-latte .pagination.is-right .pagination-previous{order:1}html.theme--catppuccin-latte .pagination.is-right .pagination-next{order:2}html.theme--catppuccin-latte .pagination.is-right .pagination-list{justify-content:flex-end;order:3}}html.theme--catppuccin-latte .panel{border-radius:8px;box-shadow:#171717;font-size:1rem}html.theme--catppuccin-latte .panel:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-latte .panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}html.theme--catppuccin-latte .panel.is-white .panel-block.is-active .panel-icon{color:#fff}html.theme--catppuccin-latte .panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}html.theme--catppuccin-latte .panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}html.theme--catppuccin-latte .panel.is-light .panel-heading{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .panel.is-light .panel-tabs a.is-active{border-bottom-color:#f5f5f5}html.theme--catppuccin-latte .panel.is-light .panel-block.is-active .panel-icon{color:#f5f5f5}html.theme--catppuccin-latte .panel.is-dark .panel-heading,html.theme--catppuccin-latte .content kbd.panel .panel-heading{background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .panel.is-dark .panel-tabs a.is-active,html.theme--catppuccin-latte .content kbd.panel .panel-tabs a.is-active{border-bottom-color:#ccd0da}html.theme--catppuccin-latte .panel.is-dark .panel-block.is-active .panel-icon,html.theme--catppuccin-latte .content kbd.panel .panel-block.is-active .panel-icon{color:#ccd0da}html.theme--catppuccin-latte .panel.is-primary .panel-heading,html.theme--catppuccin-latte .docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .panel.is-primary .panel-tabs a.is-active,html.theme--catppuccin-latte .docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#1e66f5}html.theme--catppuccin-latte .panel.is-primary .panel-block.is-active .panel-icon,html.theme--catppuccin-latte .docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#1e66f5}html.theme--catppuccin-latte .panel.is-link .panel-heading{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .panel.is-link .panel-tabs a.is-active{border-bottom-color:#1e66f5}html.theme--catppuccin-latte .panel.is-link .panel-block.is-active .panel-icon{color:#1e66f5}html.theme--catppuccin-latte .panel.is-info .panel-heading{background-color:#179299;color:#fff}html.theme--catppuccin-latte .panel.is-info .panel-tabs a.is-active{border-bottom-color:#179299}html.theme--catppuccin-latte .panel.is-info .panel-block.is-active .panel-icon{color:#179299}html.theme--catppuccin-latte .panel.is-success .panel-heading{background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .panel.is-success .panel-tabs a.is-active{border-bottom-color:#40a02b}html.theme--catppuccin-latte .panel.is-success .panel-block.is-active .panel-icon{color:#40a02b}html.theme--catppuccin-latte .panel.is-warning .panel-heading{background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .panel.is-warning .panel-tabs a.is-active{border-bottom-color:#df8e1d}html.theme--catppuccin-latte .panel.is-warning .panel-block.is-active .panel-icon{color:#df8e1d}html.theme--catppuccin-latte .panel.is-danger .panel-heading{background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .panel.is-danger .panel-tabs a.is-active{border-bottom-color:#d20f39}html.theme--catppuccin-latte .panel.is-danger .panel-block.is-active .panel-icon{color:#d20f39}html.theme--catppuccin-latte .panel-tabs:not(:last-child),html.theme--catppuccin-latte .panel-block:not(:last-child){border-bottom:1px solid #ededed}html.theme--catppuccin-latte .panel-heading{background-color:#bcc0cc;border-radius:8px 8px 0 0;color:#41445a;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}html.theme--catppuccin-latte .panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}html.theme--catppuccin-latte .panel-tabs a{border-bottom:1px solid #acb0be;margin-bottom:-1px;padding:0.5em}html.theme--catppuccin-latte .panel-tabs a.is-active{border-bottom-color:#bcc0cc;color:#0b57ef}html.theme--catppuccin-latte .panel-list a{color:#4c4f69}html.theme--catppuccin-latte .panel-list a:hover{color:#1e66f5}html.theme--catppuccin-latte .panel-block{align-items:center;color:#41445a;display:flex;justify-content:flex-start;padding:0.5em 0.75em}html.theme--catppuccin-latte .panel-block input[type="checkbox"]{margin-right:.75em}html.theme--catppuccin-latte .panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}html.theme--catppuccin-latte .panel-block.is-wrapped{flex-wrap:wrap}html.theme--catppuccin-latte .panel-block.is-active{border-left-color:#1e66f5;color:#0b57ef}html.theme--catppuccin-latte .panel-block.is-active .panel-icon{color:#1e66f5}html.theme--catppuccin-latte .panel-block:last-child{border-bottom-left-radius:8px;border-bottom-right-radius:8px}html.theme--catppuccin-latte a.panel-block,html.theme--catppuccin-latte label.panel-block{cursor:pointer}html.theme--catppuccin-latte a.panel-block:hover,html.theme--catppuccin-latte label.panel-block:hover{background-color:#e6e9ef}html.theme--catppuccin-latte .panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#616587;margin-right:.75em}html.theme--catppuccin-latte .panel-icon .fa{font-size:inherit;line-height:inherit}html.theme--catppuccin-latte .tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}html.theme--catppuccin-latte .tabs a{align-items:center;border-bottom-color:#acb0be;border-bottom-style:solid;border-bottom-width:1px;color:#4c4f69;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}html.theme--catppuccin-latte .tabs a:hover{border-bottom-color:#41445a;color:#41445a}html.theme--catppuccin-latte .tabs li{display:block}html.theme--catppuccin-latte .tabs li.is-active a{border-bottom-color:#1e66f5;color:#1e66f5}html.theme--catppuccin-latte .tabs ul{align-items:center;border-bottom-color:#acb0be;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}html.theme--catppuccin-latte .tabs ul.is-left{padding-right:0.75em}html.theme--catppuccin-latte .tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}html.theme--catppuccin-latte .tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}html.theme--catppuccin-latte .tabs .icon:first-child{margin-right:.5em}html.theme--catppuccin-latte .tabs .icon:last-child{margin-left:.5em}html.theme--catppuccin-latte .tabs.is-centered ul{justify-content:center}html.theme--catppuccin-latte .tabs.is-right ul{justify-content:flex-end}html.theme--catppuccin-latte .tabs.is-boxed a{border:1px solid transparent;border-radius:.4em .4em 0 0}html.theme--catppuccin-latte .tabs.is-boxed a:hover{background-color:#e6e9ef;border-bottom-color:#acb0be}html.theme--catppuccin-latte .tabs.is-boxed li.is-active a{background-color:#fff;border-color:#acb0be;border-bottom-color:rgba(0,0,0,0) !important}html.theme--catppuccin-latte .tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}html.theme--catppuccin-latte .tabs.is-toggle a{border-color:#acb0be;border-style:solid;border-width:1px;margin-bottom:0;position:relative}html.theme--catppuccin-latte .tabs.is-toggle a:hover{background-color:#e6e9ef;border-color:#9ca0b0;z-index:2}html.theme--catppuccin-latte .tabs.is-toggle li+li{margin-left:-1px}html.theme--catppuccin-latte .tabs.is-toggle li:first-child a{border-top-left-radius:.4em;border-bottom-left-radius:.4em}html.theme--catppuccin-latte .tabs.is-toggle li:last-child a{border-top-right-radius:.4em;border-bottom-right-radius:.4em}html.theme--catppuccin-latte .tabs.is-toggle li.is-active a{background-color:#1e66f5;border-color:#1e66f5;color:#fff;z-index:1}html.theme--catppuccin-latte .tabs.is-toggle ul{border-bottom:none}html.theme--catppuccin-latte .tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}html.theme--catppuccin-latte .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}html.theme--catppuccin-latte .tabs.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}html.theme--catppuccin-latte .tabs.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .tabs.is-large{font-size:1.5rem}html.theme--catppuccin-latte .column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>html.theme--catppuccin-latte .column.is-narrow{flex:none;width:unset}.columns.is-mobile>html.theme--catppuccin-latte .column.is-full{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-half{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-half{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-0{flex:none;width:0%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-0{margin-left:0%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-3{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-3{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-6{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-6{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-9{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-9{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-12{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-latte .column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){html.theme--catppuccin-latte .column.is-narrow-mobile{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full-mobile{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters-mobile{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds-mobile{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half-mobile{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third-mobile{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter-mobile{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth-mobile{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths-mobile{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths-mobile{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths-mobile{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters-mobile{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds-mobile{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half-mobile{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third-mobile{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter-mobile{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth-mobile{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths-mobile{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths-mobile{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths-mobile{margin-left:80%}html.theme--catppuccin-latte .column.is-0-mobile{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0-mobile{margin-left:0%}html.theme--catppuccin-latte .column.is-1-mobile{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1-mobile{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2-mobile{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2-mobile{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3-mobile{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3-mobile{margin-left:25%}html.theme--catppuccin-latte .column.is-4-mobile{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4-mobile{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5-mobile{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5-mobile{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6-mobile{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6-mobile{margin-left:50%}html.theme--catppuccin-latte .column.is-7-mobile{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7-mobile{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8-mobile{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8-mobile{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9-mobile{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9-mobile{margin-left:75%}html.theme--catppuccin-latte .column.is-10-mobile{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10-mobile{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11-mobile{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11-mobile{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12-mobile{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .column.is-narrow,html.theme--catppuccin-latte .column.is-narrow-tablet{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full,html.theme--catppuccin-latte .column.is-full-tablet{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters,html.theme--catppuccin-latte .column.is-three-quarters-tablet{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds,html.theme--catppuccin-latte .column.is-two-thirds-tablet{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half,html.theme--catppuccin-latte .column.is-half-tablet{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third,html.theme--catppuccin-latte .column.is-one-third-tablet{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter,html.theme--catppuccin-latte .column.is-one-quarter-tablet{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth,html.theme--catppuccin-latte .column.is-one-fifth-tablet{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths,html.theme--catppuccin-latte .column.is-two-fifths-tablet{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths,html.theme--catppuccin-latte .column.is-three-fifths-tablet{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths,html.theme--catppuccin-latte .column.is-four-fifths-tablet{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters,html.theme--catppuccin-latte .column.is-offset-three-quarters-tablet{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds,html.theme--catppuccin-latte .column.is-offset-two-thirds-tablet{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half,html.theme--catppuccin-latte .column.is-offset-half-tablet{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third,html.theme--catppuccin-latte .column.is-offset-one-third-tablet{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter,html.theme--catppuccin-latte .column.is-offset-one-quarter-tablet{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth,html.theme--catppuccin-latte .column.is-offset-one-fifth-tablet{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths,html.theme--catppuccin-latte .column.is-offset-two-fifths-tablet{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths,html.theme--catppuccin-latte .column.is-offset-three-fifths-tablet{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths,html.theme--catppuccin-latte .column.is-offset-four-fifths-tablet{margin-left:80%}html.theme--catppuccin-latte .column.is-0,html.theme--catppuccin-latte .column.is-0-tablet{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0,html.theme--catppuccin-latte .column.is-offset-0-tablet{margin-left:0%}html.theme--catppuccin-latte .column.is-1,html.theme--catppuccin-latte .column.is-1-tablet{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1,html.theme--catppuccin-latte .column.is-offset-1-tablet{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2,html.theme--catppuccin-latte .column.is-2-tablet{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2,html.theme--catppuccin-latte .column.is-offset-2-tablet{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3,html.theme--catppuccin-latte .column.is-3-tablet{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3,html.theme--catppuccin-latte .column.is-offset-3-tablet{margin-left:25%}html.theme--catppuccin-latte .column.is-4,html.theme--catppuccin-latte .column.is-4-tablet{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4,html.theme--catppuccin-latte .column.is-offset-4-tablet{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5,html.theme--catppuccin-latte .column.is-5-tablet{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5,html.theme--catppuccin-latte .column.is-offset-5-tablet{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6,html.theme--catppuccin-latte .column.is-6-tablet{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6,html.theme--catppuccin-latte .column.is-offset-6-tablet{margin-left:50%}html.theme--catppuccin-latte .column.is-7,html.theme--catppuccin-latte .column.is-7-tablet{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7,html.theme--catppuccin-latte .column.is-offset-7-tablet{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8,html.theme--catppuccin-latte .column.is-8-tablet{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8,html.theme--catppuccin-latte .column.is-offset-8-tablet{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9,html.theme--catppuccin-latte .column.is-9-tablet{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9,html.theme--catppuccin-latte .column.is-offset-9-tablet{margin-left:75%}html.theme--catppuccin-latte .column.is-10,html.theme--catppuccin-latte .column.is-10-tablet{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10,html.theme--catppuccin-latte .column.is-offset-10-tablet{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11,html.theme--catppuccin-latte .column.is-11-tablet{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11,html.theme--catppuccin-latte .column.is-offset-11-tablet{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12,html.theme--catppuccin-latte .column.is-12-tablet{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12,html.theme--catppuccin-latte .column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .column.is-narrow-touch{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full-touch{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters-touch{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds-touch{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half-touch{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third-touch{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter-touch{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth-touch{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths-touch{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths-touch{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths-touch{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters-touch{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds-touch{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half-touch{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third-touch{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter-touch{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth-touch{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths-touch{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths-touch{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths-touch{margin-left:80%}html.theme--catppuccin-latte .column.is-0-touch{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0-touch{margin-left:0%}html.theme--catppuccin-latte .column.is-1-touch{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1-touch{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2-touch{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2-touch{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3-touch{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3-touch{margin-left:25%}html.theme--catppuccin-latte .column.is-4-touch{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4-touch{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5-touch{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5-touch{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6-touch{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6-touch{margin-left:50%}html.theme--catppuccin-latte .column.is-7-touch{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7-touch{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8-touch{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8-touch{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9-touch{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9-touch{margin-left:75%}html.theme--catppuccin-latte .column.is-10-touch{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10-touch{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11-touch{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11-touch{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12-touch{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .column.is-narrow-desktop{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full-desktop{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters-desktop{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds-desktop{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half-desktop{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third-desktop{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter-desktop{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth-desktop{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths-desktop{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths-desktop{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths-desktop{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters-desktop{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds-desktop{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half-desktop{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third-desktop{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter-desktop{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth-desktop{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths-desktop{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths-desktop{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths-desktop{margin-left:80%}html.theme--catppuccin-latte .column.is-0-desktop{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0-desktop{margin-left:0%}html.theme--catppuccin-latte .column.is-1-desktop{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1-desktop{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2-desktop{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2-desktop{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3-desktop{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3-desktop{margin-left:25%}html.theme--catppuccin-latte .column.is-4-desktop{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4-desktop{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5-desktop{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5-desktop{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6-desktop{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6-desktop{margin-left:50%}html.theme--catppuccin-latte .column.is-7-desktop{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7-desktop{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8-desktop{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8-desktop{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9-desktop{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9-desktop{margin-left:75%}html.theme--catppuccin-latte .column.is-10-desktop{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10-desktop{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11-desktop{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11-desktop{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12-desktop{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .column.is-narrow-widescreen{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full-widescreen{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters-widescreen{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds-widescreen{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half-widescreen{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third-widescreen{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter-widescreen{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth-widescreen{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths-widescreen{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths-widescreen{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths-widescreen{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters-widescreen{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds-widescreen{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half-widescreen{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third-widescreen{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter-widescreen{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth-widescreen{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths-widescreen{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths-widescreen{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths-widescreen{margin-left:80%}html.theme--catppuccin-latte .column.is-0-widescreen{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0-widescreen{margin-left:0%}html.theme--catppuccin-latte .column.is-1-widescreen{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1-widescreen{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2-widescreen{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2-widescreen{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3-widescreen{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3-widescreen{margin-left:25%}html.theme--catppuccin-latte .column.is-4-widescreen{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4-widescreen{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5-widescreen{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5-widescreen{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6-widescreen{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6-widescreen{margin-left:50%}html.theme--catppuccin-latte .column.is-7-widescreen{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7-widescreen{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8-widescreen{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8-widescreen{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9-widescreen{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9-widescreen{margin-left:75%}html.theme--catppuccin-latte .column.is-10-widescreen{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10-widescreen{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11-widescreen{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11-widescreen{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12-widescreen{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .column.is-narrow-fullhd{flex:none;width:unset}html.theme--catppuccin-latte .column.is-full-fullhd{flex:none;width:100%}html.theme--catppuccin-latte .column.is-three-quarters-fullhd{flex:none;width:75%}html.theme--catppuccin-latte .column.is-two-thirds-fullhd{flex:none;width:66.6666%}html.theme--catppuccin-latte .column.is-half-fullhd{flex:none;width:50%}html.theme--catppuccin-latte .column.is-one-third-fullhd{flex:none;width:33.3333%}html.theme--catppuccin-latte .column.is-one-quarter-fullhd{flex:none;width:25%}html.theme--catppuccin-latte .column.is-one-fifth-fullhd{flex:none;width:20%}html.theme--catppuccin-latte .column.is-two-fifths-fullhd{flex:none;width:40%}html.theme--catppuccin-latte .column.is-three-fifths-fullhd{flex:none;width:60%}html.theme--catppuccin-latte .column.is-four-fifths-fullhd{flex:none;width:80%}html.theme--catppuccin-latte .column.is-offset-three-quarters-fullhd{margin-left:75%}html.theme--catppuccin-latte .column.is-offset-two-thirds-fullhd{margin-left:66.6666%}html.theme--catppuccin-latte .column.is-offset-half-fullhd{margin-left:50%}html.theme--catppuccin-latte .column.is-offset-one-third-fullhd{margin-left:33.3333%}html.theme--catppuccin-latte .column.is-offset-one-quarter-fullhd{margin-left:25%}html.theme--catppuccin-latte .column.is-offset-one-fifth-fullhd{margin-left:20%}html.theme--catppuccin-latte .column.is-offset-two-fifths-fullhd{margin-left:40%}html.theme--catppuccin-latte .column.is-offset-three-fifths-fullhd{margin-left:60%}html.theme--catppuccin-latte .column.is-offset-four-fifths-fullhd{margin-left:80%}html.theme--catppuccin-latte .column.is-0-fullhd{flex:none;width:0%}html.theme--catppuccin-latte .column.is-offset-0-fullhd{margin-left:0%}html.theme--catppuccin-latte .column.is-1-fullhd{flex:none;width:8.33333337%}html.theme--catppuccin-latte .column.is-offset-1-fullhd{margin-left:8.33333337%}html.theme--catppuccin-latte .column.is-2-fullhd{flex:none;width:16.66666674%}html.theme--catppuccin-latte .column.is-offset-2-fullhd{margin-left:16.66666674%}html.theme--catppuccin-latte .column.is-3-fullhd{flex:none;width:25%}html.theme--catppuccin-latte .column.is-offset-3-fullhd{margin-left:25%}html.theme--catppuccin-latte .column.is-4-fullhd{flex:none;width:33.33333337%}html.theme--catppuccin-latte .column.is-offset-4-fullhd{margin-left:33.33333337%}html.theme--catppuccin-latte .column.is-5-fullhd{flex:none;width:41.66666674%}html.theme--catppuccin-latte .column.is-offset-5-fullhd{margin-left:41.66666674%}html.theme--catppuccin-latte .column.is-6-fullhd{flex:none;width:50%}html.theme--catppuccin-latte .column.is-offset-6-fullhd{margin-left:50%}html.theme--catppuccin-latte .column.is-7-fullhd{flex:none;width:58.33333337%}html.theme--catppuccin-latte .column.is-offset-7-fullhd{margin-left:58.33333337%}html.theme--catppuccin-latte .column.is-8-fullhd{flex:none;width:66.66666674%}html.theme--catppuccin-latte .column.is-offset-8-fullhd{margin-left:66.66666674%}html.theme--catppuccin-latte .column.is-9-fullhd{flex:none;width:75%}html.theme--catppuccin-latte .column.is-offset-9-fullhd{margin-left:75%}html.theme--catppuccin-latte .column.is-10-fullhd{flex:none;width:83.33333337%}html.theme--catppuccin-latte .column.is-offset-10-fullhd{margin-left:83.33333337%}html.theme--catppuccin-latte .column.is-11-fullhd{flex:none;width:91.66666674%}html.theme--catppuccin-latte .column.is-offset-11-fullhd{margin-left:91.66666674%}html.theme--catppuccin-latte .column.is-12-fullhd{flex:none;width:100%}html.theme--catppuccin-latte .column.is-offset-12-fullhd{margin-left:100%}}html.theme--catppuccin-latte .columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-latte .columns:last-child{margin-bottom:-.75rem}html.theme--catppuccin-latte .columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}html.theme--catppuccin-latte .columns.is-centered{justify-content:center}html.theme--catppuccin-latte .columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}html.theme--catppuccin-latte .columns.is-gapless>.column{margin:0;padding:0 !important}html.theme--catppuccin-latte .columns.is-gapless:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-latte .columns.is-gapless:last-child{margin-bottom:0}html.theme--catppuccin-latte .columns.is-mobile{display:flex}html.theme--catppuccin-latte .columns.is-multiline{flex-wrap:wrap}html.theme--catppuccin-latte .columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-desktop{display:flex}}html.theme--catppuccin-latte .columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}html.theme--catppuccin-latte .columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}html.theme--catppuccin-latte .columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-0-fullhd{--columnGap: 0rem}}html.theme--catppuccin-latte .columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-1-fullhd{--columnGap: .25rem}}html.theme--catppuccin-latte .columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-2-fullhd{--columnGap: .5rem}}html.theme--catppuccin-latte .columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-3-fullhd{--columnGap: .75rem}}html.theme--catppuccin-latte .columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-4-fullhd{--columnGap: 1rem}}html.theme--catppuccin-latte .columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}html.theme--catppuccin-latte .columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}html.theme--catppuccin-latte .columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}html.theme--catppuccin-latte .columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-latte .columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-latte .columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-latte .columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-latte .columns.is-variable.is-8-fullhd{--columnGap: 2rem}}html.theme--catppuccin-latte .tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}html.theme--catppuccin-latte .tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-latte .tile.is-ancestor:last-child{margin-bottom:-.75rem}html.theme--catppuccin-latte .tile.is-ancestor:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-latte .tile.is-child{margin:0 !important}html.theme--catppuccin-latte .tile.is-parent{padding:.75rem}html.theme--catppuccin-latte .tile.is-vertical{flex-direction:column}html.theme--catppuccin-latte .tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .tile:not(.is-child){display:flex}html.theme--catppuccin-latte .tile.is-1{flex:none;width:8.33333337%}html.theme--catppuccin-latte .tile.is-2{flex:none;width:16.66666674%}html.theme--catppuccin-latte .tile.is-3{flex:none;width:25%}html.theme--catppuccin-latte .tile.is-4{flex:none;width:33.33333337%}html.theme--catppuccin-latte .tile.is-5{flex:none;width:41.66666674%}html.theme--catppuccin-latte .tile.is-6{flex:none;width:50%}html.theme--catppuccin-latte .tile.is-7{flex:none;width:58.33333337%}html.theme--catppuccin-latte .tile.is-8{flex:none;width:66.66666674%}html.theme--catppuccin-latte .tile.is-9{flex:none;width:75%}html.theme--catppuccin-latte .tile.is-10{flex:none;width:83.33333337%}html.theme--catppuccin-latte .tile.is-11{flex:none;width:91.66666674%}html.theme--catppuccin-latte .tile.is-12{flex:none;width:100%}}html.theme--catppuccin-latte .hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}html.theme--catppuccin-latte .hero .navbar{background:none}html.theme--catppuccin-latte .hero .tabs ul{border-bottom:none}html.theme--catppuccin-latte .hero.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-white strong{color:inherit}html.theme--catppuccin-latte .hero.is-white .title{color:#0a0a0a}html.theme--catppuccin-latte .hero.is-white .subtitle{color:rgba(10,10,10,0.9)}html.theme--catppuccin-latte .hero.is-white .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-white .navbar-menu{background-color:#fff}}html.theme--catppuccin-latte .hero.is-white .navbar-item,html.theme--catppuccin-latte .hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}html.theme--catppuccin-latte .hero.is-white a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-white a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-white .navbar-link:hover,html.theme--catppuccin-latte .hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-latte .hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}html.theme--catppuccin-latte .hero.is-white .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}html.theme--catppuccin-latte .hero.is-white .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-white .tabs.is-toggle a{color:#0a0a0a}html.theme--catppuccin-latte .hero.is-white .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-white .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-white .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-white .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}html.theme--catppuccin-latte .hero.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-latte .hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-black strong{color:inherit}html.theme--catppuccin-latte .hero.is-black .title{color:#fff}html.theme--catppuccin-latte .hero.is-black .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-black .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-black .navbar-menu{background-color:#0a0a0a}}html.theme--catppuccin-latte .hero.is-black .navbar-item,html.theme--catppuccin-latte .hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-black a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-black a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-black .navbar-link:hover,html.theme--catppuccin-latte .hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-latte .hero.is-black .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-black .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}html.theme--catppuccin-latte .hero.is-black .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-black .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-black .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-black .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-black .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-black .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-latte .hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}html.theme--catppuccin-latte .hero.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-light strong{color:inherit}html.theme--catppuccin-latte .hero.is-light .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-light .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-latte .hero.is-light .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-light .navbar-menu{background-color:#f5f5f5}}html.theme--catppuccin-latte .hero.is-light .navbar-item,html.theme--catppuccin-latte .hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-light a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-light a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-light .navbar-link:hover,html.theme--catppuccin-latte .hero.is-light .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-latte .hero.is-light .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-light .tabs li.is-active a{color:#f5f5f5 !important;opacity:1}html.theme--catppuccin-latte .hero.is-light .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-light .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-light .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-light .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-light .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-latte .hero.is-light.is-bold{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}}html.theme--catppuccin-latte .hero.is-dark,html.theme--catppuccin-latte .content kbd.hero{background-color:#ccd0da;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-dark strong,html.theme--catppuccin-latte .content kbd.hero strong{color:inherit}html.theme--catppuccin-latte .hero.is-dark .title,html.theme--catppuccin-latte .content kbd.hero .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-dark .subtitle,html.theme--catppuccin-latte .content kbd.hero .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-latte .hero.is-dark .subtitle a:not(.button),html.theme--catppuccin-latte .content kbd.hero .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-dark .subtitle strong,html.theme--catppuccin-latte .content kbd.hero .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-dark .navbar-menu,html.theme--catppuccin-latte .content kbd.hero .navbar-menu{background-color:#ccd0da}}html.theme--catppuccin-latte .hero.is-dark .navbar-item,html.theme--catppuccin-latte .content kbd.hero .navbar-item,html.theme--catppuccin-latte .hero.is-dark .navbar-link,html.theme--catppuccin-latte .content kbd.hero .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-dark a.navbar-item:hover,html.theme--catppuccin-latte .content kbd.hero a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-dark a.navbar-item.is-active,html.theme--catppuccin-latte .content kbd.hero a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-dark .navbar-link:hover,html.theme--catppuccin-latte .content kbd.hero .navbar-link:hover,html.theme--catppuccin-latte .hero.is-dark .navbar-link.is-active,html.theme--catppuccin-latte .content kbd.hero .navbar-link.is-active{background-color:#bdc2cf;color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-dark .tabs a,html.theme--catppuccin-latte .content kbd.hero .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-latte .hero.is-dark .tabs a:hover,html.theme--catppuccin-latte .content kbd.hero .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-dark .tabs li.is-active a,html.theme--catppuccin-latte .content kbd.hero .tabs li.is-active a{color:#ccd0da !important;opacity:1}html.theme--catppuccin-latte .hero.is-dark .tabs.is-boxed a,html.theme--catppuccin-latte .content kbd.hero .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-dark .tabs.is-toggle a,html.theme--catppuccin-latte .content kbd.hero .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-latte .hero.is-dark .tabs.is-boxed a:hover,html.theme--catppuccin-latte .content kbd.hero .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-dark .tabs.is-toggle a:hover,html.theme--catppuccin-latte .content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-dark .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .content kbd.hero .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-dark .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-dark .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .content kbd.hero .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#ccd0da}html.theme--catppuccin-latte .hero.is-dark.is-bold,html.theme--catppuccin-latte .content kbd.hero.is-bold{background-image:linear-gradient(141deg, #a7b8cc 0%, #ccd0da 71%, #d9dbe6 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-dark.is-bold .navbar-menu,html.theme--catppuccin-latte .content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #a7b8cc 0%, #ccd0da 71%, #d9dbe6 100%)}}html.theme--catppuccin-latte .hero.is-primary,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-primary strong,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink strong{color:inherit}html.theme--catppuccin-latte .hero.is-primary .title,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .title{color:#fff}html.theme--catppuccin-latte .hero.is-primary .subtitle,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-primary .subtitle a:not(.button),html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-primary .subtitle strong,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-primary .navbar-menu,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#1e66f5}}html.theme--catppuccin-latte .hero.is-primary .navbar-item,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .navbar-item,html.theme--catppuccin-latte .hero.is-primary .navbar-link,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-primary a.navbar-item:hover,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-primary a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-primary .navbar-link:hover,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .navbar-link:hover,html.theme--catppuccin-latte .hero.is-primary .navbar-link.is-active,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .hero.is-primary .tabs a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-primary .tabs a:hover,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-primary .tabs li.is-active a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#1e66f5 !important;opacity:1}html.theme--catppuccin-latte .hero.is-primary .tabs.is-boxed a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-primary .tabs.is-toggle a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-primary .tabs.is-boxed a:hover,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-primary .tabs.is-toggle a:hover,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-primary .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-primary .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-primary .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .hero.is-primary.is-bold,html.theme--catppuccin-latte .docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #0070e0 0%, #1e66f5 71%, #3153fb 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-primary.is-bold .navbar-menu,html.theme--catppuccin-latte .docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #0070e0 0%, #1e66f5 71%, #3153fb 100%)}}html.theme--catppuccin-latte .hero.is-link{background-color:#1e66f5;color:#fff}html.theme--catppuccin-latte .hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-link strong{color:inherit}html.theme--catppuccin-latte .hero.is-link .title{color:#fff}html.theme--catppuccin-latte .hero.is-link .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-link .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-link .navbar-menu{background-color:#1e66f5}}html.theme--catppuccin-latte .hero.is-link .navbar-item,html.theme--catppuccin-latte .hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-link a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-link a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-link .navbar-link:hover,html.theme--catppuccin-latte .hero.is-link .navbar-link.is-active{background-color:#0b57ef;color:#fff}html.theme--catppuccin-latte .hero.is-link .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-link .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-link .tabs li.is-active a{color:#1e66f5 !important;opacity:1}html.theme--catppuccin-latte .hero.is-link .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-link .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-link .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-link .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-link .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-link .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#1e66f5}html.theme--catppuccin-latte .hero.is-link.is-bold{background-image:linear-gradient(141deg, #0070e0 0%, #1e66f5 71%, #3153fb 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #0070e0 0%, #1e66f5 71%, #3153fb 100%)}}html.theme--catppuccin-latte .hero.is-info{background-color:#179299;color:#fff}html.theme--catppuccin-latte .hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-info strong{color:inherit}html.theme--catppuccin-latte .hero.is-info .title{color:#fff}html.theme--catppuccin-latte .hero.is-info .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-info .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-info .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-info .navbar-menu{background-color:#179299}}html.theme--catppuccin-latte .hero.is-info .navbar-item,html.theme--catppuccin-latte .hero.is-info .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-info a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-info a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-info .navbar-link:hover,html.theme--catppuccin-latte .hero.is-info .navbar-link.is-active{background-color:#147d83;color:#fff}html.theme--catppuccin-latte .hero.is-info .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-info .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-info .tabs li.is-active a{color:#179299 !important;opacity:1}html.theme--catppuccin-latte .hero.is-info .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-info .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-info .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-info .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-info .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-info .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#179299}html.theme--catppuccin-latte .hero.is-info.is-bold{background-image:linear-gradient(141deg, #0a7367 0%, #179299 71%, #1591b4 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #0a7367 0%, #179299 71%, #1591b4 100%)}}html.theme--catppuccin-latte .hero.is-success{background-color:#40a02b;color:#fff}html.theme--catppuccin-latte .hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-success strong{color:inherit}html.theme--catppuccin-latte .hero.is-success .title{color:#fff}html.theme--catppuccin-latte .hero.is-success .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-success .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-success .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-success .navbar-menu{background-color:#40a02b}}html.theme--catppuccin-latte .hero.is-success .navbar-item,html.theme--catppuccin-latte .hero.is-success .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-success a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-success a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-success .navbar-link:hover,html.theme--catppuccin-latte .hero.is-success .navbar-link.is-active{background-color:#388c26;color:#fff}html.theme--catppuccin-latte .hero.is-success .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-success .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-success .tabs li.is-active a{color:#40a02b !important;opacity:1}html.theme--catppuccin-latte .hero.is-success .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-success .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-success .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-success .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-success .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-success .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#40a02b}html.theme--catppuccin-latte .hero.is-success.is-bold{background-image:linear-gradient(141deg, #3c7f19 0%, #40a02b 71%, #2dba2b 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #3c7f19 0%, #40a02b 71%, #2dba2b 100%)}}html.theme--catppuccin-latte .hero.is-warning{background-color:#df8e1d;color:#fff}html.theme--catppuccin-latte .hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-warning strong{color:inherit}html.theme--catppuccin-latte .hero.is-warning .title{color:#fff}html.theme--catppuccin-latte .hero.is-warning .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-warning .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-warning .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-warning .navbar-menu{background-color:#df8e1d}}html.theme--catppuccin-latte .hero.is-warning .navbar-item,html.theme--catppuccin-latte .hero.is-warning .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-warning a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-warning a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-warning .navbar-link:hover,html.theme--catppuccin-latte .hero.is-warning .navbar-link.is-active{background-color:#c8801a;color:#fff}html.theme--catppuccin-latte .hero.is-warning .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-warning .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-warning .tabs li.is-active a{color:#df8e1d !important;opacity:1}html.theme--catppuccin-latte .hero.is-warning .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-warning .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-warning .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-warning .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-warning .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-warning .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#df8e1d}html.theme--catppuccin-latte .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #bc560d 0%, #df8e1d 71%, #eaba2b 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #bc560d 0%, #df8e1d 71%, #eaba2b 100%)}}html.theme--catppuccin-latte .hero.is-danger{background-color:#d20f39;color:#fff}html.theme--catppuccin-latte .hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-latte .hero.is-danger strong{color:inherit}html.theme--catppuccin-latte .hero.is-danger .title{color:#fff}html.theme--catppuccin-latte .hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-latte .hero.is-danger .subtitle a:not(.button),html.theme--catppuccin-latte .hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .hero.is-danger .navbar-menu{background-color:#d20f39}}html.theme--catppuccin-latte .hero.is-danger .navbar-item,html.theme--catppuccin-latte .hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-latte .hero.is-danger a.navbar-item:hover,html.theme--catppuccin-latte .hero.is-danger a.navbar-item.is-active,html.theme--catppuccin-latte .hero.is-danger .navbar-link:hover,html.theme--catppuccin-latte .hero.is-danger .navbar-link.is-active{background-color:#ba0d33;color:#fff}html.theme--catppuccin-latte .hero.is-danger .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-latte .hero.is-danger .tabs a:hover{opacity:1}html.theme--catppuccin-latte .hero.is-danger .tabs li.is-active a{color:#d20f39 !important;opacity:1}html.theme--catppuccin-latte .hero.is-danger .tabs.is-boxed a,html.theme--catppuccin-latte .hero.is-danger .tabs.is-toggle a{color:#fff}html.theme--catppuccin-latte .hero.is-danger .tabs.is-boxed a:hover,html.theme--catppuccin-latte .hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-latte .hero.is-danger .tabs.is-boxed li.is-active a,html.theme--catppuccin-latte .hero.is-danger .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-latte .hero.is-danger .tabs.is-toggle li.is-active a,html.theme--catppuccin-latte .hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#d20f39}html.theme--catppuccin-latte .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #ab0343 0%, #d20f39 71%, #f00a16 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #ab0343 0%, #d20f39 71%, #f00a16 100%)}}html.theme--catppuccin-latte .hero.is-small .hero-body,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .hero.is-large .hero-body{padding:18rem 6rem}}html.theme--catppuccin-latte .hero.is-halfheight .hero-body,html.theme--catppuccin-latte .hero.is-fullheight .hero-body,html.theme--catppuccin-latte .hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}html.theme--catppuccin-latte .hero.is-halfheight .hero-body>.container,html.theme--catppuccin-latte .hero.is-fullheight .hero-body>.container,html.theme--catppuccin-latte .hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}html.theme--catppuccin-latte .hero.is-halfheight{min-height:50vh}html.theme--catppuccin-latte .hero.is-fullheight{min-height:100vh}html.theme--catppuccin-latte .hero-video{overflow:hidden}html.theme--catppuccin-latte .hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}html.theme--catppuccin-latte .hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero-video{display:none}}html.theme--catppuccin-latte .hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-latte .hero-buttons .button{display:flex}html.theme--catppuccin-latte .hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .hero-buttons{display:flex;justify-content:center}html.theme--catppuccin-latte .hero-buttons .button:not(:last-child){margin-right:1.5rem}}html.theme--catppuccin-latte .hero-head,html.theme--catppuccin-latte .hero-foot{flex-grow:0;flex-shrink:0}html.theme--catppuccin-latte .hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-latte .hero-body{padding:3rem 3rem}}html.theme--catppuccin-latte .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--catppuccin-latte .section{padding:3rem 3rem}html.theme--catppuccin-latte .section.is-medium{padding:9rem 4.5rem}html.theme--catppuccin-latte .section.is-large{padding:18rem 6rem}}html.theme--catppuccin-latte .footer{background-color:#e6e9ef;padding:3rem 1.5rem 6rem}html.theme--catppuccin-latte h1 .docs-heading-anchor,html.theme--catppuccin-latte h1 .docs-heading-anchor:hover,html.theme--catppuccin-latte h1 .docs-heading-anchor:visited,html.theme--catppuccin-latte h2 .docs-heading-anchor,html.theme--catppuccin-latte h2 .docs-heading-anchor:hover,html.theme--catppuccin-latte h2 .docs-heading-anchor:visited,html.theme--catppuccin-latte h3 .docs-heading-anchor,html.theme--catppuccin-latte h3 .docs-heading-anchor:hover,html.theme--catppuccin-latte h3 .docs-heading-anchor:visited,html.theme--catppuccin-latte h4 .docs-heading-anchor,html.theme--catppuccin-latte h4 .docs-heading-anchor:hover,html.theme--catppuccin-latte h4 .docs-heading-anchor:visited,html.theme--catppuccin-latte h5 .docs-heading-anchor,html.theme--catppuccin-latte h5 .docs-heading-anchor:hover,html.theme--catppuccin-latte h5 .docs-heading-anchor:visited,html.theme--catppuccin-latte h6 .docs-heading-anchor,html.theme--catppuccin-latte h6 .docs-heading-anchor:hover,html.theme--catppuccin-latte h6 .docs-heading-anchor:visited{color:#4c4f69}html.theme--catppuccin-latte h1 .docs-heading-anchor-permalink,html.theme--catppuccin-latte h2 .docs-heading-anchor-permalink,html.theme--catppuccin-latte h3 .docs-heading-anchor-permalink,html.theme--catppuccin-latte h4 .docs-heading-anchor-permalink,html.theme--catppuccin-latte h5 .docs-heading-anchor-permalink,html.theme--catppuccin-latte h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}html.theme--catppuccin-latte h1 .docs-heading-anchor-permalink::before,html.theme--catppuccin-latte h2 .docs-heading-anchor-permalink::before,html.theme--catppuccin-latte h3 .docs-heading-anchor-permalink::before,html.theme--catppuccin-latte h4 .docs-heading-anchor-permalink::before,html.theme--catppuccin-latte h5 .docs-heading-anchor-permalink::before,html.theme--catppuccin-latte h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}html.theme--catppuccin-latte h1:hover .docs-heading-anchor-permalink,html.theme--catppuccin-latte h2:hover .docs-heading-anchor-permalink,html.theme--catppuccin-latte h3:hover .docs-heading-anchor-permalink,html.theme--catppuccin-latte h4:hover .docs-heading-anchor-permalink,html.theme--catppuccin-latte h5:hover .docs-heading-anchor-permalink,html.theme--catppuccin-latte h6:hover .docs-heading-anchor-permalink{visibility:visible}html.theme--catppuccin-latte .docs-dark-only{display:none !important}html.theme--catppuccin-latte pre{position:relative;overflow:hidden}html.theme--catppuccin-latte pre code,html.theme--catppuccin-latte pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}html.theme--catppuccin-latte pre code:first-of-type,html.theme--catppuccin-latte pre code.hljs:first-of-type{padding-top:0.5rem !important}html.theme--catppuccin-latte pre code:last-of-type,html.theme--catppuccin-latte pre code.hljs:last-of-type{padding-bottom:0.5rem !important}html.theme--catppuccin-latte pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#4c4f69;cursor:pointer;text-align:center}html.theme--catppuccin-latte pre .copy-button:focus,html.theme--catppuccin-latte pre .copy-button:hover{opacity:1;background:rgba(76,79,105,0.1);color:#1e66f5}html.theme--catppuccin-latte pre .copy-button.success{color:#40a02b;opacity:1}html.theme--catppuccin-latte pre .copy-button.error{color:#d20f39;opacity:1}html.theme--catppuccin-latte pre:hover .copy-button{opacity:1}html.theme--catppuccin-latte .admonition{background-color:#e6e9ef;border-style:solid;border-width:2px;border-color:#5c5f77;border-radius:4px;font-size:1rem}html.theme--catppuccin-latte .admonition strong{color:currentColor}html.theme--catppuccin-latte .admonition.is-small,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}html.theme--catppuccin-latte .admonition.is-medium{font-size:1.25rem}html.theme--catppuccin-latte .admonition.is-large{font-size:1.5rem}html.theme--catppuccin-latte .admonition.is-default{background-color:#e6e9ef;border-color:#5c5f77}html.theme--catppuccin-latte .admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#5c5f77}html.theme--catppuccin-latte .admonition.is-default>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition.is-info{background-color:#e6e9ef;border-color:#179299}html.theme--catppuccin-latte .admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#179299}html.theme--catppuccin-latte .admonition.is-info>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition.is-success{background-color:#e6e9ef;border-color:#40a02b}html.theme--catppuccin-latte .admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#40a02b}html.theme--catppuccin-latte .admonition.is-success>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition.is-warning{background-color:#e6e9ef;border-color:#df8e1d}html.theme--catppuccin-latte .admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#df8e1d}html.theme--catppuccin-latte .admonition.is-warning>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition.is-danger{background-color:#e6e9ef;border-color:#d20f39}html.theme--catppuccin-latte .admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#d20f39}html.theme--catppuccin-latte .admonition.is-danger>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition.is-compat{background-color:#e6e9ef;border-color:#04a5e5}html.theme--catppuccin-latte .admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#04a5e5}html.theme--catppuccin-latte .admonition.is-compat>.admonition-body{color:#4c4f69}html.theme--catppuccin-latte .admonition-header{color:#5c5f77;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}html.theme--catppuccin-latte .admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}html.theme--catppuccin-latte details.admonition.is-details>.admonition-header{list-style:none}html.theme--catppuccin-latte details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}html.theme--catppuccin-latte details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}html.theme--catppuccin-latte .admonition-body{color:#4c4f69;padding:0.5rem .75rem}html.theme--catppuccin-latte .admonition-body pre{background-color:#e6e9ef}html.theme--catppuccin-latte .admonition-body code{background-color:#e6e9ef}html.theme--catppuccin-latte .docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #acb0be;border-radius:4px;box-shadow:none;max-width:100%}html.theme--catppuccin-latte .docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#e6e9ef;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #acb0be;overflow:auto}html.theme--catppuccin-latte .docstring>header code{background-color:transparent}html.theme--catppuccin-latte .docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}html.theme--catppuccin-latte .docstring>header .docstring-binding{margin-right:0.3em}html.theme--catppuccin-latte .docstring>header .docstring-category{margin-left:0.3em}html.theme--catppuccin-latte .docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #acb0be}html.theme--catppuccin-latte .docstring>section:last-child{border-bottom:none}html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:focus{opacity:1 !important}html.theme--catppuccin-latte .docstring:hover>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-latte .docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-latte .docstring>section:hover a.docs-sourcelink{opacity:1}html.theme--catppuccin-latte .documenter-example-output{background-color:#eff1f5}html.theme--catppuccin-latte .outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#e6e9ef;color:#4c4f69;border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}html.theme--catppuccin-latte .outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}html.theme--catppuccin-latte .outdated-warning-overlay a{color:#1e66f5}html.theme--catppuccin-latte .outdated-warning-overlay a:hover{color:#04a5e5}html.theme--catppuccin-latte .content pre{border:2px solid #acb0be;border-radius:4px}html.theme--catppuccin-latte .content code{font-weight:inherit}html.theme--catppuccin-latte .content a code{color:#1e66f5}html.theme--catppuccin-latte .content a:hover code{color:#04a5e5}html.theme--catppuccin-latte .content h1 code,html.theme--catppuccin-latte .content h2 code,html.theme--catppuccin-latte .content h3 code,html.theme--catppuccin-latte .content h4 code,html.theme--catppuccin-latte .content h5 code,html.theme--catppuccin-latte .content h6 code{color:#4c4f69}html.theme--catppuccin-latte .content table{display:block;width:initial;max-width:100%;overflow-x:auto}html.theme--catppuccin-latte .content blockquote>ul:first-child,html.theme--catppuccin-latte .content blockquote>ol:first-child,html.theme--catppuccin-latte .content .admonition-body>ul:first-child,html.theme--catppuccin-latte .content .admonition-body>ol:first-child{margin-top:0}html.theme--catppuccin-latte pre,html.theme--catppuccin-latte code{font-variant-ligatures:no-contextual}html.theme--catppuccin-latte .breadcrumb a.is-disabled{cursor:default;pointer-events:none}html.theme--catppuccin-latte .breadcrumb a.is-disabled,html.theme--catppuccin-latte .breadcrumb a.is-disabled:hover{color:#41445a}html.theme--catppuccin-latte .hljs{background:initial !important}html.theme--catppuccin-latte .katex .katex-mathml{top:0;right:0}html.theme--catppuccin-latte .katex-display,html.theme--catppuccin-latte mjx-container,html.theme--catppuccin-latte .MathJax_Display{margin:0.5em 0 !important}html.theme--catppuccin-latte html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}html.theme--catppuccin-latte li.no-marker{list-style:none}html.theme--catppuccin-latte #documenter .docs-main>article{overflow-wrap:break-word}html.theme--catppuccin-latte #documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){html.theme--catppuccin-latte #documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte #documenter .docs-main{width:100%}html.theme--catppuccin-latte #documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}html.theme--catppuccin-latte #documenter .docs-main>header,html.theme--catppuccin-latte #documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar{background-color:#eff1f5;border-bottom:1px solid #acb0be;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-right .docs-icon,html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #171717;transition-duration:0.7s;-webkit-transition-duration:0.7s}html.theme--catppuccin-latte #documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}html.theme--catppuccin-latte #documenter .docs-main section.footnotes{border-top:1px solid #acb0be}html.theme--catppuccin-latte #documenter .docs-main section.footnotes li .tag:first-child,html.theme--catppuccin-latte #documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,html.theme--catppuccin-latte #documenter .docs-main section.footnotes li .content kbd:first-child,html.theme--catppuccin-latte .content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}html.theme--catppuccin-latte #documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #acb0be;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){html.theme--catppuccin-latte #documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}html.theme--catppuccin-latte #documenter .docs-main .docs-footer .docs-footer-nextpage,html.theme--catppuccin-latte #documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}html.theme--catppuccin-latte #documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}html.theme--catppuccin-latte #documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}html.theme--catppuccin-latte #documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}html.theme--catppuccin-latte #documenter .docs-sidebar{display:flex;flex-direction:column;color:#4c4f69;background-color:#e6e9ef;border-right:1px solid #acb0be;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}html.theme--catppuccin-latte #documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #171717}@media screen and (min-width: 1056px){html.theme--catppuccin-latte #documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){html.theme--catppuccin-latte #documenter .docs-sidebar{left:0;top:0}}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-package-name a,html.theme--catppuccin-latte #documenter .docs-sidebar .docs-package-name a:hover{color:#4c4f69}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-version-selector{border-top:1px solid #acb0be;display:none;padding:0.5rem}html.theme--catppuccin-latte #documenter .docs-sidebar .docs-version-selector.visible{display:flex}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #acb0be;padding-bottom:1.5rem}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #acb0be}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu .tocitem,html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#4c4f69;background:#e6e9ef}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu a.tocitem:hover,html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#4c4f69;background-color:#f2f4f7}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #acb0be;border-bottom:1px solid #acb0be;background-color:#dce0e8}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#dce0e8;color:#4c4f69}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#f2f4f7;color:#4c4f69}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #acb0be}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input{width:14.4rem}html.theme--catppuccin-latte #documenter .docs-sidebar #documenter-search-query{color:#868c98;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#fff}html.theme--catppuccin-latte #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#fff}}@media screen and (max-width: 1055px){html.theme--catppuccin-latte #documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-latte #documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-latte #documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#fff}html.theme--catppuccin-latte #documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#fff}}html.theme--catppuccin-latte kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(245,245,245,0.6);box-shadow:0 2px 0 1px rgba(245,245,245,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}html.theme--catppuccin-latte .search-min-width-50{min-width:50%}html.theme--catppuccin-latte .search-min-height-100{min-height:100%}html.theme--catppuccin-latte .search-modal-card-body{max-height:calc(100vh - 15rem)}html.theme--catppuccin-latte .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-latte .search-result-link:hover,html.theme--catppuccin-latte .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--catppuccin-latte .search-result-link .property-search-result-badge,html.theme--catppuccin-latte .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-latte .property-search-result-badge,html.theme--catppuccin-latte .search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}html.theme--catppuccin-latte .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-latte .search-result-link:hover .search-filter,html.theme--catppuccin-latte .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-latte .search-result-link:focus .search-filter{color:#333;background-color:#f1f5f9}html.theme--catppuccin-latte .search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}html.theme--catppuccin-latte .search-filter:hover,html.theme--catppuccin-latte .search-filter:focus{color:#333}html.theme--catppuccin-latte .search-filter-selected{color:#ccd0da;background-color:#7287fd}html.theme--catppuccin-latte .search-filter-selected:hover,html.theme--catppuccin-latte .search-filter-selected:focus{color:#ccd0da}html.theme--catppuccin-latte .search-result-highlight{background-color:#ffdd57;color:black}html.theme--catppuccin-latte .search-divider{border-bottom:1px solid #acb0be}html.theme--catppuccin-latte .search-result-title{width:85%;color:#f5f5f5}html.theme--catppuccin-latte .search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-latte #search-modal .modal-card-body::-webkit-scrollbar,html.theme--catppuccin-latte #search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}html.theme--catppuccin-latte #search-modal .modal-card-body::-webkit-scrollbar-thumb,html.theme--catppuccin-latte #search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}html.theme--catppuccin-latte #search-modal .modal-card-body::-webkit-scrollbar-track,html.theme--catppuccin-latte #search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}html.theme--catppuccin-latte .w-100{width:100%}html.theme--catppuccin-latte .gap-2{gap:0.5rem}html.theme--catppuccin-latte .gap-4{gap:1rem}html.theme--catppuccin-latte .gap-8{gap:2rem}html.theme--catppuccin-latte{background-color:#eff1f5;font-size:16px;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-latte a{transition:all 200ms ease}html.theme--catppuccin-latte .label{color:#4c4f69}html.theme--catppuccin-latte .button,html.theme--catppuccin-latte .control.has-icons-left .icon,html.theme--catppuccin-latte .control.has-icons-right .icon,html.theme--catppuccin-latte .input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte .pagination-ellipsis,html.theme--catppuccin-latte .pagination-link,html.theme--catppuccin-latte .pagination-next,html.theme--catppuccin-latte .pagination-previous,html.theme--catppuccin-latte .select,html.theme--catppuccin-latte .select select,html.theme--catppuccin-latte .textarea{height:2.5em;color:#4c4f69}html.theme--catppuccin-latte .input,html.theme--catppuccin-latte #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-latte .textarea{transition:all 200ms ease;box-shadow:none;border-width:1px;padding-left:1em;padding-right:1em;color:#4c4f69}html.theme--catppuccin-latte .select:after,html.theme--catppuccin-latte .select select{border-width:1px}html.theme--catppuccin-latte .menu-list a{transition:all 300ms ease}html.theme--catppuccin-latte .modal-card-foot,html.theme--catppuccin-latte .modal-card-head{border-color:#acb0be}html.theme--catppuccin-latte .navbar{border-radius:.4em}html.theme--catppuccin-latte .navbar.is-transparent{background:none}html.theme--catppuccin-latte .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-latte .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#1e66f5}@media screen and (max-width: 1055px){html.theme--catppuccin-latte .navbar .navbar-menu{background-color:#1e66f5;border-radius:0 0 .4em .4em}}html.theme--catppuccin-latte .docstring>section>a.docs-sourcelink:not(body){color:#ccd0da}html.theme--catppuccin-latte .tag.is-link:not(body),html.theme--catppuccin-latte .docstring>section>a.is-link.docs-sourcelink:not(body),html.theme--catppuccin-latte .content kbd.is-link:not(body){color:#ccd0da}html.theme--catppuccin-latte .ansi span.sgr1{font-weight:bolder}html.theme--catppuccin-latte .ansi span.sgr2{font-weight:lighter}html.theme--catppuccin-latte .ansi span.sgr3{font-style:italic}html.theme--catppuccin-latte .ansi span.sgr4{text-decoration:underline}html.theme--catppuccin-latte .ansi span.sgr7{color:#eff1f5;background-color:#4c4f69}html.theme--catppuccin-latte .ansi span.sgr8{color:transparent}html.theme--catppuccin-latte .ansi span.sgr8 span{color:transparent}html.theme--catppuccin-latte .ansi span.sgr9{text-decoration:line-through}html.theme--catppuccin-latte .ansi span.sgr30{color:#5c5f77}html.theme--catppuccin-latte .ansi span.sgr31{color:#d20f39}html.theme--catppuccin-latte .ansi span.sgr32{color:#40a02b}html.theme--catppuccin-latte .ansi span.sgr33{color:#df8e1d}html.theme--catppuccin-latte .ansi span.sgr34{color:#1e66f5}html.theme--catppuccin-latte .ansi span.sgr35{color:#ea76cb}html.theme--catppuccin-latte .ansi span.sgr36{color:#179299}html.theme--catppuccin-latte .ansi span.sgr37{color:#acb0be}html.theme--catppuccin-latte .ansi span.sgr40{background-color:#5c5f77}html.theme--catppuccin-latte .ansi span.sgr41{background-color:#d20f39}html.theme--catppuccin-latte .ansi span.sgr42{background-color:#40a02b}html.theme--catppuccin-latte .ansi span.sgr43{background-color:#df8e1d}html.theme--catppuccin-latte .ansi span.sgr44{background-color:#1e66f5}html.theme--catppuccin-latte .ansi span.sgr45{background-color:#ea76cb}html.theme--catppuccin-latte .ansi span.sgr46{background-color:#179299}html.theme--catppuccin-latte .ansi span.sgr47{background-color:#acb0be}html.theme--catppuccin-latte .ansi span.sgr90{color:#6c6f85}html.theme--catppuccin-latte .ansi span.sgr91{color:#d20f39}html.theme--catppuccin-latte .ansi span.sgr92{color:#40a02b}html.theme--catppuccin-latte .ansi span.sgr93{color:#df8e1d}html.theme--catppuccin-latte .ansi span.sgr94{color:#1e66f5}html.theme--catppuccin-latte .ansi span.sgr95{color:#ea76cb}html.theme--catppuccin-latte .ansi span.sgr96{color:#179299}html.theme--catppuccin-latte .ansi span.sgr97{color:#bcc0cc}html.theme--catppuccin-latte .ansi span.sgr100{background-color:#6c6f85}html.theme--catppuccin-latte .ansi span.sgr101{background-color:#d20f39}html.theme--catppuccin-latte .ansi span.sgr102{background-color:#40a02b}html.theme--catppuccin-latte .ansi span.sgr103{background-color:#df8e1d}html.theme--catppuccin-latte .ansi span.sgr104{background-color:#1e66f5}html.theme--catppuccin-latte .ansi span.sgr105{background-color:#ea76cb}html.theme--catppuccin-latte .ansi span.sgr106{background-color:#179299}html.theme--catppuccin-latte .ansi span.sgr107{background-color:#bcc0cc}html.theme--catppuccin-latte code.language-julia-repl>span.hljs-meta{color:#40a02b;font-weight:bolder}html.theme--catppuccin-latte code .hljs{color:#4c4f69;background:#eff1f5}html.theme--catppuccin-latte code .hljs-keyword{color:#8839ef}html.theme--catppuccin-latte code .hljs-built_in{color:#d20f39}html.theme--catppuccin-latte code .hljs-type{color:#df8e1d}html.theme--catppuccin-latte code .hljs-literal{color:#fe640b}html.theme--catppuccin-latte code .hljs-number{color:#fe640b}html.theme--catppuccin-latte code .hljs-operator{color:#179299}html.theme--catppuccin-latte code .hljs-punctuation{color:#5c5f77}html.theme--catppuccin-latte code .hljs-property{color:#179299}html.theme--catppuccin-latte code .hljs-regexp{color:#ea76cb}html.theme--catppuccin-latte code .hljs-string{color:#40a02b}html.theme--catppuccin-latte code .hljs-char.escape_{color:#40a02b}html.theme--catppuccin-latte code .hljs-subst{color:#6c6f85}html.theme--catppuccin-latte code .hljs-symbol{color:#dd7878}html.theme--catppuccin-latte code .hljs-variable{color:#8839ef}html.theme--catppuccin-latte code .hljs-variable.language_{color:#8839ef}html.theme--catppuccin-latte code .hljs-variable.constant_{color:#fe640b}html.theme--catppuccin-latte code .hljs-title{color:#1e66f5}html.theme--catppuccin-latte code .hljs-title.class_{color:#df8e1d}html.theme--catppuccin-latte code .hljs-title.function_{color:#1e66f5}html.theme--catppuccin-latte code .hljs-params{color:#4c4f69}html.theme--catppuccin-latte code .hljs-comment{color:#acb0be}html.theme--catppuccin-latte code .hljs-doctag{color:#d20f39}html.theme--catppuccin-latte code .hljs-meta{color:#fe640b}html.theme--catppuccin-latte code .hljs-section{color:#1e66f5}html.theme--catppuccin-latte code .hljs-tag{color:#6c6f85}html.theme--catppuccin-latte code .hljs-name{color:#8839ef}html.theme--catppuccin-latte code .hljs-attr{color:#1e66f5}html.theme--catppuccin-latte code .hljs-attribute{color:#40a02b}html.theme--catppuccin-latte code .hljs-bullet{color:#179299}html.theme--catppuccin-latte code .hljs-code{color:#40a02b}html.theme--catppuccin-latte code .hljs-emphasis{color:#d20f39;font-style:italic}html.theme--catppuccin-latte code .hljs-strong{color:#d20f39;font-weight:bold}html.theme--catppuccin-latte code .hljs-formula{color:#179299}html.theme--catppuccin-latte code .hljs-link{color:#209fb5;font-style:italic}html.theme--catppuccin-latte code .hljs-quote{color:#40a02b;font-style:italic}html.theme--catppuccin-latte code .hljs-selector-tag{color:#df8e1d}html.theme--catppuccin-latte code .hljs-selector-id{color:#1e66f5}html.theme--catppuccin-latte code .hljs-selector-class{color:#179299}html.theme--catppuccin-latte code .hljs-selector-attr{color:#8839ef}html.theme--catppuccin-latte code .hljs-selector-pseudo{color:#179299}html.theme--catppuccin-latte code .hljs-template-tag{color:#dd7878}html.theme--catppuccin-latte code .hljs-template-variable{color:#dd7878}html.theme--catppuccin-latte code .hljs-addition{color:#40a02b;background:rgba(166,227,161,0.15)}html.theme--catppuccin-latte code .hljs-deletion{color:#d20f39;background:rgba(243,139,168,0.15)}html.theme--catppuccin-latte .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-latte .search-result-link:hover,html.theme--catppuccin-latte .search-result-link:focus{background-color:#ccd0da}html.theme--catppuccin-latte .search-result-link .property-search-result-badge,html.theme--catppuccin-latte .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-latte .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-latte .search-result-link:hover .search-filter,html.theme--catppuccin-latte .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-latte .search-result-link:focus .search-filter{color:#ccd0da !important;background-color:#7287fd !important}html.theme--catppuccin-latte .search-result-title{color:#4c4f69}html.theme--catppuccin-latte .search-result-highlight{background-color:#d20f39;color:#e6e9ef}html.theme--catppuccin-latte .search-divider{border-bottom:1px solid #5e6d6f50}html.theme--catppuccin-latte .w-100{width:100%}html.theme--catppuccin-latte .gap-2{gap:0.5rem}html.theme--catppuccin-latte .gap-4{gap:1rem} diff --git a/v0.16.1/assets/themes/catppuccin-macchiato.css b/v0.16.1/assets/themes/catppuccin-macchiato.css new file mode 100644 index 000000000..6ed16f8eb --- /dev/null +++ b/v0.16.1/assets/themes/catppuccin-macchiato.css @@ -0,0 +1 @@ +html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato .pagination-ellipsis,html.theme--catppuccin-macchiato .file-cta,html.theme--catppuccin-macchiato .file-name,html.theme--catppuccin-macchiato .select select,html.theme--catppuccin-macchiato .textarea,html.theme--catppuccin-macchiato .input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato .button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:.4em;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}html.theme--catppuccin-macchiato .pagination-previous:focus,html.theme--catppuccin-macchiato .pagination-next:focus,html.theme--catppuccin-macchiato .pagination-link:focus,html.theme--catppuccin-macchiato .pagination-ellipsis:focus,html.theme--catppuccin-macchiato .file-cta:focus,html.theme--catppuccin-macchiato .file-name:focus,html.theme--catppuccin-macchiato .select select:focus,html.theme--catppuccin-macchiato .textarea:focus,html.theme--catppuccin-macchiato .input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-macchiato .button:focus,html.theme--catppuccin-macchiato .is-focused.pagination-previous,html.theme--catppuccin-macchiato .is-focused.pagination-next,html.theme--catppuccin-macchiato .is-focused.pagination-link,html.theme--catppuccin-macchiato .is-focused.pagination-ellipsis,html.theme--catppuccin-macchiato .is-focused.file-cta,html.theme--catppuccin-macchiato .is-focused.file-name,html.theme--catppuccin-macchiato .select select.is-focused,html.theme--catppuccin-macchiato .is-focused.textarea,html.theme--catppuccin-macchiato .is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-focused.button,html.theme--catppuccin-macchiato .pagination-previous:active,html.theme--catppuccin-macchiato .pagination-next:active,html.theme--catppuccin-macchiato .pagination-link:active,html.theme--catppuccin-macchiato .pagination-ellipsis:active,html.theme--catppuccin-macchiato .file-cta:active,html.theme--catppuccin-macchiato .file-name:active,html.theme--catppuccin-macchiato .select select:active,html.theme--catppuccin-macchiato .textarea:active,html.theme--catppuccin-macchiato .input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-macchiato .button:active,html.theme--catppuccin-macchiato .is-active.pagination-previous,html.theme--catppuccin-macchiato .is-active.pagination-next,html.theme--catppuccin-macchiato .is-active.pagination-link,html.theme--catppuccin-macchiato .is-active.pagination-ellipsis,html.theme--catppuccin-macchiato .is-active.file-cta,html.theme--catppuccin-macchiato .is-active.file-name,html.theme--catppuccin-macchiato .select select.is-active,html.theme--catppuccin-macchiato .is-active.textarea,html.theme--catppuccin-macchiato .is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-macchiato .is-active.button{outline:none}html.theme--catppuccin-macchiato .pagination-previous[disabled],html.theme--catppuccin-macchiato .pagination-next[disabled],html.theme--catppuccin-macchiato .pagination-link[disabled],html.theme--catppuccin-macchiato .pagination-ellipsis[disabled],html.theme--catppuccin-macchiato .file-cta[disabled],html.theme--catppuccin-macchiato .file-name[disabled],html.theme--catppuccin-macchiato .select select[disabled],html.theme--catppuccin-macchiato .textarea[disabled],html.theme--catppuccin-macchiato .input[disabled],html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled],html.theme--catppuccin-macchiato .button[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato fieldset[disabled] .pagination-previous,fieldset[disabled] html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato fieldset[disabled] .pagination-next,fieldset[disabled] html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato fieldset[disabled] .pagination-link,fieldset[disabled] html.theme--catppuccin-macchiato .pagination-ellipsis,html.theme--catppuccin-macchiato fieldset[disabled] .pagination-ellipsis,fieldset[disabled] html.theme--catppuccin-macchiato .file-cta,html.theme--catppuccin-macchiato fieldset[disabled] .file-cta,fieldset[disabled] html.theme--catppuccin-macchiato .file-name,html.theme--catppuccin-macchiato fieldset[disabled] .file-name,fieldset[disabled] html.theme--catppuccin-macchiato .select select,fieldset[disabled] html.theme--catppuccin-macchiato .textarea,fieldset[disabled] html.theme--catppuccin-macchiato .input,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato fieldset[disabled] .select select,html.theme--catppuccin-macchiato .select fieldset[disabled] select,html.theme--catppuccin-macchiato fieldset[disabled] .textarea,html.theme--catppuccin-macchiato fieldset[disabled] .input,html.theme--catppuccin-macchiato fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] html.theme--catppuccin-macchiato .button,html.theme--catppuccin-macchiato fieldset[disabled] .button{cursor:not-allowed}html.theme--catppuccin-macchiato .tabs,html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato .pagination-ellipsis,html.theme--catppuccin-macchiato .breadcrumb,html.theme--catppuccin-macchiato .file,html.theme--catppuccin-macchiato .button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}html.theme--catppuccin-macchiato .navbar-link:not(.is-arrowless)::after,html.theme--catppuccin-macchiato .select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}html.theme--catppuccin-macchiato .admonition:not(:last-child),html.theme--catppuccin-macchiato .tabs:not(:last-child),html.theme--catppuccin-macchiato .pagination:not(:last-child),html.theme--catppuccin-macchiato .message:not(:last-child),html.theme--catppuccin-macchiato .level:not(:last-child),html.theme--catppuccin-macchiato .breadcrumb:not(:last-child),html.theme--catppuccin-macchiato .block:not(:last-child),html.theme--catppuccin-macchiato .title:not(:last-child),html.theme--catppuccin-macchiato .subtitle:not(:last-child),html.theme--catppuccin-macchiato .table-container:not(:last-child),html.theme--catppuccin-macchiato .table:not(:last-child),html.theme--catppuccin-macchiato .progress:not(:last-child),html.theme--catppuccin-macchiato .notification:not(:last-child),html.theme--catppuccin-macchiato .content:not(:last-child),html.theme--catppuccin-macchiato .box:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-macchiato .modal-close,html.theme--catppuccin-macchiato .delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}html.theme--catppuccin-macchiato .modal-close::before,html.theme--catppuccin-macchiato .delete::before,html.theme--catppuccin-macchiato .modal-close::after,html.theme--catppuccin-macchiato .delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-macchiato .modal-close::before,html.theme--catppuccin-macchiato .delete::before{height:2px;width:50%}html.theme--catppuccin-macchiato .modal-close::after,html.theme--catppuccin-macchiato .delete::after{height:50%;width:2px}html.theme--catppuccin-macchiato .modal-close:hover,html.theme--catppuccin-macchiato .delete:hover,html.theme--catppuccin-macchiato .modal-close:focus,html.theme--catppuccin-macchiato .delete:focus{background-color:rgba(10,10,10,0.3)}html.theme--catppuccin-macchiato .modal-close:active,html.theme--catppuccin-macchiato .delete:active{background-color:rgba(10,10,10,0.4)}html.theme--catppuccin-macchiato .is-small.modal-close,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.modal-close,html.theme--catppuccin-macchiato .is-small.delete,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}html.theme--catppuccin-macchiato .is-medium.modal-close,html.theme--catppuccin-macchiato .is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}html.theme--catppuccin-macchiato .is-large.modal-close,html.theme--catppuccin-macchiato .is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}html.theme--catppuccin-macchiato .control.is-loading::after,html.theme--catppuccin-macchiato .select.is-loading::after,html.theme--catppuccin-macchiato .loader,html.theme--catppuccin-macchiato .button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #8087a2;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}html.theme--catppuccin-macchiato .hero-video,html.theme--catppuccin-macchiato .modal-background,html.theme--catppuccin-macchiato .modal,html.theme--catppuccin-macchiato .image.is-square img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-macchiato .image.is-square .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-macchiato .image.is-1by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-macchiato .image.is-1by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-5by4 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-macchiato .image.is-5by4 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-macchiato .image.is-4by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-macchiato .image.is-4by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by2 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-macchiato .image.is-3by2 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-macchiato .image.is-5by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-macchiato .image.is-5by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-16by9 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-macchiato .image.is-16by9 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-macchiato .image.is-2by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-macchiato .image.is-2by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-macchiato .image.is-3by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-4by5 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-macchiato .image.is-4by5 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by4 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-macchiato .image.is-3by4 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-macchiato .image.is-2by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-macchiato .image.is-2by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by5 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-macchiato .image.is-3by5 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-macchiato .image.is-9by16 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-macchiato .image.is-9by16 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-macchiato .image.is-1by2 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-macchiato .image.is-1by2 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-macchiato .image.is-1by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-macchiato .image.is-1by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}html.theme--catppuccin-macchiato .navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#f5f5f5 !important}a.has-text-light:hover,a.has-text-light:focus{color:#dbdbdb !important}.has-background-light{background-color:#f5f5f5 !important}.has-text-dark{color:#363a4f !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#212431 !important}.has-background-dark{background-color:#363a4f !important}.has-text-primary{color:#8aadf4 !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#5b8cf0 !important}.has-background-primary{background-color:#8aadf4 !important}.has-text-primary-light{color:#ecf2fd !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#bed1f9 !important}.has-background-primary-light{background-color:#ecf2fd !important}.has-text-primary-dark{color:#0e3b95 !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#124dc4 !important}.has-background-primary-dark{background-color:#0e3b95 !important}.has-text-link{color:#8aadf4 !important}a.has-text-link:hover,a.has-text-link:focus{color:#5b8cf0 !important}.has-background-link{background-color:#8aadf4 !important}.has-text-link-light{color:#ecf2fd !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#bed1f9 !important}.has-background-link-light{background-color:#ecf2fd !important}.has-text-link-dark{color:#0e3b95 !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#124dc4 !important}.has-background-link-dark{background-color:#0e3b95 !important}.has-text-info{color:#8bd5ca !important}a.has-text-info:hover,a.has-text-info:focus{color:#66c7b9 !important}.has-background-info{background-color:#8bd5ca !important}.has-text-info-light{color:#f0faf8 !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#cbece7 !important}.has-background-info-light{background-color:#f0faf8 !important}.has-text-info-dark{color:#276d62 !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#359284 !important}.has-background-info-dark{background-color:#276d62 !important}.has-text-success{color:#a6da95 !important}a.has-text-success:hover,a.has-text-success:focus{color:#86cd6f !important}.has-background-success{background-color:#a6da95 !important}.has-text-success-light{color:#f2faf0 !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#d3edca !important}.has-background-success-light{background-color:#f2faf0 !important}.has-text-success-dark{color:#386e26 !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#4b9333 !important}.has-background-success-dark{background-color:#386e26 !important}.has-text-warning{color:#eed49f !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#e6c174 !important}.has-background-warning{background-color:#eed49f !important}.has-text-warning-light{color:#fcf7ee !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#f4e4c2 !important}.has-background-warning-light{background-color:#fcf7ee !important}.has-text-warning-dark{color:#7e5c16 !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#a97b1e !important}.has-background-warning-dark{background-color:#7e5c16 !important}.has-text-danger{color:#ed8796 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#e65b6f !important}.has-background-danger{background-color:#ed8796 !important}.has-text-danger-light{color:#fcedef !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#f6c1c9 !important}.has-background-danger-light{background-color:#fcedef !important}.has-text-danger-dark{color:#971729 !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#c31d36 !important}.has-background-danger-dark{background-color:#971729 !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#363a4f !important}.has-background-grey-darker{background-color:#363a4f !important}.has-text-grey-dark{color:#494d64 !important}.has-background-grey-dark{background-color:#494d64 !important}.has-text-grey{color:#5b6078 !important}.has-background-grey{background-color:#5b6078 !important}.has-text-grey-light{color:#6e738d !important}.has-background-grey-light{background-color:#6e738d !important}.has-text-grey-lighter{color:#8087a2 !important}.has-background-grey-lighter{background-color:#8087a2 !important}.has-text-white-ter{color:#f5f5f5 !important}.has-background-white-ter{background-color:#f5f5f5 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}html.theme--catppuccin-macchiato html{background-color:#24273a;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-macchiato article,html.theme--catppuccin-macchiato aside,html.theme--catppuccin-macchiato figure,html.theme--catppuccin-macchiato footer,html.theme--catppuccin-macchiato header,html.theme--catppuccin-macchiato hgroup,html.theme--catppuccin-macchiato section{display:block}html.theme--catppuccin-macchiato body,html.theme--catppuccin-macchiato button,html.theme--catppuccin-macchiato input,html.theme--catppuccin-macchiato optgroup,html.theme--catppuccin-macchiato select,html.theme--catppuccin-macchiato textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}html.theme--catppuccin-macchiato code,html.theme--catppuccin-macchiato pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-macchiato body{color:#cad3f5;font-size:1em;font-weight:400;line-height:1.5}html.theme--catppuccin-macchiato a{color:#8aadf4;cursor:pointer;text-decoration:none}html.theme--catppuccin-macchiato a strong{color:currentColor}html.theme--catppuccin-macchiato a:hover{color:#91d7e3}html.theme--catppuccin-macchiato code{background-color:#1e2030;color:#cad3f5;font-size:.875em;font-weight:normal;padding:.1em}html.theme--catppuccin-macchiato hr{background-color:#1e2030;border:none;display:block;height:2px;margin:1.5rem 0}html.theme--catppuccin-macchiato img{height:auto;max-width:100%}html.theme--catppuccin-macchiato input[type="checkbox"],html.theme--catppuccin-macchiato input[type="radio"]{vertical-align:baseline}html.theme--catppuccin-macchiato small{font-size:.875em}html.theme--catppuccin-macchiato span{font-style:inherit;font-weight:inherit}html.theme--catppuccin-macchiato strong{color:#b5c1f1;font-weight:700}html.theme--catppuccin-macchiato fieldset{border:none}html.theme--catppuccin-macchiato pre{-webkit-overflow-scrolling:touch;background-color:#1e2030;color:#cad3f5;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}html.theme--catppuccin-macchiato pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}html.theme--catppuccin-macchiato table td,html.theme--catppuccin-macchiato table th{vertical-align:top}html.theme--catppuccin-macchiato table td:not([align]),html.theme--catppuccin-macchiato table th:not([align]){text-align:inherit}html.theme--catppuccin-macchiato table th{color:#b5c1f1}html.theme--catppuccin-macchiato .box{background-color:#494d64;border-radius:8px;box-shadow:none;color:#cad3f5;display:block;padding:1.25rem}html.theme--catppuccin-macchiato a.box:hover,html.theme--catppuccin-macchiato a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #8aadf4}html.theme--catppuccin-macchiato a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #8aadf4}html.theme--catppuccin-macchiato .button{background-color:#1e2030;border-color:#3b3f5f;border-width:1px;color:#8aadf4;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}html.theme--catppuccin-macchiato .button strong{color:inherit}html.theme--catppuccin-macchiato .button .icon,html.theme--catppuccin-macchiato .button .icon.is-small,html.theme--catppuccin-macchiato .button #documenter .docs-sidebar form.docs-search>input.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .button form.docs-search>input.icon,html.theme--catppuccin-macchiato .button .icon.is-medium,html.theme--catppuccin-macchiato .button .icon.is-large{height:1.5em;width:1.5em}html.theme--catppuccin-macchiato .button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}html.theme--catppuccin-macchiato .button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-macchiato .button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-macchiato .button:hover,html.theme--catppuccin-macchiato .button.is-hovered{border-color:#6e738d;color:#b5c1f1}html.theme--catppuccin-macchiato .button:focus,html.theme--catppuccin-macchiato .button.is-focused{border-color:#6e738d;color:#739df2}html.theme--catppuccin-macchiato .button:focus:not(:active),html.theme--catppuccin-macchiato .button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .button:active,html.theme--catppuccin-macchiato .button.is-active{border-color:#494d64;color:#b5c1f1}html.theme--catppuccin-macchiato .button.is-text{background-color:transparent;border-color:transparent;color:#cad3f5;text-decoration:underline}html.theme--catppuccin-macchiato .button.is-text:hover,html.theme--catppuccin-macchiato .button.is-text.is-hovered,html.theme--catppuccin-macchiato .button.is-text:focus,html.theme--catppuccin-macchiato .button.is-text.is-focused{background-color:#1e2030;color:#b5c1f1}html.theme--catppuccin-macchiato .button.is-text:active,html.theme--catppuccin-macchiato .button.is-text.is-active{background-color:#141620;color:#b5c1f1}html.theme--catppuccin-macchiato .button.is-text[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}html.theme--catppuccin-macchiato .button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#8aadf4;text-decoration:none}html.theme--catppuccin-macchiato .button.is-ghost:hover,html.theme--catppuccin-macchiato .button.is-ghost.is-hovered{color:#8aadf4;text-decoration:underline}html.theme--catppuccin-macchiato .button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white:hover,html.theme--catppuccin-macchiato .button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white:focus,html.theme--catppuccin-macchiato .button.is-white.is-focused{border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white:focus:not(:active),html.theme--catppuccin-macchiato .button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-macchiato .button.is-white:active,html.theme--catppuccin-macchiato .button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}html.theme--catppuccin-macchiato .button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .button.is-white.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-hovered{background-color:#000}html.theme--catppuccin-macchiato .button.is-white.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-macchiato .button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-white.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-white.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-macchiato .button.is-white.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-black:hover,html.theme--catppuccin-macchiato .button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-black:focus,html.theme--catppuccin-macchiato .button.is-black.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-black:focus:not(:active),html.theme--catppuccin-macchiato .button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-macchiato .button.is-black:active,html.theme--catppuccin-macchiato .button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-black[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}html.theme--catppuccin-macchiato .button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-macchiato .button.is-black.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-black.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-black.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-light{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light:hover,html.theme--catppuccin-macchiato .button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light:focus,html.theme--catppuccin-macchiato .button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light:focus:not(:active),html.theme--catppuccin-macchiato .button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-macchiato .button.is-light:active,html.theme--catppuccin-macchiato .button.is-light.is-active{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-light{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none}html.theme--catppuccin-macchiato .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-macchiato .button.is-light.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-macchiato .button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;color:#f5f5f5}html.theme--catppuccin-macchiato .button.is-light.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-light.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-focused{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-light.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-dark,html.theme--catppuccin-macchiato .content kbd.button{background-color:#363a4f;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-dark:hover,html.theme--catppuccin-macchiato .content kbd.button:hover,html.theme--catppuccin-macchiato .button.is-dark.is-hovered,html.theme--catppuccin-macchiato .content kbd.button.is-hovered{background-color:#313447;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-dark:focus,html.theme--catppuccin-macchiato .content kbd.button:focus,html.theme--catppuccin-macchiato .button.is-dark.is-focused,html.theme--catppuccin-macchiato .content kbd.button.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-dark:focus:not(:active),html.theme--catppuccin-macchiato .content kbd.button:focus:not(:active),html.theme--catppuccin-macchiato .button.is-dark.is-focused:not(:active),html.theme--catppuccin-macchiato .content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(54,58,79,0.25)}html.theme--catppuccin-macchiato .button.is-dark:active,html.theme--catppuccin-macchiato .content kbd.button:active,html.theme--catppuccin-macchiato .button.is-dark.is-active,html.theme--catppuccin-macchiato .content kbd.button.is-active{background-color:#2c2f40;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-dark[disabled],html.theme--catppuccin-macchiato .content kbd.button[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-dark,fieldset[disabled] html.theme--catppuccin-macchiato .content kbd.button{background-color:#363a4f;border-color:#363a4f;box-shadow:none}html.theme--catppuccin-macchiato .button.is-dark.is-inverted,html.theme--catppuccin-macchiato .content kbd.button.is-inverted{background-color:#fff;color:#363a4f}html.theme--catppuccin-macchiato .button.is-dark.is-inverted:hover,html.theme--catppuccin-macchiato .content kbd.button.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-hovered,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-macchiato .button.is-dark.is-inverted[disabled],html.theme--catppuccin-macchiato .content kbd.button.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-dark.is-inverted,fieldset[disabled] html.theme--catppuccin-macchiato .content kbd.button.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#363a4f}html.theme--catppuccin-macchiato .button.is-dark.is-loading::after,html.theme--catppuccin-macchiato .content kbd.button.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-dark.is-outlined,html.theme--catppuccin-macchiato .content kbd.button.is-outlined{background-color:transparent;border-color:#363a4f;color:#363a4f}html.theme--catppuccin-macchiato .button.is-dark.is-outlined:hover,html.theme--catppuccin-macchiato .content kbd.button.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-hovered,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-dark.is-outlined:focus,html.theme--catppuccin-macchiato .content kbd.button.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-focused,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-focused{background-color:#363a4f;border-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-loading::after,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #363a4f #363a4f !important}html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-dark.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-macchiato .content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-dark.is-outlined[disabled],html.theme--catppuccin-macchiato .content kbd.button.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-dark.is-outlined,fieldset[disabled] html.theme--catppuccin-macchiato .content kbd.button.is-outlined{background-color:transparent;border-color:#363a4f;box-shadow:none;color:#363a4f}html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-focused,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-focused{background-color:#fff;color:#363a4f}html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #363a4f #363a4f !important}html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined[disabled],html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-dark.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-macchiato .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink{background-color:#8aadf4;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-primary:hover,html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink:hover,html.theme--catppuccin-macchiato .button.is-primary.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#7ea5f3;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-primary:focus,html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink:focus,html.theme--catppuccin-macchiato .button.is-primary.is-focused,html.theme--catppuccin-macchiato .docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-primary:focus:not(:active),html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink:focus:not(:active),html.theme--catppuccin-macchiato .button.is-primary.is-focused:not(:active),html.theme--catppuccin-macchiato .docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .button.is-primary:active,html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink:active,html.theme--catppuccin-macchiato .button.is-primary.is-active,html.theme--catppuccin-macchiato .docstring>section>a.button.is-active.docs-sourcelink{background-color:#739df2;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-primary[disabled],html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-primary,fieldset[disabled] html.theme--catppuccin-macchiato .docstring>section>a.button.docs-sourcelink{background-color:#8aadf4;border-color:#8aadf4;box-shadow:none}html.theme--catppuccin-macchiato .button.is-primary.is-inverted,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-primary.is-inverted:hover,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.docs-sourcelink:hover,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}html.theme--catppuccin-macchiato .button.is-primary.is-inverted[disabled],html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-primary.is-inverted,fieldset[disabled] html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-primary.is-loading::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-primary.is-outlined,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#8aadf4;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-primary.is-outlined:hover,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-macchiato .button.is-primary.is-outlined:focus,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-focused,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#8aadf4;border-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-loading::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #8aadf4 #8aadf4 !important}html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-macchiato .button.is-primary.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-primary.is-outlined[disabled],html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-primary.is-outlined,fieldset[disabled] html.theme--catppuccin-macchiato .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#8aadf4;box-shadow:none;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-focused,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #8aadf4 #8aadf4 !important}html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined[disabled],html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-primary.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-macchiato .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-primary.is-light,html.theme--catppuccin-macchiato .docstring>section>a.button.is-light.docs-sourcelink{background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-primary.is-light:hover,html.theme--catppuccin-macchiato .docstring>section>a.button.is-light.docs-sourcelink:hover,html.theme--catppuccin-macchiato .button.is-primary.is-light.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#e1eafc;border-color:transparent;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-primary.is-light:active,html.theme--catppuccin-macchiato .docstring>section>a.button.is-light.docs-sourcelink:active,html.theme--catppuccin-macchiato .button.is-primary.is-light.is-active,html.theme--catppuccin-macchiato .docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#d5e2fb;border-color:transparent;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-link{background-color:#8aadf4;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-link:hover,html.theme--catppuccin-macchiato .button.is-link.is-hovered{background-color:#7ea5f3;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-link:focus,html.theme--catppuccin-macchiato .button.is-link.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-link:focus:not(:active),html.theme--catppuccin-macchiato .button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .button.is-link:active,html.theme--catppuccin-macchiato .button.is-link.is-active{background-color:#739df2;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-link[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-link{background-color:#8aadf4;border-color:#8aadf4;box-shadow:none}html.theme--catppuccin-macchiato .button.is-link.is-inverted{background-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-link.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-macchiato .button.is-link.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-link.is-outlined{background-color:transparent;border-color:#8aadf4;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-link.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-link.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-focused{background-color:#8aadf4;border-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #8aadf4 #8aadf4 !important}html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-link.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-link.is-outlined{background-color:transparent;border-color:#8aadf4;box-shadow:none;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #8aadf4 #8aadf4 !important}html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-link.is-light{background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-link.is-light:hover,html.theme--catppuccin-macchiato .button.is-link.is-light.is-hovered{background-color:#e1eafc;border-color:transparent;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-link.is-light:active,html.theme--catppuccin-macchiato .button.is-link.is-light.is-active{background-color:#d5e2fb;border-color:transparent;color:#0e3b95}html.theme--catppuccin-macchiato .button.is-info{background-color:#8bd5ca;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info:hover,html.theme--catppuccin-macchiato .button.is-info.is-hovered{background-color:#82d2c6;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info:focus,html.theme--catppuccin-macchiato .button.is-info.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info:focus:not(:active),html.theme--catppuccin-macchiato .button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(139,213,202,0.25)}html.theme--catppuccin-macchiato .button.is-info:active,html.theme--catppuccin-macchiato .button.is-info.is-active{background-color:#78cec1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-info{background-color:#8bd5ca;border-color:#8bd5ca;box-shadow:none}html.theme--catppuccin-macchiato .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);color:#8bd5ca}html.theme--catppuccin-macchiato .button.is-info.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#8bd5ca}html.theme--catppuccin-macchiato .button.is-info.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-info.is-outlined{background-color:transparent;border-color:#8bd5ca;color:#8bd5ca}html.theme--catppuccin-macchiato .button.is-info.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-info.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-focused{background-color:#8bd5ca;border-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #8bd5ca #8bd5ca !important}html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-info.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-info.is-outlined{background-color:transparent;border-color:#8bd5ca;box-shadow:none;color:#8bd5ca}html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#8bd5ca}html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #8bd5ca #8bd5ca !important}html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-info.is-light{background-color:#f0faf8;color:#276d62}html.theme--catppuccin-macchiato .button.is-info.is-light:hover,html.theme--catppuccin-macchiato .button.is-info.is-light.is-hovered{background-color:#e7f6f4;border-color:transparent;color:#276d62}html.theme--catppuccin-macchiato .button.is-info.is-light:active,html.theme--catppuccin-macchiato .button.is-info.is-light.is-active{background-color:#ddf3f0;border-color:transparent;color:#276d62}html.theme--catppuccin-macchiato .button.is-success{background-color:#a6da95;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success:hover,html.theme--catppuccin-macchiato .button.is-success.is-hovered{background-color:#9ed78c;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success:focus,html.theme--catppuccin-macchiato .button.is-success.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success:focus:not(:active),html.theme--catppuccin-macchiato .button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(166,218,149,0.25)}html.theme--catppuccin-macchiato .button.is-success:active,html.theme--catppuccin-macchiato .button.is-success.is-active{background-color:#96d382;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-success{background-color:#a6da95;border-color:#a6da95;box-shadow:none}html.theme--catppuccin-macchiato .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);color:#a6da95}html.theme--catppuccin-macchiato .button.is-success.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#a6da95}html.theme--catppuccin-macchiato .button.is-success.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-success.is-outlined{background-color:transparent;border-color:#a6da95;color:#a6da95}html.theme--catppuccin-macchiato .button.is-success.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-success.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-focused{background-color:#a6da95;border-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #a6da95 #a6da95 !important}html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-success.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-success.is-outlined{background-color:transparent;border-color:#a6da95;box-shadow:none;color:#a6da95}html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#a6da95}html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #a6da95 #a6da95 !important}html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-success.is-light{background-color:#f2faf0;color:#386e26}html.theme--catppuccin-macchiato .button.is-success.is-light:hover,html.theme--catppuccin-macchiato .button.is-success.is-light.is-hovered{background-color:#eaf6e6;border-color:transparent;color:#386e26}html.theme--catppuccin-macchiato .button.is-success.is-light:active,html.theme--catppuccin-macchiato .button.is-success.is-light.is-active{background-color:#e2f3dd;border-color:transparent;color:#386e26}html.theme--catppuccin-macchiato .button.is-warning{background-color:#eed49f;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning:hover,html.theme--catppuccin-macchiato .button.is-warning.is-hovered{background-color:#eccf94;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning:focus,html.theme--catppuccin-macchiato .button.is-warning.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning:focus:not(:active),html.theme--catppuccin-macchiato .button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(238,212,159,0.25)}html.theme--catppuccin-macchiato .button.is-warning:active,html.theme--catppuccin-macchiato .button.is-warning.is-active{background-color:#eaca89;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-warning{background-color:#eed49f;border-color:#eed49f;box-shadow:none}html.theme--catppuccin-macchiato .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);color:#eed49f}html.theme--catppuccin-macchiato .button.is-warning.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#eed49f}html.theme--catppuccin-macchiato .button.is-warning.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-warning.is-outlined{background-color:transparent;border-color:#eed49f;color:#eed49f}html.theme--catppuccin-macchiato .button.is-warning.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-warning.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-focused{background-color:#eed49f;border-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #eed49f #eed49f !important}html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-macchiato .button.is-warning.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-warning.is-outlined{background-color:transparent;border-color:#eed49f;box-shadow:none;color:#eed49f}html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#eed49f}html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #eed49f #eed49f !important}html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .button.is-warning.is-light{background-color:#fcf7ee;color:#7e5c16}html.theme--catppuccin-macchiato .button.is-warning.is-light:hover,html.theme--catppuccin-macchiato .button.is-warning.is-light.is-hovered{background-color:#faf2e3;border-color:transparent;color:#7e5c16}html.theme--catppuccin-macchiato .button.is-warning.is-light:active,html.theme--catppuccin-macchiato .button.is-warning.is-light.is-active{background-color:#f8eed8;border-color:transparent;color:#7e5c16}html.theme--catppuccin-macchiato .button.is-danger{background-color:#ed8796;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-danger:hover,html.theme--catppuccin-macchiato .button.is-danger.is-hovered{background-color:#eb7c8c;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-danger:focus,html.theme--catppuccin-macchiato .button.is-danger.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-danger:focus:not(:active),html.theme--catppuccin-macchiato .button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(237,135,150,0.25)}html.theme--catppuccin-macchiato .button.is-danger:active,html.theme--catppuccin-macchiato .button.is-danger.is-active{background-color:#ea7183;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .button.is-danger[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-danger{background-color:#ed8796;border-color:#ed8796;box-shadow:none}html.theme--catppuccin-macchiato .button.is-danger.is-inverted{background-color:#fff;color:#ed8796}html.theme--catppuccin-macchiato .button.is-danger.is-inverted:hover,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-macchiato .button.is-danger.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#ed8796}html.theme--catppuccin-macchiato .button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-danger.is-outlined{background-color:transparent;border-color:#ed8796;color:#ed8796}html.theme--catppuccin-macchiato .button.is-danger.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-danger.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-focused{background-color:#ed8796;border-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #ed8796 #ed8796 !important}html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-macchiato .button.is-danger.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-danger.is-outlined{background-color:transparent;border-color:#ed8796;box-shadow:none;color:#ed8796}html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined:hover,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined:focus,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#ed8796}html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #ed8796 #ed8796 !important}html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-macchiato .button.is-danger.is-light{background-color:#fcedef;color:#971729}html.theme--catppuccin-macchiato .button.is-danger.is-light:hover,html.theme--catppuccin-macchiato .button.is-danger.is-light.is-hovered{background-color:#fbe2e6;border-color:transparent;color:#971729}html.theme--catppuccin-macchiato .button.is-danger.is-light:active,html.theme--catppuccin-macchiato .button.is-danger.is-light.is-active{background-color:#f9d7dc;border-color:transparent;color:#971729}html.theme--catppuccin-macchiato .button.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}html.theme--catppuccin-macchiato .button.is-small:not(.is-rounded),html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:3px}html.theme--catppuccin-macchiato .button.is-normal{font-size:1rem}html.theme--catppuccin-macchiato .button.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .button.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .button[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .button{background-color:#6e738d;border-color:#5b6078;box-shadow:none;opacity:.5}html.theme--catppuccin-macchiato .button.is-fullwidth{display:flex;width:100%}html.theme--catppuccin-macchiato .button.is-loading{color:transparent !important;pointer-events:none}html.theme--catppuccin-macchiato .button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}html.theme--catppuccin-macchiato .button.is-static{background-color:#1e2030;border-color:#5b6078;color:#8087a2;box-shadow:none;pointer-events:none}html.theme--catppuccin-macchiato .button.is-rounded,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}html.theme--catppuccin-macchiato .buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-macchiato .buttons .button{margin-bottom:0.5rem}html.theme--catppuccin-macchiato .buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}html.theme--catppuccin-macchiato .buttons:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-macchiato .buttons:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-macchiato .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}html.theme--catppuccin-macchiato .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:3px}html.theme--catppuccin-macchiato .buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}html.theme--catppuccin-macchiato .buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}html.theme--catppuccin-macchiato .buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-macchiato .buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}html.theme--catppuccin-macchiato .buttons.has-addons .button:last-child{margin-right:0}html.theme--catppuccin-macchiato .buttons.has-addons .button:hover,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-hovered{z-index:2}html.theme--catppuccin-macchiato .buttons.has-addons .button:focus,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-focused,html.theme--catppuccin-macchiato .buttons.has-addons .button:active,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-active,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-selected{z-index:3}html.theme--catppuccin-macchiato .buttons.has-addons .button:focus:hover,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-focused:hover,html.theme--catppuccin-macchiato .buttons.has-addons .button:active:hover,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-active:hover,html.theme--catppuccin-macchiato .buttons.has-addons .button.is-selected:hover{z-index:4}html.theme--catppuccin-macchiato .buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .buttons.is-centered{justify-content:center}html.theme--catppuccin-macchiato .buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}html.theme--catppuccin-macchiato .buttons.is-right{justify-content:flex-end}html.theme--catppuccin-macchiato .buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .button.is-responsive.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}html.theme--catppuccin-macchiato .button.is-responsive,html.theme--catppuccin-macchiato .button.is-responsive.is-normal{font-size:.65625rem}html.theme--catppuccin-macchiato .button.is-responsive.is-medium{font-size:.75rem}html.theme--catppuccin-macchiato .button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .button.is-responsive.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}html.theme--catppuccin-macchiato .button.is-responsive,html.theme--catppuccin-macchiato .button.is-responsive.is-normal{font-size:.75rem}html.theme--catppuccin-macchiato .button.is-responsive.is-medium{font-size:1rem}html.theme--catppuccin-macchiato .button.is-responsive.is-large{font-size:1.25rem}}html.theme--catppuccin-macchiato .container{flex-grow:1;margin:0 auto;position:relative;width:auto}html.theme--catppuccin-macchiato .container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .container{max-width:992px}}@media screen and (max-width: 1215px){html.theme--catppuccin-macchiato .container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){html.theme--catppuccin-macchiato .container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}html.theme--catppuccin-macchiato .content li+li{margin-top:0.25em}html.theme--catppuccin-macchiato .content p:not(:last-child),html.theme--catppuccin-macchiato .content dl:not(:last-child),html.theme--catppuccin-macchiato .content ol:not(:last-child),html.theme--catppuccin-macchiato .content ul:not(:last-child),html.theme--catppuccin-macchiato .content blockquote:not(:last-child),html.theme--catppuccin-macchiato .content pre:not(:last-child),html.theme--catppuccin-macchiato .content table:not(:last-child){margin-bottom:1em}html.theme--catppuccin-macchiato .content h1,html.theme--catppuccin-macchiato .content h2,html.theme--catppuccin-macchiato .content h3,html.theme--catppuccin-macchiato .content h4,html.theme--catppuccin-macchiato .content h5,html.theme--catppuccin-macchiato .content h6{color:#cad3f5;font-weight:600;line-height:1.125}html.theme--catppuccin-macchiato .content h1{font-size:2em;margin-bottom:0.5em}html.theme--catppuccin-macchiato .content h1:not(:first-child){margin-top:1em}html.theme--catppuccin-macchiato .content h2{font-size:1.75em;margin-bottom:0.5714em}html.theme--catppuccin-macchiato .content h2:not(:first-child){margin-top:1.1428em}html.theme--catppuccin-macchiato .content h3{font-size:1.5em;margin-bottom:0.6666em}html.theme--catppuccin-macchiato .content h3:not(:first-child){margin-top:1.3333em}html.theme--catppuccin-macchiato .content h4{font-size:1.25em;margin-bottom:0.8em}html.theme--catppuccin-macchiato .content h5{font-size:1.125em;margin-bottom:0.8888em}html.theme--catppuccin-macchiato .content h6{font-size:1em;margin-bottom:1em}html.theme--catppuccin-macchiato .content blockquote{background-color:#1e2030;border-left:5px solid #5b6078;padding:1.25em 1.5em}html.theme--catppuccin-macchiato .content ol{list-style-position:outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-macchiato .content ol:not([type]){list-style-type:decimal}html.theme--catppuccin-macchiato .content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}html.theme--catppuccin-macchiato .content ol.is-lower-roman:not([type]){list-style-type:lower-roman}html.theme--catppuccin-macchiato .content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}html.theme--catppuccin-macchiato .content ol.is-upper-roman:not([type]){list-style-type:upper-roman}html.theme--catppuccin-macchiato .content ul{list-style:disc outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-macchiato .content ul ul{list-style-type:circle;margin-top:0.5em}html.theme--catppuccin-macchiato .content ul ul ul{list-style-type:square}html.theme--catppuccin-macchiato .content dd{margin-left:2em}html.theme--catppuccin-macchiato .content figure{margin-left:2em;margin-right:2em;text-align:center}html.theme--catppuccin-macchiato .content figure:not(:first-child){margin-top:2em}html.theme--catppuccin-macchiato .content figure:not(:last-child){margin-bottom:2em}html.theme--catppuccin-macchiato .content figure img{display:inline-block}html.theme--catppuccin-macchiato .content figure figcaption{font-style:italic}html.theme--catppuccin-macchiato .content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}html.theme--catppuccin-macchiato .content sup,html.theme--catppuccin-macchiato .content sub{font-size:75%}html.theme--catppuccin-macchiato .content table{width:100%}html.theme--catppuccin-macchiato .content table td,html.theme--catppuccin-macchiato .content table th{border:1px solid #5b6078;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-macchiato .content table th{color:#b5c1f1}html.theme--catppuccin-macchiato .content table th:not([align]){text-align:inherit}html.theme--catppuccin-macchiato .content table thead td,html.theme--catppuccin-macchiato .content table thead th{border-width:0 0 2px;color:#b5c1f1}html.theme--catppuccin-macchiato .content table tfoot td,html.theme--catppuccin-macchiato .content table tfoot th{border-width:2px 0 0;color:#b5c1f1}html.theme--catppuccin-macchiato .content table tbody tr:last-child td,html.theme--catppuccin-macchiato .content table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-macchiato .content .tabs li+li{margin-top:0}html.theme--catppuccin-macchiato .content.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}html.theme--catppuccin-macchiato .content.is-normal{font-size:1rem}html.theme--catppuccin-macchiato .content.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .content.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}html.theme--catppuccin-macchiato .icon.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}html.theme--catppuccin-macchiato .icon.is-medium{height:2rem;width:2rem}html.theme--catppuccin-macchiato .icon.is-large{height:3rem;width:3rem}html.theme--catppuccin-macchiato .icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}html.theme--catppuccin-macchiato .icon-text .icon{flex-grow:0;flex-shrink:0}html.theme--catppuccin-macchiato .icon-text .icon:not(:last-child){margin-right:.25em}html.theme--catppuccin-macchiato .icon-text .icon:not(:first-child){margin-left:.25em}html.theme--catppuccin-macchiato div.icon-text{display:flex}html.theme--catppuccin-macchiato .image,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img{display:block;position:relative}html.theme--catppuccin-macchiato .image img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}html.theme--catppuccin-macchiato .image img.is-rounded,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}html.theme--catppuccin-macchiato .image.is-fullwidth,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}html.theme--catppuccin-macchiato .image.is-square img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-macchiato .image.is-square .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-macchiato .image.is-1by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-macchiato .image.is-1by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-5by4 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-macchiato .image.is-5by4 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-macchiato .image.is-4by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-macchiato .image.is-4by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by2 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-macchiato .image.is-3by2 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-macchiato .image.is-5by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-macchiato .image.is-5by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-16by9 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-macchiato .image.is-16by9 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-macchiato .image.is-2by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-macchiato .image.is-2by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by1 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-macchiato .image.is-3by1 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-macchiato .image.is-4by5 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-macchiato .image.is-4by5 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by4 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-macchiato .image.is-3by4 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-macchiato .image.is-2by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-macchiato .image.is-2by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-macchiato .image.is-3by5 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-macchiato .image.is-3by5 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-macchiato .image.is-9by16 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-macchiato .image.is-9by16 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-macchiato .image.is-1by2 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-macchiato .image.is-1by2 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-macchiato .image.is-1by3 img,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-macchiato .image.is-1by3 .has-ratio,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}html.theme--catppuccin-macchiato .image.is-square,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-square,html.theme--catppuccin-macchiato .image.is-1by1,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}html.theme--catppuccin-macchiato .image.is-5by4,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}html.theme--catppuccin-macchiato .image.is-4by3,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}html.theme--catppuccin-macchiato .image.is-3by2,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}html.theme--catppuccin-macchiato .image.is-5by3,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}html.theme--catppuccin-macchiato .image.is-16by9,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}html.theme--catppuccin-macchiato .image.is-2by1,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}html.theme--catppuccin-macchiato .image.is-3by1,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}html.theme--catppuccin-macchiato .image.is-4by5,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}html.theme--catppuccin-macchiato .image.is-3by4,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}html.theme--catppuccin-macchiato .image.is-2by3,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}html.theme--catppuccin-macchiato .image.is-3by5,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}html.theme--catppuccin-macchiato .image.is-9by16,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}html.theme--catppuccin-macchiato .image.is-1by2,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}html.theme--catppuccin-macchiato .image.is-1by3,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}html.theme--catppuccin-macchiato .image.is-16x16,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}html.theme--catppuccin-macchiato .image.is-24x24,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}html.theme--catppuccin-macchiato .image.is-32x32,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}html.theme--catppuccin-macchiato .image.is-48x48,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}html.theme--catppuccin-macchiato .image.is-64x64,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}html.theme--catppuccin-macchiato .image.is-96x96,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}html.theme--catppuccin-macchiato .image.is-128x128,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}html.theme--catppuccin-macchiato .notification{background-color:#1e2030;border-radius:.4em;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}html.theme--catppuccin-macchiato .notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-macchiato .notification strong{color:currentColor}html.theme--catppuccin-macchiato .notification code,html.theme--catppuccin-macchiato .notification pre{background:#fff}html.theme--catppuccin-macchiato .notification pre code{background:transparent}html.theme--catppuccin-macchiato .notification>.delete{right:.5rem;position:absolute;top:0.5rem}html.theme--catppuccin-macchiato .notification .title,html.theme--catppuccin-macchiato .notification .subtitle,html.theme--catppuccin-macchiato .notification .content{color:currentColor}html.theme--catppuccin-macchiato .notification.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .notification.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .notification.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .notification.is-dark,html.theme--catppuccin-macchiato .content kbd.notification{background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .notification.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.notification.docs-sourcelink{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .notification.is-primary.is-light,html.theme--catppuccin-macchiato .docstring>section>a.notification.is-light.docs-sourcelink{background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .notification.is-link{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .notification.is-link.is-light{background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .notification.is-info{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .notification.is-info.is-light{background-color:#f0faf8;color:#276d62}html.theme--catppuccin-macchiato .notification.is-success{background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .notification.is-success.is-light{background-color:#f2faf0;color:#386e26}html.theme--catppuccin-macchiato .notification.is-warning{background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .notification.is-warning.is-light{background-color:#fcf7ee;color:#7e5c16}html.theme--catppuccin-macchiato .notification.is-danger{background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .notification.is-danger.is-light{background-color:#fcedef;color:#971729}html.theme--catppuccin-macchiato .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}html.theme--catppuccin-macchiato .progress::-webkit-progress-bar{background-color:#494d64}html.theme--catppuccin-macchiato .progress::-webkit-progress-value{background-color:#8087a2}html.theme--catppuccin-macchiato .progress::-moz-progress-bar{background-color:#8087a2}html.theme--catppuccin-macchiato .progress::-ms-fill{background-color:#8087a2;border:none}html.theme--catppuccin-macchiato .progress.is-white::-webkit-progress-value{background-color:#fff}html.theme--catppuccin-macchiato .progress.is-white::-moz-progress-bar{background-color:#fff}html.theme--catppuccin-macchiato .progress.is-white::-ms-fill{background-color:#fff}html.theme--catppuccin-macchiato .progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-black::-webkit-progress-value{background-color:#0a0a0a}html.theme--catppuccin-macchiato .progress.is-black::-moz-progress-bar{background-color:#0a0a0a}html.theme--catppuccin-macchiato .progress.is-black::-ms-fill{background-color:#0a0a0a}html.theme--catppuccin-macchiato .progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-light::-webkit-progress-value{background-color:#f5f5f5}html.theme--catppuccin-macchiato .progress.is-light::-moz-progress-bar{background-color:#f5f5f5}html.theme--catppuccin-macchiato .progress.is-light::-ms-fill{background-color:#f5f5f5}html.theme--catppuccin-macchiato .progress.is-light:indeterminate{background-image:linear-gradient(to right, #f5f5f5 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-dark::-webkit-progress-value,html.theme--catppuccin-macchiato .content kbd.progress::-webkit-progress-value{background-color:#363a4f}html.theme--catppuccin-macchiato .progress.is-dark::-moz-progress-bar,html.theme--catppuccin-macchiato .content kbd.progress::-moz-progress-bar{background-color:#363a4f}html.theme--catppuccin-macchiato .progress.is-dark::-ms-fill,html.theme--catppuccin-macchiato .content kbd.progress::-ms-fill{background-color:#363a4f}html.theme--catppuccin-macchiato .progress.is-dark:indeterminate,html.theme--catppuccin-macchiato .content kbd.progress:indeterminate{background-image:linear-gradient(to right, #363a4f 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-primary::-webkit-progress-value,html.theme--catppuccin-macchiato .docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-primary::-moz-progress-bar,html.theme--catppuccin-macchiato .docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-primary::-ms-fill,html.theme--catppuccin-macchiato .docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-primary:indeterminate,html.theme--catppuccin-macchiato .docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #8aadf4 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-link::-webkit-progress-value{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-link::-moz-progress-bar{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-link::-ms-fill{background-color:#8aadf4}html.theme--catppuccin-macchiato .progress.is-link:indeterminate{background-image:linear-gradient(to right, #8aadf4 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-info::-webkit-progress-value{background-color:#8bd5ca}html.theme--catppuccin-macchiato .progress.is-info::-moz-progress-bar{background-color:#8bd5ca}html.theme--catppuccin-macchiato .progress.is-info::-ms-fill{background-color:#8bd5ca}html.theme--catppuccin-macchiato .progress.is-info:indeterminate{background-image:linear-gradient(to right, #8bd5ca 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-success::-webkit-progress-value{background-color:#a6da95}html.theme--catppuccin-macchiato .progress.is-success::-moz-progress-bar{background-color:#a6da95}html.theme--catppuccin-macchiato .progress.is-success::-ms-fill{background-color:#a6da95}html.theme--catppuccin-macchiato .progress.is-success:indeterminate{background-image:linear-gradient(to right, #a6da95 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-warning::-webkit-progress-value{background-color:#eed49f}html.theme--catppuccin-macchiato .progress.is-warning::-moz-progress-bar{background-color:#eed49f}html.theme--catppuccin-macchiato .progress.is-warning::-ms-fill{background-color:#eed49f}html.theme--catppuccin-macchiato .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #eed49f 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress.is-danger::-webkit-progress-value{background-color:#ed8796}html.theme--catppuccin-macchiato .progress.is-danger::-moz-progress-bar{background-color:#ed8796}html.theme--catppuccin-macchiato .progress.is-danger::-ms-fill{background-color:#ed8796}html.theme--catppuccin-macchiato .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #ed8796 30%, #494d64 30%)}html.theme--catppuccin-macchiato .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#494d64;background-image:linear-gradient(to right, #cad3f5 30%, #494d64 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}html.theme--catppuccin-macchiato .progress:indeterminate::-webkit-progress-bar{background-color:transparent}html.theme--catppuccin-macchiato .progress:indeterminate::-moz-progress-bar{background-color:transparent}html.theme--catppuccin-macchiato .progress:indeterminate::-ms-fill{animation-name:none}html.theme--catppuccin-macchiato .progress.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}html.theme--catppuccin-macchiato .progress.is-medium{height:1.25rem}html.theme--catppuccin-macchiato .progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}html.theme--catppuccin-macchiato .table{background-color:#494d64;color:#cad3f5}html.theme--catppuccin-macchiato .table td,html.theme--catppuccin-macchiato .table th{border:1px solid #5b6078;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-macchiato .table td.is-white,html.theme--catppuccin-macchiato .table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .table td.is-black,html.theme--catppuccin-macchiato .table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .table td.is-light,html.theme--catppuccin-macchiato .table th.is-light{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .table td.is-dark,html.theme--catppuccin-macchiato .table th.is-dark{background-color:#363a4f;border-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .table td.is-primary,html.theme--catppuccin-macchiato .table th.is-primary{background-color:#8aadf4;border-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .table td.is-link,html.theme--catppuccin-macchiato .table th.is-link{background-color:#8aadf4;border-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .table td.is-info,html.theme--catppuccin-macchiato .table th.is-info{background-color:#8bd5ca;border-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .table td.is-success,html.theme--catppuccin-macchiato .table th.is-success{background-color:#a6da95;border-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .table td.is-warning,html.theme--catppuccin-macchiato .table th.is-warning{background-color:#eed49f;border-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .table td.is-danger,html.theme--catppuccin-macchiato .table th.is-danger{background-color:#ed8796;border-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .table td.is-narrow,html.theme--catppuccin-macchiato .table th.is-narrow{white-space:nowrap;width:1%}html.theme--catppuccin-macchiato .table td.is-selected,html.theme--catppuccin-macchiato .table th.is-selected{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .table td.is-selected a,html.theme--catppuccin-macchiato .table td.is-selected strong,html.theme--catppuccin-macchiato .table th.is-selected a,html.theme--catppuccin-macchiato .table th.is-selected strong{color:currentColor}html.theme--catppuccin-macchiato .table td.is-vcentered,html.theme--catppuccin-macchiato .table th.is-vcentered{vertical-align:middle}html.theme--catppuccin-macchiato .table th{color:#b5c1f1}html.theme--catppuccin-macchiato .table th:not([align]){text-align:left}html.theme--catppuccin-macchiato .table tr.is-selected{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .table tr.is-selected a,html.theme--catppuccin-macchiato .table tr.is-selected strong{color:currentColor}html.theme--catppuccin-macchiato .table tr.is-selected td,html.theme--catppuccin-macchiato .table tr.is-selected th{border-color:#fff;color:currentColor}html.theme--catppuccin-macchiato .table thead{background-color:rgba(0,0,0,0)}html.theme--catppuccin-macchiato .table thead td,html.theme--catppuccin-macchiato .table thead th{border-width:0 0 2px;color:#b5c1f1}html.theme--catppuccin-macchiato .table tfoot{background-color:rgba(0,0,0,0)}html.theme--catppuccin-macchiato .table tfoot td,html.theme--catppuccin-macchiato .table tfoot th{border-width:2px 0 0;color:#b5c1f1}html.theme--catppuccin-macchiato .table tbody{background-color:rgba(0,0,0,0)}html.theme--catppuccin-macchiato .table tbody tr:last-child td,html.theme--catppuccin-macchiato .table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-macchiato .table.is-bordered td,html.theme--catppuccin-macchiato .table.is-bordered th{border-width:1px}html.theme--catppuccin-macchiato .table.is-bordered tr:last-child td,html.theme--catppuccin-macchiato .table.is-bordered tr:last-child th{border-bottom-width:1px}html.theme--catppuccin-macchiato .table.is-fullwidth{width:100%}html.theme--catppuccin-macchiato .table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#363a4f}html.theme--catppuccin-macchiato .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#363a4f}html.theme--catppuccin-macchiato .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#3a3e55}html.theme--catppuccin-macchiato .table.is-narrow td,html.theme--catppuccin-macchiato .table.is-narrow th{padding:0.25em 0.5em}html.theme--catppuccin-macchiato .table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#363a4f}html.theme--catppuccin-macchiato .table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}html.theme--catppuccin-macchiato .tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-macchiato .tags .tag,html.theme--catppuccin-macchiato .tags .content kbd,html.theme--catppuccin-macchiato .content .tags kbd,html.theme--catppuccin-macchiato .tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}html.theme--catppuccin-macchiato .tags .tag:not(:last-child),html.theme--catppuccin-macchiato .tags .content kbd:not(:last-child),html.theme--catppuccin-macchiato .content .tags kbd:not(:last-child),html.theme--catppuccin-macchiato .tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}html.theme--catppuccin-macchiato .tags:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-macchiato .tags:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-macchiato .tags.are-medium .tag:not(.is-normal):not(.is-large),html.theme--catppuccin-macchiato .tags.are-medium .content kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-macchiato .content .tags.are-medium kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-macchiato .tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}html.theme--catppuccin-macchiato .tags.are-large .tag:not(.is-normal):not(.is-medium),html.theme--catppuccin-macchiato .tags.are-large .content kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-macchiato .content .tags.are-large kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-macchiato .tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}html.theme--catppuccin-macchiato .tags.is-centered{justify-content:center}html.theme--catppuccin-macchiato .tags.is-centered .tag,html.theme--catppuccin-macchiato .tags.is-centered .content kbd,html.theme--catppuccin-macchiato .content .tags.is-centered kbd,html.theme--catppuccin-macchiato .tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}html.theme--catppuccin-macchiato .tags.is-right{justify-content:flex-end}html.theme--catppuccin-macchiato .tags.is-right .tag:not(:first-child),html.theme--catppuccin-macchiato .tags.is-right .content kbd:not(:first-child),html.theme--catppuccin-macchiato .content .tags.is-right kbd:not(:first-child),html.theme--catppuccin-macchiato .tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}html.theme--catppuccin-macchiato .tags.is-right .tag:not(:last-child),html.theme--catppuccin-macchiato .tags.is-right .content kbd:not(:last-child),html.theme--catppuccin-macchiato .content .tags.is-right kbd:not(:last-child),html.theme--catppuccin-macchiato .tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}html.theme--catppuccin-macchiato .tags.has-addons .tag,html.theme--catppuccin-macchiato .tags.has-addons .content kbd,html.theme--catppuccin-macchiato .content .tags.has-addons kbd,html.theme--catppuccin-macchiato .tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}html.theme--catppuccin-macchiato .tags.has-addons .tag:not(:first-child),html.theme--catppuccin-macchiato .tags.has-addons .content kbd:not(:first-child),html.theme--catppuccin-macchiato .content .tags.has-addons kbd:not(:first-child),html.theme--catppuccin-macchiato .tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}html.theme--catppuccin-macchiato .tags.has-addons .tag:not(:last-child),html.theme--catppuccin-macchiato .tags.has-addons .content kbd:not(:last-child),html.theme--catppuccin-macchiato .content .tags.has-addons kbd:not(:last-child),html.theme--catppuccin-macchiato .tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}html.theme--catppuccin-macchiato .tag:not(body),html.theme--catppuccin-macchiato .content kbd:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#1e2030;border-radius:.4em;color:#cad3f5;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}html.theme--catppuccin-macchiato .tag:not(body) .delete,html.theme--catppuccin-macchiato .content kbd:not(body) .delete,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}html.theme--catppuccin-macchiato .tag.is-white:not(body),html.theme--catppuccin-macchiato .content kbd.is-white:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .tag.is-black:not(body),html.theme--catppuccin-macchiato .content kbd.is-black:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .tag.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .tag.is-dark:not(body),html.theme--catppuccin-macchiato .content kbd:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-dark:not(body),html.theme--catppuccin-macchiato .content .docstring>section>kbd:not(body){background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .tag.is-primary:not(body),html.theme--catppuccin-macchiato .content kbd.is-primary:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body){background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .tag.is-primary.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-primary.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .tag.is-link:not(body),html.theme--catppuccin-macchiato .content kbd.is-link:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .tag.is-link.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-link.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#ecf2fd;color:#0e3b95}html.theme--catppuccin-macchiato .tag.is-info:not(body),html.theme--catppuccin-macchiato .content kbd.is-info:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .tag.is-info.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-info.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#f0faf8;color:#276d62}html.theme--catppuccin-macchiato .tag.is-success:not(body),html.theme--catppuccin-macchiato .content kbd.is-success:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .tag.is-success.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-success.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#f2faf0;color:#386e26}html.theme--catppuccin-macchiato .tag.is-warning:not(body),html.theme--catppuccin-macchiato .content kbd.is-warning:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .tag.is-warning.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-warning.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fcf7ee;color:#7e5c16}html.theme--catppuccin-macchiato .tag.is-danger:not(body),html.theme--catppuccin-macchiato .content kbd.is-danger:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .tag.is-danger.is-light:not(body),html.theme--catppuccin-macchiato .content kbd.is-danger.is-light:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#fcedef;color:#971729}html.theme--catppuccin-macchiato .tag.is-normal:not(body),html.theme--catppuccin-macchiato .content kbd.is-normal:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}html.theme--catppuccin-macchiato .tag.is-medium:not(body),html.theme--catppuccin-macchiato .content kbd.is-medium:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}html.theme--catppuccin-macchiato .tag.is-large:not(body),html.theme--catppuccin-macchiato .content kbd.is-large:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}html.theme--catppuccin-macchiato .tag:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-macchiato .content kbd:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}html.theme--catppuccin-macchiato .tag:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-macchiato .content kbd:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}html.theme--catppuccin-macchiato .tag:not(body) .icon:first-child:last-child,html.theme--catppuccin-macchiato .content kbd:not(body) .icon:first-child:last-child,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}html.theme--catppuccin-macchiato .tag.is-delete:not(body),html.theme--catppuccin-macchiato .content kbd.is-delete:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}html.theme--catppuccin-macchiato .tag.is-delete:not(body)::before,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body)::before,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body)::before,html.theme--catppuccin-macchiato .tag.is-delete:not(body)::after,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body)::after,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-macchiato .tag.is-delete:not(body)::before,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body)::before,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}html.theme--catppuccin-macchiato .tag.is-delete:not(body)::after,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body)::after,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}html.theme--catppuccin-macchiato .tag.is-delete:not(body):hover,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body):hover,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body):hover,html.theme--catppuccin-macchiato .tag.is-delete:not(body):focus,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body):focus,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#141620}html.theme--catppuccin-macchiato .tag.is-delete:not(body):active,html.theme--catppuccin-macchiato .content kbd.is-delete:not(body):active,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#0a0b11}html.theme--catppuccin-macchiato .tag.is-rounded:not(body),html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:not(body),html.theme--catppuccin-macchiato .content kbd.is-rounded:not(body),html.theme--catppuccin-macchiato #documenter .docs-sidebar .content form.docs-search>input:not(body),html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}html.theme--catppuccin-macchiato a.tag:hover,html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:hover{text-decoration:underline}html.theme--catppuccin-macchiato .title,html.theme--catppuccin-macchiato .subtitle{word-break:break-word}html.theme--catppuccin-macchiato .title em,html.theme--catppuccin-macchiato .title span,html.theme--catppuccin-macchiato .subtitle em,html.theme--catppuccin-macchiato .subtitle span{font-weight:inherit}html.theme--catppuccin-macchiato .title sub,html.theme--catppuccin-macchiato .subtitle sub{font-size:.75em}html.theme--catppuccin-macchiato .title sup,html.theme--catppuccin-macchiato .subtitle sup{font-size:.75em}html.theme--catppuccin-macchiato .title .tag,html.theme--catppuccin-macchiato .title .content kbd,html.theme--catppuccin-macchiato .content .title kbd,html.theme--catppuccin-macchiato .title .docstring>section>a.docs-sourcelink,html.theme--catppuccin-macchiato .subtitle .tag,html.theme--catppuccin-macchiato .subtitle .content kbd,html.theme--catppuccin-macchiato .content .subtitle kbd,html.theme--catppuccin-macchiato .subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}html.theme--catppuccin-macchiato .title{color:#fff;font-size:2rem;font-weight:500;line-height:1.125}html.theme--catppuccin-macchiato .title strong{color:inherit;font-weight:inherit}html.theme--catppuccin-macchiato .title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}html.theme--catppuccin-macchiato .title.is-1{font-size:3rem}html.theme--catppuccin-macchiato .title.is-2{font-size:2.5rem}html.theme--catppuccin-macchiato .title.is-3{font-size:2rem}html.theme--catppuccin-macchiato .title.is-4{font-size:1.5rem}html.theme--catppuccin-macchiato .title.is-5{font-size:1.25rem}html.theme--catppuccin-macchiato .title.is-6{font-size:1rem}html.theme--catppuccin-macchiato .title.is-7{font-size:.75rem}html.theme--catppuccin-macchiato .subtitle{color:#6e738d;font-size:1.25rem;font-weight:400;line-height:1.25}html.theme--catppuccin-macchiato .subtitle strong{color:#6e738d;font-weight:600}html.theme--catppuccin-macchiato .subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}html.theme--catppuccin-macchiato .subtitle.is-1{font-size:3rem}html.theme--catppuccin-macchiato .subtitle.is-2{font-size:2.5rem}html.theme--catppuccin-macchiato .subtitle.is-3{font-size:2rem}html.theme--catppuccin-macchiato .subtitle.is-4{font-size:1.5rem}html.theme--catppuccin-macchiato .subtitle.is-5{font-size:1.25rem}html.theme--catppuccin-macchiato .subtitle.is-6{font-size:1rem}html.theme--catppuccin-macchiato .subtitle.is-7{font-size:.75rem}html.theme--catppuccin-macchiato .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--catppuccin-macchiato .number{align-items:center;background-color:#1e2030;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}html.theme--catppuccin-macchiato .select select,html.theme--catppuccin-macchiato .textarea,html.theme--catppuccin-macchiato .input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{background-color:#24273a;border-color:#5b6078;border-radius:.4em;color:#8087a2}html.theme--catppuccin-macchiato .select select::-moz-placeholder,html.theme--catppuccin-macchiato .textarea::-moz-placeholder,html.theme--catppuccin-macchiato .input::-moz-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#868c98}html.theme--catppuccin-macchiato .select select::-webkit-input-placeholder,html.theme--catppuccin-macchiato .textarea::-webkit-input-placeholder,html.theme--catppuccin-macchiato .input::-webkit-input-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#868c98}html.theme--catppuccin-macchiato .select select:-moz-placeholder,html.theme--catppuccin-macchiato .textarea:-moz-placeholder,html.theme--catppuccin-macchiato .input:-moz-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#868c98}html.theme--catppuccin-macchiato .select select:-ms-input-placeholder,html.theme--catppuccin-macchiato .textarea:-ms-input-placeholder,html.theme--catppuccin-macchiato .input:-ms-input-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#868c98}html.theme--catppuccin-macchiato .select select:hover,html.theme--catppuccin-macchiato .textarea:hover,html.theme--catppuccin-macchiato .input:hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:hover,html.theme--catppuccin-macchiato .select select.is-hovered,html.theme--catppuccin-macchiato .is-hovered.textarea,html.theme--catppuccin-macchiato .is-hovered.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#6e738d}html.theme--catppuccin-macchiato .select select:focus,html.theme--catppuccin-macchiato .textarea:focus,html.theme--catppuccin-macchiato .input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-macchiato .select select.is-focused,html.theme--catppuccin-macchiato .is-focused.textarea,html.theme--catppuccin-macchiato .is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .select select:active,html.theme--catppuccin-macchiato .textarea:active,html.theme--catppuccin-macchiato .input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-macchiato .select select.is-active,html.theme--catppuccin-macchiato .is-active.textarea,html.theme--catppuccin-macchiato .is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{border-color:#8aadf4;box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .select select[disabled],html.theme--catppuccin-macchiato .textarea[disabled],html.theme--catppuccin-macchiato .input[disabled],html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .select select,fieldset[disabled] html.theme--catppuccin-macchiato .textarea,fieldset[disabled] html.theme--catppuccin-macchiato .input,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{background-color:#6e738d;border-color:#1e2030;box-shadow:none;color:#f5f7fd}html.theme--catppuccin-macchiato .select select[disabled]::-moz-placeholder,html.theme--catppuccin-macchiato .textarea[disabled]::-moz-placeholder,html.theme--catppuccin-macchiato .input[disabled]::-moz-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .select select::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .textarea::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .input::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(245,247,253,0.3)}html.theme--catppuccin-macchiato .select select[disabled]::-webkit-input-placeholder,html.theme--catppuccin-macchiato .textarea[disabled]::-webkit-input-placeholder,html.theme--catppuccin-macchiato .input[disabled]::-webkit-input-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .select select::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .textarea::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .input::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(245,247,253,0.3)}html.theme--catppuccin-macchiato .select select[disabled]:-moz-placeholder,html.theme--catppuccin-macchiato .textarea[disabled]:-moz-placeholder,html.theme--catppuccin-macchiato .input[disabled]:-moz-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .select select:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .textarea:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .input:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(245,247,253,0.3)}html.theme--catppuccin-macchiato .select select[disabled]:-ms-input-placeholder,html.theme--catppuccin-macchiato .textarea[disabled]:-ms-input-placeholder,html.theme--catppuccin-macchiato .input[disabled]:-ms-input-placeholder,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .select select:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .textarea:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato .input:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(245,247,253,0.3)}html.theme--catppuccin-macchiato .textarea,html.theme--catppuccin-macchiato .input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}html.theme--catppuccin-macchiato .textarea[readonly],html.theme--catppuccin-macchiato .input[readonly],html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}html.theme--catppuccin-macchiato .is-white.textarea,html.theme--catppuccin-macchiato .is-white.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}html.theme--catppuccin-macchiato .is-white.textarea:focus,html.theme--catppuccin-macchiato .is-white.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-white:focus,html.theme--catppuccin-macchiato .is-white.is-focused.textarea,html.theme--catppuccin-macchiato .is-white.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-white.textarea:active,html.theme--catppuccin-macchiato .is-white.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-white:active,html.theme--catppuccin-macchiato .is-white.is-active.textarea,html.theme--catppuccin-macchiato .is-white.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-macchiato .is-black.textarea,html.theme--catppuccin-macchiato .is-black.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}html.theme--catppuccin-macchiato .is-black.textarea:focus,html.theme--catppuccin-macchiato .is-black.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-black:focus,html.theme--catppuccin-macchiato .is-black.is-focused.textarea,html.theme--catppuccin-macchiato .is-black.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-black.textarea:active,html.theme--catppuccin-macchiato .is-black.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-black:active,html.theme--catppuccin-macchiato .is-black.is-active.textarea,html.theme--catppuccin-macchiato .is-black.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-macchiato .is-light.textarea,html.theme--catppuccin-macchiato .is-light.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-light{border-color:#f5f5f5}html.theme--catppuccin-macchiato .is-light.textarea:focus,html.theme--catppuccin-macchiato .is-light.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-light:focus,html.theme--catppuccin-macchiato .is-light.is-focused.textarea,html.theme--catppuccin-macchiato .is-light.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-light.textarea:active,html.theme--catppuccin-macchiato .is-light.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-light:active,html.theme--catppuccin-macchiato .is-light.is-active.textarea,html.theme--catppuccin-macchiato .is-light.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-macchiato .is-dark.textarea,html.theme--catppuccin-macchiato .content kbd.textarea,html.theme--catppuccin-macchiato .is-dark.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-dark,html.theme--catppuccin-macchiato .content kbd.input{border-color:#363a4f}html.theme--catppuccin-macchiato .is-dark.textarea:focus,html.theme--catppuccin-macchiato .content kbd.textarea:focus,html.theme--catppuccin-macchiato .is-dark.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-dark:focus,html.theme--catppuccin-macchiato .content kbd.input:focus,html.theme--catppuccin-macchiato .is-dark.is-focused.textarea,html.theme--catppuccin-macchiato .content kbd.is-focused.textarea,html.theme--catppuccin-macchiato .is-dark.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .content kbd.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .content form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-dark.textarea:active,html.theme--catppuccin-macchiato .content kbd.textarea:active,html.theme--catppuccin-macchiato .is-dark.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-dark:active,html.theme--catppuccin-macchiato .content kbd.input:active,html.theme--catppuccin-macchiato .is-dark.is-active.textarea,html.theme--catppuccin-macchiato .content kbd.is-active.textarea,html.theme--catppuccin-macchiato .is-dark.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-macchiato .content kbd.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(54,58,79,0.25)}html.theme--catppuccin-macchiato .is-primary.textarea,html.theme--catppuccin-macchiato .docstring>section>a.textarea.docs-sourcelink,html.theme--catppuccin-macchiato .is-primary.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.input.docs-sourcelink{border-color:#8aadf4}html.theme--catppuccin-macchiato .is-primary.textarea:focus,html.theme--catppuccin-macchiato .docstring>section>a.textarea.docs-sourcelink:focus,html.theme--catppuccin-macchiato .is-primary.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-primary:focus,html.theme--catppuccin-macchiato .docstring>section>a.input.docs-sourcelink:focus,html.theme--catppuccin-macchiato .is-primary.is-focused.textarea,html.theme--catppuccin-macchiato .docstring>section>a.is-focused.textarea.docs-sourcelink,html.theme--catppuccin-macchiato .is-primary.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .docstring>section>a.is-focused.input.docs-sourcelink,html.theme--catppuccin-macchiato .is-primary.textarea:active,html.theme--catppuccin-macchiato .docstring>section>a.textarea.docs-sourcelink:active,html.theme--catppuccin-macchiato .is-primary.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-primary:active,html.theme--catppuccin-macchiato .docstring>section>a.input.docs-sourcelink:active,html.theme--catppuccin-macchiato .is-primary.is-active.textarea,html.theme--catppuccin-macchiato .docstring>section>a.is-active.textarea.docs-sourcelink,html.theme--catppuccin-macchiato .is-primary.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-macchiato .docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .is-link.textarea,html.theme--catppuccin-macchiato .is-link.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-link{border-color:#8aadf4}html.theme--catppuccin-macchiato .is-link.textarea:focus,html.theme--catppuccin-macchiato .is-link.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-link:focus,html.theme--catppuccin-macchiato .is-link.is-focused.textarea,html.theme--catppuccin-macchiato .is-link.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-link.textarea:active,html.theme--catppuccin-macchiato .is-link.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-link:active,html.theme--catppuccin-macchiato .is-link.is-active.textarea,html.theme--catppuccin-macchiato .is-link.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .is-info.textarea,html.theme--catppuccin-macchiato .is-info.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-info{border-color:#8bd5ca}html.theme--catppuccin-macchiato .is-info.textarea:focus,html.theme--catppuccin-macchiato .is-info.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-info:focus,html.theme--catppuccin-macchiato .is-info.is-focused.textarea,html.theme--catppuccin-macchiato .is-info.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-info.textarea:active,html.theme--catppuccin-macchiato .is-info.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-info:active,html.theme--catppuccin-macchiato .is-info.is-active.textarea,html.theme--catppuccin-macchiato .is-info.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(139,213,202,0.25)}html.theme--catppuccin-macchiato .is-success.textarea,html.theme--catppuccin-macchiato .is-success.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-success{border-color:#a6da95}html.theme--catppuccin-macchiato .is-success.textarea:focus,html.theme--catppuccin-macchiato .is-success.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-success:focus,html.theme--catppuccin-macchiato .is-success.is-focused.textarea,html.theme--catppuccin-macchiato .is-success.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-success.textarea:active,html.theme--catppuccin-macchiato .is-success.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-success:active,html.theme--catppuccin-macchiato .is-success.is-active.textarea,html.theme--catppuccin-macchiato .is-success.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(166,218,149,0.25)}html.theme--catppuccin-macchiato .is-warning.textarea,html.theme--catppuccin-macchiato .is-warning.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#eed49f}html.theme--catppuccin-macchiato .is-warning.textarea:focus,html.theme--catppuccin-macchiato .is-warning.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-warning:focus,html.theme--catppuccin-macchiato .is-warning.is-focused.textarea,html.theme--catppuccin-macchiato .is-warning.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-warning.textarea:active,html.theme--catppuccin-macchiato .is-warning.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-warning:active,html.theme--catppuccin-macchiato .is-warning.is-active.textarea,html.theme--catppuccin-macchiato .is-warning.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(238,212,159,0.25)}html.theme--catppuccin-macchiato .is-danger.textarea,html.theme--catppuccin-macchiato .is-danger.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#ed8796}html.theme--catppuccin-macchiato .is-danger.textarea:focus,html.theme--catppuccin-macchiato .is-danger.input:focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-danger:focus,html.theme--catppuccin-macchiato .is-danger.is-focused.textarea,html.theme--catppuccin-macchiato .is-danger.is-focused.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-macchiato .is-danger.textarea:active,html.theme--catppuccin-macchiato .is-danger.input:active,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-danger:active,html.theme--catppuccin-macchiato .is-danger.is-active.textarea,html.theme--catppuccin-macchiato .is-danger.is-active.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(237,135,150,0.25)}html.theme--catppuccin-macchiato .is-small.textarea,html.theme--catppuccin-macchiato .is-small.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{border-radius:3px;font-size:.75rem}html.theme--catppuccin-macchiato .is-medium.textarea,html.theme--catppuccin-macchiato .is-medium.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .is-large.textarea,html.theme--catppuccin-macchiato .is-large.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .is-fullwidth.textarea,html.theme--catppuccin-macchiato .is-fullwidth.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}html.theme--catppuccin-macchiato .is-inline.textarea,html.theme--catppuccin-macchiato .is-inline.input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}html.theme--catppuccin-macchiato .input.is-rounded,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}html.theme--catppuccin-macchiato .input.is-static,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}html.theme--catppuccin-macchiato .textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}html.theme--catppuccin-macchiato .textarea:not([rows]){max-height:40em;min-height:8em}html.theme--catppuccin-macchiato .textarea[rows]{height:initial}html.theme--catppuccin-macchiato .textarea.has-fixed-size{resize:none}html.theme--catppuccin-macchiato .radio,html.theme--catppuccin-macchiato .checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}html.theme--catppuccin-macchiato .radio input,html.theme--catppuccin-macchiato .checkbox input{cursor:pointer}html.theme--catppuccin-macchiato .radio:hover,html.theme--catppuccin-macchiato .checkbox:hover{color:#91d7e3}html.theme--catppuccin-macchiato .radio[disabled],html.theme--catppuccin-macchiato .checkbox[disabled],fieldset[disabled] html.theme--catppuccin-macchiato .radio,fieldset[disabled] html.theme--catppuccin-macchiato .checkbox,html.theme--catppuccin-macchiato .radio input[disabled],html.theme--catppuccin-macchiato .checkbox input[disabled]{color:#f5f7fd;cursor:not-allowed}html.theme--catppuccin-macchiato .radio+.radio{margin-left:.5em}html.theme--catppuccin-macchiato .select{display:inline-block;max-width:100%;position:relative;vertical-align:top}html.theme--catppuccin-macchiato .select:not(.is-multiple){height:2.5em}html.theme--catppuccin-macchiato .select:not(.is-multiple):not(.is-loading)::after{border-color:#8aadf4;right:1.125em;z-index:4}html.theme--catppuccin-macchiato .select.is-rounded select,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}html.theme--catppuccin-macchiato .select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}html.theme--catppuccin-macchiato .select select::-ms-expand{display:none}html.theme--catppuccin-macchiato .select select[disabled]:hover,fieldset[disabled] html.theme--catppuccin-macchiato .select select:hover{border-color:#1e2030}html.theme--catppuccin-macchiato .select select:not([multiple]){padding-right:2.5em}html.theme--catppuccin-macchiato .select select[multiple]{height:auto;padding:0}html.theme--catppuccin-macchiato .select select[multiple] option{padding:0.5em 1em}html.theme--catppuccin-macchiato .select:not(.is-multiple):not(.is-loading):hover::after{border-color:#91d7e3}html.theme--catppuccin-macchiato .select.is-white:not(:hover)::after{border-color:#fff}html.theme--catppuccin-macchiato .select.is-white select{border-color:#fff}html.theme--catppuccin-macchiato .select.is-white select:hover,html.theme--catppuccin-macchiato .select.is-white select.is-hovered{border-color:#f2f2f2}html.theme--catppuccin-macchiato .select.is-white select:focus,html.theme--catppuccin-macchiato .select.is-white select.is-focused,html.theme--catppuccin-macchiato .select.is-white select:active,html.theme--catppuccin-macchiato .select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-macchiato .select.is-black:not(:hover)::after{border-color:#0a0a0a}html.theme--catppuccin-macchiato .select.is-black select{border-color:#0a0a0a}html.theme--catppuccin-macchiato .select.is-black select:hover,html.theme--catppuccin-macchiato .select.is-black select.is-hovered{border-color:#000}html.theme--catppuccin-macchiato .select.is-black select:focus,html.theme--catppuccin-macchiato .select.is-black select.is-focused,html.theme--catppuccin-macchiato .select.is-black select:active,html.theme--catppuccin-macchiato .select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-macchiato .select.is-light:not(:hover)::after{border-color:#f5f5f5}html.theme--catppuccin-macchiato .select.is-light select{border-color:#f5f5f5}html.theme--catppuccin-macchiato .select.is-light select:hover,html.theme--catppuccin-macchiato .select.is-light select.is-hovered{border-color:#e8e8e8}html.theme--catppuccin-macchiato .select.is-light select:focus,html.theme--catppuccin-macchiato .select.is-light select.is-focused,html.theme--catppuccin-macchiato .select.is-light select:active,html.theme--catppuccin-macchiato .select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-macchiato .select.is-dark:not(:hover)::after,html.theme--catppuccin-macchiato .content kbd.select:not(:hover)::after{border-color:#363a4f}html.theme--catppuccin-macchiato .select.is-dark select,html.theme--catppuccin-macchiato .content kbd.select select{border-color:#363a4f}html.theme--catppuccin-macchiato .select.is-dark select:hover,html.theme--catppuccin-macchiato .content kbd.select select:hover,html.theme--catppuccin-macchiato .select.is-dark select.is-hovered,html.theme--catppuccin-macchiato .content kbd.select select.is-hovered{border-color:#2c2f40}html.theme--catppuccin-macchiato .select.is-dark select:focus,html.theme--catppuccin-macchiato .content kbd.select select:focus,html.theme--catppuccin-macchiato .select.is-dark select.is-focused,html.theme--catppuccin-macchiato .content kbd.select select.is-focused,html.theme--catppuccin-macchiato .select.is-dark select:active,html.theme--catppuccin-macchiato .content kbd.select select:active,html.theme--catppuccin-macchiato .select.is-dark select.is-active,html.theme--catppuccin-macchiato .content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(54,58,79,0.25)}html.theme--catppuccin-macchiato .select.is-primary:not(:hover)::after,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#8aadf4}html.theme--catppuccin-macchiato .select.is-primary select,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select{border-color:#8aadf4}html.theme--catppuccin-macchiato .select.is-primary select:hover,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select:hover,html.theme--catppuccin-macchiato .select.is-primary select.is-hovered,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#739df2}html.theme--catppuccin-macchiato .select.is-primary select:focus,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select:focus,html.theme--catppuccin-macchiato .select.is-primary select.is-focused,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select.is-focused,html.theme--catppuccin-macchiato .select.is-primary select:active,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select:active,html.theme--catppuccin-macchiato .select.is-primary select.is-active,html.theme--catppuccin-macchiato .docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .select.is-link:not(:hover)::after{border-color:#8aadf4}html.theme--catppuccin-macchiato .select.is-link select{border-color:#8aadf4}html.theme--catppuccin-macchiato .select.is-link select:hover,html.theme--catppuccin-macchiato .select.is-link select.is-hovered{border-color:#739df2}html.theme--catppuccin-macchiato .select.is-link select:focus,html.theme--catppuccin-macchiato .select.is-link select.is-focused,html.theme--catppuccin-macchiato .select.is-link select:active,html.theme--catppuccin-macchiato .select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(138,173,244,0.25)}html.theme--catppuccin-macchiato .select.is-info:not(:hover)::after{border-color:#8bd5ca}html.theme--catppuccin-macchiato .select.is-info select{border-color:#8bd5ca}html.theme--catppuccin-macchiato .select.is-info select:hover,html.theme--catppuccin-macchiato .select.is-info select.is-hovered{border-color:#78cec1}html.theme--catppuccin-macchiato .select.is-info select:focus,html.theme--catppuccin-macchiato .select.is-info select.is-focused,html.theme--catppuccin-macchiato .select.is-info select:active,html.theme--catppuccin-macchiato .select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(139,213,202,0.25)}html.theme--catppuccin-macchiato .select.is-success:not(:hover)::after{border-color:#a6da95}html.theme--catppuccin-macchiato .select.is-success select{border-color:#a6da95}html.theme--catppuccin-macchiato .select.is-success select:hover,html.theme--catppuccin-macchiato .select.is-success select.is-hovered{border-color:#96d382}html.theme--catppuccin-macchiato .select.is-success select:focus,html.theme--catppuccin-macchiato .select.is-success select.is-focused,html.theme--catppuccin-macchiato .select.is-success select:active,html.theme--catppuccin-macchiato .select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(166,218,149,0.25)}html.theme--catppuccin-macchiato .select.is-warning:not(:hover)::after{border-color:#eed49f}html.theme--catppuccin-macchiato .select.is-warning select{border-color:#eed49f}html.theme--catppuccin-macchiato .select.is-warning select:hover,html.theme--catppuccin-macchiato .select.is-warning select.is-hovered{border-color:#eaca89}html.theme--catppuccin-macchiato .select.is-warning select:focus,html.theme--catppuccin-macchiato .select.is-warning select.is-focused,html.theme--catppuccin-macchiato .select.is-warning select:active,html.theme--catppuccin-macchiato .select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(238,212,159,0.25)}html.theme--catppuccin-macchiato .select.is-danger:not(:hover)::after{border-color:#ed8796}html.theme--catppuccin-macchiato .select.is-danger select{border-color:#ed8796}html.theme--catppuccin-macchiato .select.is-danger select:hover,html.theme--catppuccin-macchiato .select.is-danger select.is-hovered{border-color:#ea7183}html.theme--catppuccin-macchiato .select.is-danger select:focus,html.theme--catppuccin-macchiato .select.is-danger select.is-focused,html.theme--catppuccin-macchiato .select.is-danger select:active,html.theme--catppuccin-macchiato .select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(237,135,150,0.25)}html.theme--catppuccin-macchiato .select.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.select{border-radius:3px;font-size:.75rem}html.theme--catppuccin-macchiato .select.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .select.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .select.is-disabled::after{border-color:#f5f7fd !important;opacity:0.5}html.theme--catppuccin-macchiato .select.is-fullwidth{width:100%}html.theme--catppuccin-macchiato .select.is-fullwidth select{width:100%}html.theme--catppuccin-macchiato .select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}html.theme--catppuccin-macchiato .select.is-loading.is-small:after,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-macchiato .select.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-macchiato .select.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-macchiato .file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}html.theme--catppuccin-macchiato .file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .file.is-white:hover .file-cta,html.theme--catppuccin-macchiato .file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .file.is-white:focus .file-cta,html.theme--catppuccin-macchiato .file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}html.theme--catppuccin-macchiato .file.is-white:active .file-cta,html.theme--catppuccin-macchiato .file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-macchiato .file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-black:hover .file-cta,html.theme--catppuccin-macchiato .file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-black:focus .file-cta,html.theme--catppuccin-macchiato .file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}html.theme--catppuccin-macchiato .file.is-black:active .file-cta,html.theme--catppuccin-macchiato .file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-light .file-cta{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-light:hover .file-cta,html.theme--catppuccin-macchiato .file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-light:focus .file-cta,html.theme--catppuccin-macchiato .file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(245,245,245,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-light:active .file-cta,html.theme--catppuccin-macchiato .file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-dark .file-cta,html.theme--catppuccin-macchiato .content kbd.file .file-cta{background-color:#363a4f;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-dark:hover .file-cta,html.theme--catppuccin-macchiato .content kbd.file:hover .file-cta,html.theme--catppuccin-macchiato .file.is-dark.is-hovered .file-cta,html.theme--catppuccin-macchiato .content kbd.file.is-hovered .file-cta{background-color:#313447;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-dark:focus .file-cta,html.theme--catppuccin-macchiato .content kbd.file:focus .file-cta,html.theme--catppuccin-macchiato .file.is-dark.is-focused .file-cta,html.theme--catppuccin-macchiato .content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(54,58,79,0.25);color:#fff}html.theme--catppuccin-macchiato .file.is-dark:active .file-cta,html.theme--catppuccin-macchiato .content kbd.file:active .file-cta,html.theme--catppuccin-macchiato .file.is-dark.is-active .file-cta,html.theme--catppuccin-macchiato .content kbd.file.is-active .file-cta{background-color:#2c2f40;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-primary .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.docs-sourcelink .file-cta{background-color:#8aadf4;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-primary:hover .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.docs-sourcelink:hover .file-cta,html.theme--catppuccin-macchiato .file.is-primary.is-hovered .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#7ea5f3;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-primary:focus .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.docs-sourcelink:focus .file-cta,html.theme--catppuccin-macchiato .file.is-primary.is-focused .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(138,173,244,0.25);color:#fff}html.theme--catppuccin-macchiato .file.is-primary:active .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.docs-sourcelink:active .file-cta,html.theme--catppuccin-macchiato .file.is-primary.is-active .file-cta,html.theme--catppuccin-macchiato .docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#739df2;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-link .file-cta{background-color:#8aadf4;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-link:hover .file-cta,html.theme--catppuccin-macchiato .file.is-link.is-hovered .file-cta{background-color:#7ea5f3;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-link:focus .file-cta,html.theme--catppuccin-macchiato .file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(138,173,244,0.25);color:#fff}html.theme--catppuccin-macchiato .file.is-link:active .file-cta,html.theme--catppuccin-macchiato .file.is-link.is-active .file-cta{background-color:#739df2;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-info .file-cta{background-color:#8bd5ca;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-info:hover .file-cta,html.theme--catppuccin-macchiato .file.is-info.is-hovered .file-cta{background-color:#82d2c6;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-info:focus .file-cta,html.theme--catppuccin-macchiato .file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(139,213,202,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-info:active .file-cta,html.theme--catppuccin-macchiato .file.is-info.is-active .file-cta{background-color:#78cec1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-success .file-cta{background-color:#a6da95;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-success:hover .file-cta,html.theme--catppuccin-macchiato .file.is-success.is-hovered .file-cta{background-color:#9ed78c;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-success:focus .file-cta,html.theme--catppuccin-macchiato .file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(166,218,149,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-success:active .file-cta,html.theme--catppuccin-macchiato .file.is-success.is-active .file-cta{background-color:#96d382;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-warning .file-cta{background-color:#eed49f;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-warning:hover .file-cta,html.theme--catppuccin-macchiato .file.is-warning.is-hovered .file-cta{background-color:#eccf94;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-warning:focus .file-cta,html.theme--catppuccin-macchiato .file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(238,212,159,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-warning:active .file-cta,html.theme--catppuccin-macchiato .file.is-warning.is-active .file-cta{background-color:#eaca89;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .file.is-danger .file-cta{background-color:#ed8796;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-danger:hover .file-cta,html.theme--catppuccin-macchiato .file.is-danger.is-hovered .file-cta{background-color:#eb7c8c;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-danger:focus .file-cta,html.theme--catppuccin-macchiato .file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(237,135,150,0.25);color:#fff}html.theme--catppuccin-macchiato .file.is-danger:active .file-cta,html.theme--catppuccin-macchiato .file.is-danger.is-active .file-cta{background-color:#ea7183;border-color:transparent;color:#fff}html.theme--catppuccin-macchiato .file.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}html.theme--catppuccin-macchiato .file.is-normal{font-size:1rem}html.theme--catppuccin-macchiato .file.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .file.is-medium .file-icon .fa{font-size:21px}html.theme--catppuccin-macchiato .file.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .file.is-large .file-icon .fa{font-size:28px}html.theme--catppuccin-macchiato .file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-macchiato .file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-macchiato .file.has-name.is-empty .file-cta{border-radius:.4em}html.theme--catppuccin-macchiato .file.has-name.is-empty .file-name{display:none}html.theme--catppuccin-macchiato .file.is-boxed .file-label{flex-direction:column}html.theme--catppuccin-macchiato .file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}html.theme--catppuccin-macchiato .file.is-boxed .file-name{border-width:0 1px 1px}html.theme--catppuccin-macchiato .file.is-boxed .file-icon{height:1.5em;width:1.5em}html.theme--catppuccin-macchiato .file.is-boxed .file-icon .fa{font-size:21px}html.theme--catppuccin-macchiato .file.is-boxed.is-small .file-icon .fa,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}html.theme--catppuccin-macchiato .file.is-boxed.is-medium .file-icon .fa{font-size:28px}html.theme--catppuccin-macchiato .file.is-boxed.is-large .file-icon .fa{font-size:35px}html.theme--catppuccin-macchiato .file.is-boxed.has-name .file-cta{border-radius:.4em .4em 0 0}html.theme--catppuccin-macchiato .file.is-boxed.has-name .file-name{border-radius:0 0 .4em .4em;border-width:0 1px 1px}html.theme--catppuccin-macchiato .file.is-centered{justify-content:center}html.theme--catppuccin-macchiato .file.is-fullwidth .file-label{width:100%}html.theme--catppuccin-macchiato .file.is-fullwidth .file-name{flex-grow:1;max-width:none}html.theme--catppuccin-macchiato .file.is-right{justify-content:flex-end}html.theme--catppuccin-macchiato .file.is-right .file-cta{border-radius:0 .4em .4em 0}html.theme--catppuccin-macchiato .file.is-right .file-name{border-radius:.4em 0 0 .4em;border-width:1px 0 1px 1px;order:-1}html.theme--catppuccin-macchiato .file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}html.theme--catppuccin-macchiato .file-label:hover .file-cta{background-color:#313447;color:#b5c1f1}html.theme--catppuccin-macchiato .file-label:hover .file-name{border-color:#565a71}html.theme--catppuccin-macchiato .file-label:active .file-cta{background-color:#2c2f40;color:#b5c1f1}html.theme--catppuccin-macchiato .file-label:active .file-name{border-color:#505469}html.theme--catppuccin-macchiato .file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}html.theme--catppuccin-macchiato .file-cta,html.theme--catppuccin-macchiato .file-name{border-color:#5b6078;border-radius:.4em;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}html.theme--catppuccin-macchiato .file-cta{background-color:#363a4f;color:#cad3f5}html.theme--catppuccin-macchiato .file-name{border-color:#5b6078;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}html.theme--catppuccin-macchiato .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}html.theme--catppuccin-macchiato .file-icon .fa{font-size:14px}html.theme--catppuccin-macchiato .label{color:#b5c1f1;display:block;font-size:1rem;font-weight:700}html.theme--catppuccin-macchiato .label:not(:last-child){margin-bottom:0.5em}html.theme--catppuccin-macchiato .label.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}html.theme--catppuccin-macchiato .label.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .label.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .help{display:block;font-size:.75rem;margin-top:0.25rem}html.theme--catppuccin-macchiato .help.is-white{color:#fff}html.theme--catppuccin-macchiato .help.is-black{color:#0a0a0a}html.theme--catppuccin-macchiato .help.is-light{color:#f5f5f5}html.theme--catppuccin-macchiato .help.is-dark,html.theme--catppuccin-macchiato .content kbd.help{color:#363a4f}html.theme--catppuccin-macchiato .help.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.help.docs-sourcelink{color:#8aadf4}html.theme--catppuccin-macchiato .help.is-link{color:#8aadf4}html.theme--catppuccin-macchiato .help.is-info{color:#8bd5ca}html.theme--catppuccin-macchiato .help.is-success{color:#a6da95}html.theme--catppuccin-macchiato .help.is-warning{color:#eed49f}html.theme--catppuccin-macchiato .help.is-danger{color:#ed8796}html.theme--catppuccin-macchiato .field:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-macchiato .field.has-addons{display:flex;justify-content:flex-start}html.theme--catppuccin-macchiato .field.has-addons .control:not(:last-child){margin-right:-1px}html.theme--catppuccin-macchiato .field.has-addons .control:not(:first-child):not(:last-child) .button,html.theme--catppuccin-macchiato .field.has-addons .control:not(:first-child):not(:last-child) .input,html.theme--catppuccin-macchiato .field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,html.theme--catppuccin-macchiato .field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}html.theme--catppuccin-macchiato .field.has-addons .control:first-child:not(:only-child) .button,html.theme--catppuccin-macchiato .field.has-addons .control:first-child:not(:only-child) .input,html.theme--catppuccin-macchiato .field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-macchiato .field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-macchiato .field.has-addons .control:last-child:not(:only-child) .button,html.theme--catppuccin-macchiato .field.has-addons .control:last-child:not(:only-child) .input,html.theme--catppuccin-macchiato .field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-macchiato .field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-macchiato .field.has-addons .control .button:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .button.is-hovered:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .input:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .input.is-hovered:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .select select:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}html.theme--catppuccin-macchiato .field.has-addons .control .button:not([disabled]):focus,html.theme--catppuccin-macchiato .field.has-addons .control .button.is-focused:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .button:not([disabled]):active,html.theme--catppuccin-macchiato .field.has-addons .control .button.is-active:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .input:not([disabled]):focus,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-macchiato .field.has-addons .control .input.is-focused:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .input:not([disabled]):active,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,html.theme--catppuccin-macchiato .field.has-addons .control .input.is-active:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .select select:not([disabled]):focus,html.theme--catppuccin-macchiato .field.has-addons .control .select select.is-focused:not([disabled]),html.theme--catppuccin-macchiato .field.has-addons .control .select select:not([disabled]):active,html.theme--catppuccin-macchiato .field.has-addons .control .select select.is-active:not([disabled]){z-index:3}html.theme--catppuccin-macchiato .field.has-addons .control .button:not([disabled]):focus:hover,html.theme--catppuccin-macchiato .field.has-addons .control .button.is-focused:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .button:not([disabled]):active:hover,html.theme--catppuccin-macchiato .field.has-addons .control .button.is-active:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .input:not([disabled]):focus:hover,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-macchiato .field.has-addons .control .input.is-focused:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .input:not([disabled]):active:hover,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-macchiato .field.has-addons .control .input.is-active:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .select select:not([disabled]):focus:hover,html.theme--catppuccin-macchiato .field.has-addons .control .select select.is-focused:not([disabled]):hover,html.theme--catppuccin-macchiato .field.has-addons .control .select select:not([disabled]):active:hover,html.theme--catppuccin-macchiato .field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}html.theme--catppuccin-macchiato .field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .field.has-addons.has-addons-centered{justify-content:center}html.theme--catppuccin-macchiato .field.has-addons.has-addons-right{justify-content:flex-end}html.theme--catppuccin-macchiato .field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}html.theme--catppuccin-macchiato .field.is-grouped{display:flex;justify-content:flex-start}html.theme--catppuccin-macchiato .field.is-grouped>.control{flex-shrink:0}html.theme--catppuccin-macchiato .field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-macchiato .field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-centered{justify-content:center}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-right{justify-content:flex-end}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-multiline{flex-wrap:wrap}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-multiline>.control:last-child,html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}html.theme--catppuccin-macchiato .field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .field.is-horizontal{display:flex}}html.theme--catppuccin-macchiato .field-label .label{font-size:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}html.theme--catppuccin-macchiato .field-label.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}html.theme--catppuccin-macchiato .field-label.is-normal{padding-top:0.375em}html.theme--catppuccin-macchiato .field-label.is-medium{font-size:1.25rem;padding-top:0.375em}html.theme--catppuccin-macchiato .field-label.is-large{font-size:1.5rem;padding-top:0.375em}}html.theme--catppuccin-macchiato .field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}html.theme--catppuccin-macchiato .field-body .field{margin-bottom:0}html.theme--catppuccin-macchiato .field-body>.field{flex-shrink:1}html.theme--catppuccin-macchiato .field-body>.field:not(.is-narrow){flex-grow:1}html.theme--catppuccin-macchiato .field-body>.field:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-macchiato .control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}html.theme--catppuccin-macchiato .control.has-icons-left .input:focus~.icon,html.theme--catppuccin-macchiato .control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,html.theme--catppuccin-macchiato .control.has-icons-left .select:focus~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .input:focus~.icon,html.theme--catppuccin-macchiato .control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .select:focus~.icon{color:#363a4f}html.theme--catppuccin-macchiato .control.has-icons-left .input.is-small~.icon,html.theme--catppuccin-macchiato .control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,html.theme--catppuccin-macchiato .control.has-icons-left .select.is-small~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .input.is-small~.icon,html.theme--catppuccin-macchiato .control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .select.is-small~.icon{font-size:.75rem}html.theme--catppuccin-macchiato .control.has-icons-left .input.is-medium~.icon,html.theme--catppuccin-macchiato .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,html.theme--catppuccin-macchiato .control.has-icons-left .select.is-medium~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .input.is-medium~.icon,html.theme--catppuccin-macchiato .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}html.theme--catppuccin-macchiato .control.has-icons-left .input.is-large~.icon,html.theme--catppuccin-macchiato .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,html.theme--catppuccin-macchiato .control.has-icons-left .select.is-large~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .input.is-large~.icon,html.theme--catppuccin-macchiato .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,html.theme--catppuccin-macchiato .control.has-icons-right .select.is-large~.icon{font-size:1.5rem}html.theme--catppuccin-macchiato .control.has-icons-left .icon,html.theme--catppuccin-macchiato .control.has-icons-right .icon{color:#5b6078;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}html.theme--catppuccin-macchiato .control.has-icons-left .input,html.theme--catppuccin-macchiato .control.has-icons-left #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-left form.docs-search>input,html.theme--catppuccin-macchiato .control.has-icons-left .select select{padding-left:2.5em}html.theme--catppuccin-macchiato .control.has-icons-left .icon.is-left{left:0}html.theme--catppuccin-macchiato .control.has-icons-right .input,html.theme--catppuccin-macchiato .control.has-icons-right #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato #documenter .docs-sidebar .control.has-icons-right form.docs-search>input,html.theme--catppuccin-macchiato .control.has-icons-right .select select{padding-right:2.5em}html.theme--catppuccin-macchiato .control.has-icons-right .icon.is-right{right:0}html.theme--catppuccin-macchiato .control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}html.theme--catppuccin-macchiato .control.is-loading.is-small:after,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-macchiato .control.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-macchiato .control.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-macchiato .breadcrumb{font-size:1rem;white-space:nowrap}html.theme--catppuccin-macchiato .breadcrumb a{align-items:center;color:#8aadf4;display:flex;justify-content:center;padding:0 .75em}html.theme--catppuccin-macchiato .breadcrumb a:hover{color:#91d7e3}html.theme--catppuccin-macchiato .breadcrumb li{align-items:center;display:flex}html.theme--catppuccin-macchiato .breadcrumb li:first-child a{padding-left:0}html.theme--catppuccin-macchiato .breadcrumb li.is-active a{color:#b5c1f1;cursor:default;pointer-events:none}html.theme--catppuccin-macchiato .breadcrumb li+li::before{color:#6e738d;content:"\0002f"}html.theme--catppuccin-macchiato .breadcrumb ul,html.theme--catppuccin-macchiato .breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-macchiato .breadcrumb .icon:first-child{margin-right:.5em}html.theme--catppuccin-macchiato .breadcrumb .icon:last-child{margin-left:.5em}html.theme--catppuccin-macchiato .breadcrumb.is-centered ol,html.theme--catppuccin-macchiato .breadcrumb.is-centered ul{justify-content:center}html.theme--catppuccin-macchiato .breadcrumb.is-right ol,html.theme--catppuccin-macchiato .breadcrumb.is-right ul{justify-content:flex-end}html.theme--catppuccin-macchiato .breadcrumb.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}html.theme--catppuccin-macchiato .breadcrumb.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .breadcrumb.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .breadcrumb.has-arrow-separator li+li::before{content:"\02192"}html.theme--catppuccin-macchiato .breadcrumb.has-bullet-separator li+li::before{content:"\02022"}html.theme--catppuccin-macchiato .breadcrumb.has-dot-separator li+li::before{content:"\000b7"}html.theme--catppuccin-macchiato .breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}html.theme--catppuccin-macchiato .card{background-color:#fff;border-radius:.25rem;box-shadow:#171717;color:#cad3f5;max-width:100%;position:relative}html.theme--catppuccin-macchiato .card-footer:first-child,html.theme--catppuccin-macchiato .card-content:first-child,html.theme--catppuccin-macchiato .card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-macchiato .card-footer:last-child,html.theme--catppuccin-macchiato .card-content:last-child,html.theme--catppuccin-macchiato .card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-macchiato .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}html.theme--catppuccin-macchiato .card-header-title{align-items:center;color:#b5c1f1;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}html.theme--catppuccin-macchiato .card-header-title.is-centered{justify-content:center}html.theme--catppuccin-macchiato .card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}html.theme--catppuccin-macchiato .card-image{display:block;position:relative}html.theme--catppuccin-macchiato .card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-macchiato .card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-macchiato .card-content{background-color:rgba(0,0,0,0);padding:1.5rem}html.theme--catppuccin-macchiato .card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}html.theme--catppuccin-macchiato .card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}html.theme--catppuccin-macchiato .card-footer-item:not(:last-child){border-right:1px solid #ededed}html.theme--catppuccin-macchiato .card .media:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-macchiato .dropdown{display:inline-flex;position:relative;vertical-align:top}html.theme--catppuccin-macchiato .dropdown.is-active .dropdown-menu,html.theme--catppuccin-macchiato .dropdown.is-hoverable:hover .dropdown-menu{display:block}html.theme--catppuccin-macchiato .dropdown.is-right .dropdown-menu{left:auto;right:0}html.theme--catppuccin-macchiato .dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}html.theme--catppuccin-macchiato .dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}html.theme--catppuccin-macchiato .dropdown-content{background-color:#1e2030;border-radius:.4em;box-shadow:#171717;padding-bottom:.5rem;padding-top:.5rem}html.theme--catppuccin-macchiato .dropdown-item{color:#cad3f5;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}html.theme--catppuccin-macchiato a.dropdown-item,html.theme--catppuccin-macchiato button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}html.theme--catppuccin-macchiato a.dropdown-item:hover,html.theme--catppuccin-macchiato button.dropdown-item:hover{background-color:#1e2030;color:#0a0a0a}html.theme--catppuccin-macchiato a.dropdown-item.is-active,html.theme--catppuccin-macchiato button.dropdown-item.is-active{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}html.theme--catppuccin-macchiato .level{align-items:center;justify-content:space-between}html.theme--catppuccin-macchiato .level code{border-radius:.4em}html.theme--catppuccin-macchiato .level img{display:inline-block;vertical-align:top}html.theme--catppuccin-macchiato .level.is-mobile{display:flex}html.theme--catppuccin-macchiato .level.is-mobile .level-left,html.theme--catppuccin-macchiato .level.is-mobile .level-right{display:flex}html.theme--catppuccin-macchiato .level.is-mobile .level-left+.level-right{margin-top:0}html.theme--catppuccin-macchiato .level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-macchiato .level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .level{display:flex}html.theme--catppuccin-macchiato .level>.level-item:not(.is-narrow){flex-grow:1}}html.theme--catppuccin-macchiato .level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}html.theme--catppuccin-macchiato .level-item .title,html.theme--catppuccin-macchiato .level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .level-item:not(:last-child){margin-bottom:.75rem}}html.theme--catppuccin-macchiato .level-left,html.theme--catppuccin-macchiato .level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-macchiato .level-left .level-item.is-flexible,html.theme--catppuccin-macchiato .level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .level-left .level-item:not(:last-child),html.theme--catppuccin-macchiato .level-right .level-item:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-macchiato .level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .level-left{display:flex}}html.theme--catppuccin-macchiato .level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .level-right{display:flex}}html.theme--catppuccin-macchiato .media{align-items:flex-start;display:flex;text-align:inherit}html.theme--catppuccin-macchiato .media .content:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-macchiato .media .media{border-top:1px solid rgba(91,96,120,0.5);display:flex;padding-top:.75rem}html.theme--catppuccin-macchiato .media .media .content:not(:last-child),html.theme--catppuccin-macchiato .media .media .control:not(:last-child){margin-bottom:.5rem}html.theme--catppuccin-macchiato .media .media .media{padding-top:.5rem}html.theme--catppuccin-macchiato .media .media .media+.media{margin-top:.5rem}html.theme--catppuccin-macchiato .media+.media{border-top:1px solid rgba(91,96,120,0.5);margin-top:1rem;padding-top:1rem}html.theme--catppuccin-macchiato .media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}html.theme--catppuccin-macchiato .media-left,html.theme--catppuccin-macchiato .media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-macchiato .media-left{margin-right:1rem}html.theme--catppuccin-macchiato .media-right{margin-left:1rem}html.theme--catppuccin-macchiato .media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .media-content{overflow-x:auto}}html.theme--catppuccin-macchiato .menu{font-size:1rem}html.theme--catppuccin-macchiato .menu.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}html.theme--catppuccin-macchiato .menu.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .menu.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .menu-list{line-height:1.25}html.theme--catppuccin-macchiato .menu-list a{border-radius:3px;color:#cad3f5;display:block;padding:0.5em 0.75em}html.theme--catppuccin-macchiato .menu-list a:hover{background-color:#1e2030;color:#b5c1f1}html.theme--catppuccin-macchiato .menu-list a.is-active{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .menu-list li ul{border-left:1px solid #5b6078;margin:.75em;padding-left:.75em}html.theme--catppuccin-macchiato .menu-label{color:#f5f7fd;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}html.theme--catppuccin-macchiato .menu-label:not(:first-child){margin-top:1em}html.theme--catppuccin-macchiato .menu-label:not(:last-child){margin-bottom:1em}html.theme--catppuccin-macchiato .message{background-color:#1e2030;border-radius:.4em;font-size:1rem}html.theme--catppuccin-macchiato .message strong{color:currentColor}html.theme--catppuccin-macchiato .message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-macchiato .message.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}html.theme--catppuccin-macchiato .message.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .message.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .message.is-white{background-color:#fff}html.theme--catppuccin-macchiato .message.is-white .message-header{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .message.is-white .message-body{border-color:#fff}html.theme--catppuccin-macchiato .message.is-black{background-color:#fafafa}html.theme--catppuccin-macchiato .message.is-black .message-header{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .message.is-black .message-body{border-color:#0a0a0a}html.theme--catppuccin-macchiato .message.is-light{background-color:#fafafa}html.theme--catppuccin-macchiato .message.is-light .message-header{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .message.is-light .message-body{border-color:#f5f5f5}html.theme--catppuccin-macchiato .message.is-dark,html.theme--catppuccin-macchiato .content kbd.message{background-color:#f9f9fb}html.theme--catppuccin-macchiato .message.is-dark .message-header,html.theme--catppuccin-macchiato .content kbd.message .message-header{background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .message.is-dark .message-body,html.theme--catppuccin-macchiato .content kbd.message .message-body{border-color:#363a4f}html.theme--catppuccin-macchiato .message.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.message.docs-sourcelink{background-color:#ecf2fd}html.theme--catppuccin-macchiato .message.is-primary .message-header,html.theme--catppuccin-macchiato .docstring>section>a.message.docs-sourcelink .message-header{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .message.is-primary .message-body,html.theme--catppuccin-macchiato .docstring>section>a.message.docs-sourcelink .message-body{border-color:#8aadf4;color:#0e3b95}html.theme--catppuccin-macchiato .message.is-link{background-color:#ecf2fd}html.theme--catppuccin-macchiato .message.is-link .message-header{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .message.is-link .message-body{border-color:#8aadf4;color:#0e3b95}html.theme--catppuccin-macchiato .message.is-info{background-color:#f0faf8}html.theme--catppuccin-macchiato .message.is-info .message-header{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .message.is-info .message-body{border-color:#8bd5ca;color:#276d62}html.theme--catppuccin-macchiato .message.is-success{background-color:#f2faf0}html.theme--catppuccin-macchiato .message.is-success .message-header{background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .message.is-success .message-body{border-color:#a6da95;color:#386e26}html.theme--catppuccin-macchiato .message.is-warning{background-color:#fcf7ee}html.theme--catppuccin-macchiato .message.is-warning .message-header{background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .message.is-warning .message-body{border-color:#eed49f;color:#7e5c16}html.theme--catppuccin-macchiato .message.is-danger{background-color:#fcedef}html.theme--catppuccin-macchiato .message.is-danger .message-header{background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .message.is-danger .message-body{border-color:#ed8796;color:#971729}html.theme--catppuccin-macchiato .message-header{align-items:center;background-color:#cad3f5;border-radius:.4em .4em 0 0;color:rgba(0,0,0,0.7);display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}html.theme--catppuccin-macchiato .message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}html.theme--catppuccin-macchiato .message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}html.theme--catppuccin-macchiato .message-body{border-color:#5b6078;border-radius:.4em;border-style:solid;border-width:0 0 0 4px;color:#cad3f5;padding:1.25em 1.5em}html.theme--catppuccin-macchiato .message-body code,html.theme--catppuccin-macchiato .message-body pre{background-color:#fff}html.theme--catppuccin-macchiato .message-body pre code{background-color:rgba(0,0,0,0)}html.theme--catppuccin-macchiato .modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}html.theme--catppuccin-macchiato .modal.is-active{display:flex}html.theme--catppuccin-macchiato .modal-background{background-color:rgba(10,10,10,0.86)}html.theme--catppuccin-macchiato .modal-content,html.theme--catppuccin-macchiato .modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){html.theme--catppuccin-macchiato .modal-content,html.theme--catppuccin-macchiato .modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}html.theme--catppuccin-macchiato .modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}html.theme--catppuccin-macchiato .modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}html.theme--catppuccin-macchiato .modal-card-head,html.theme--catppuccin-macchiato .modal-card-foot{align-items:center;background-color:#1e2030;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}html.theme--catppuccin-macchiato .modal-card-head{border-bottom:1px solid #5b6078;border-top-left-radius:8px;border-top-right-radius:8px}html.theme--catppuccin-macchiato .modal-card-title{color:#cad3f5;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}html.theme--catppuccin-macchiato .modal-card-foot{border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid #5b6078}html.theme--catppuccin-macchiato .modal-card-foot .button:not(:last-child){margin-right:.5em}html.theme--catppuccin-macchiato .modal-card-body{-webkit-overflow-scrolling:touch;background-color:#24273a;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}html.theme--catppuccin-macchiato .navbar{background-color:#8aadf4;min-height:4rem;position:relative;z-index:30}html.theme--catppuccin-macchiato .navbar.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-white .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-macchiato .navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}html.theme--catppuccin-macchiato .navbar.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-black .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}html.theme--catppuccin-macchiato .navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}html.theme--catppuccin-macchiato .navbar.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-light .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-macchiato .navbar.is-dark,html.theme--catppuccin-macchiato .content kbd.navbar{background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand .navbar-link.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#2c2f40;color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-brand .navbar-link::after,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-burger,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end .navbar-link.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#2c2f40;color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-end .navbar-link::after,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#2c2f40;color:#fff}html.theme--catppuccin-macchiato .navbar.is-dark .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-macchiato .content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#363a4f;color:#fff}}html.theme--catppuccin-macchiato .navbar.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand .navbar-link.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-brand .navbar-link::after,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-burger,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end .navbar-link.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-end .navbar-link::after,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#8aadf4;color:#fff}}html.theme--catppuccin-macchiato .navbar.is-link{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-link .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#8aadf4;color:#fff}}html.theme--catppuccin-macchiato .navbar.is-info{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#78cec1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-info .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end .navbar-link.is-active{background-color:#78cec1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-info .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#78cec1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-macchiato .navbar.is-success{background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#96d382;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-success .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end .navbar-link.is-active{background-color:#96d382;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-success .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#96d382;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#a6da95;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-macchiato .navbar.is-warning{background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#eaca89;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#eaca89;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#eaca89;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#eed49f;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-macchiato .navbar.is-danger{background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#ea7183;color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start .navbar-link,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end>.navbar-item,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start .navbar-link.is-active,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end>a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end>a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#ea7183;color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-start .navbar-link::after,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#ea7183;color:#fff}html.theme--catppuccin-macchiato .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#ed8796;color:#fff}}html.theme--catppuccin-macchiato .navbar>.container{align-items:stretch;display:flex;min-height:4rem;width:100%}html.theme--catppuccin-macchiato .navbar.has-shadow{box-shadow:0 2px 0 0 #1e2030}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom,html.theme--catppuccin-macchiato .navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom{bottom:0}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #1e2030}html.theme--catppuccin-macchiato .navbar.is-fixed-top{top:0}html.theme--catppuccin-macchiato html.has-navbar-fixed-top,html.theme--catppuccin-macchiato body.has-navbar-fixed-top{padding-top:4rem}html.theme--catppuccin-macchiato html.has-navbar-fixed-bottom,html.theme--catppuccin-macchiato body.has-navbar-fixed-bottom{padding-bottom:4rem}html.theme--catppuccin-macchiato .navbar-brand,html.theme--catppuccin-macchiato .navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:4rem}html.theme--catppuccin-macchiato .navbar-brand a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar-brand a.navbar-item:hover{background-color:transparent}html.theme--catppuccin-macchiato .navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}html.theme--catppuccin-macchiato .navbar-burger{color:#cad3f5;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:4rem;position:relative;width:4rem;margin-left:auto}html.theme--catppuccin-macchiato .navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}html.theme--catppuccin-macchiato .navbar-burger span:nth-child(1){top:calc(50% - 6px)}html.theme--catppuccin-macchiato .navbar-burger span:nth-child(2){top:calc(50% - 1px)}html.theme--catppuccin-macchiato .navbar-burger span:nth-child(3){top:calc(50% + 4px)}html.theme--catppuccin-macchiato .navbar-burger:hover{background-color:rgba(0,0,0,0.05)}html.theme--catppuccin-macchiato .navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}html.theme--catppuccin-macchiato .navbar-burger.is-active span:nth-child(2){opacity:0}html.theme--catppuccin-macchiato .navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}html.theme--catppuccin-macchiato .navbar-menu{display:none}html.theme--catppuccin-macchiato .navbar-item,html.theme--catppuccin-macchiato .navbar-link{color:#cad3f5;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}html.theme--catppuccin-macchiato .navbar-item .icon:only-child,html.theme--catppuccin-macchiato .navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}html.theme--catppuccin-macchiato a.navbar-item,html.theme--catppuccin-macchiato .navbar-link{cursor:pointer}html.theme--catppuccin-macchiato a.navbar-item:focus,html.theme--catppuccin-macchiato a.navbar-item:focus-within,html.theme--catppuccin-macchiato a.navbar-item:hover,html.theme--catppuccin-macchiato a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar-link:focus,html.theme--catppuccin-macchiato .navbar-link:focus-within,html.theme--catppuccin-macchiato .navbar-link:hover,html.theme--catppuccin-macchiato .navbar-link.is-active{background-color:rgba(0,0,0,0);color:#8aadf4}html.theme--catppuccin-macchiato .navbar-item{flex-grow:0;flex-shrink:0}html.theme--catppuccin-macchiato .navbar-item img{max-height:1.75rem}html.theme--catppuccin-macchiato .navbar-item.has-dropdown{padding:0}html.theme--catppuccin-macchiato .navbar-item.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .navbar-item.is-tab{border-bottom:1px solid transparent;min-height:4rem;padding-bottom:calc(0.5rem - 1px)}html.theme--catppuccin-macchiato .navbar-item.is-tab:focus,html.theme--catppuccin-macchiato .navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#8aadf4}html.theme--catppuccin-macchiato .navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#8aadf4;border-bottom-style:solid;border-bottom-width:3px;color:#8aadf4;padding-bottom:calc(0.5rem - 3px)}html.theme--catppuccin-macchiato .navbar-content{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .navbar-link:not(.is-arrowless){padding-right:2.5em}html.theme--catppuccin-macchiato .navbar-link:not(.is-arrowless)::after{border-color:#fff;margin-top:-0.375em;right:1.125em}html.theme--catppuccin-macchiato .navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}html.theme--catppuccin-macchiato .navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}html.theme--catppuccin-macchiato .navbar-divider{background-color:rgba(0,0,0,0.2);border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .navbar>.container{display:block}html.theme--catppuccin-macchiato .navbar-brand .navbar-item,html.theme--catppuccin-macchiato .navbar-tabs .navbar-item{align-items:center;display:flex}html.theme--catppuccin-macchiato .navbar-link::after{display:none}html.theme--catppuccin-macchiato .navbar-menu{background-color:#8aadf4;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}html.theme--catppuccin-macchiato .navbar-menu.is-active{display:block}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-touch,html.theme--catppuccin-macchiato .navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-touch{bottom:0}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .navbar.is-fixed-top-touch{top:0}html.theme--catppuccin-macchiato .navbar.is-fixed-top .navbar-menu,html.theme--catppuccin-macchiato .navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 4rem);overflow:auto}html.theme--catppuccin-macchiato html.has-navbar-fixed-top-touch,html.theme--catppuccin-macchiato body.has-navbar-fixed-top-touch{padding-top:4rem}html.theme--catppuccin-macchiato html.has-navbar-fixed-bottom-touch,html.theme--catppuccin-macchiato body.has-navbar-fixed-bottom-touch{padding-bottom:4rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .navbar,html.theme--catppuccin-macchiato .navbar-menu,html.theme--catppuccin-macchiato .navbar-start,html.theme--catppuccin-macchiato .navbar-end{align-items:stretch;display:flex}html.theme--catppuccin-macchiato .navbar{min-height:4rem}html.theme--catppuccin-macchiato .navbar.is-spaced{padding:1rem 2rem}html.theme--catppuccin-macchiato .navbar.is-spaced .navbar-start,html.theme--catppuccin-macchiato .navbar.is-spaced .navbar-end{align-items:center}html.theme--catppuccin-macchiato .navbar.is-spaced a.navbar-item,html.theme--catppuccin-macchiato .navbar.is-spaced .navbar-link{border-radius:.4em}html.theme--catppuccin-macchiato .navbar.is-transparent a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-transparent a.navbar-item:hover,html.theme--catppuccin-macchiato .navbar.is-transparent a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-link:focus,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-link:hover,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#8087a2}html.theme--catppuccin-macchiato .navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#8aadf4}html.theme--catppuccin-macchiato .navbar-burger{display:none}html.theme--catppuccin-macchiato .navbar-item,html.theme--catppuccin-macchiato .navbar-link{align-items:center;display:flex}html.theme--catppuccin-macchiato .navbar-item.has-dropdown{align-items:stretch}html.theme--catppuccin-macchiato .navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}html.theme--catppuccin-macchiato .navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:1px solid rgba(0,0,0,0.2);border-radius:8px 8px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}html.theme--catppuccin-macchiato .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced html.theme--catppuccin-macchiato .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-macchiato .navbar-item.is-hoverable:hover .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}html.theme--catppuccin-macchiato .navbar-menu{flex-grow:1;flex-shrink:0}html.theme--catppuccin-macchiato .navbar-start{justify-content:flex-start;margin-right:auto}html.theme--catppuccin-macchiato .navbar-end{justify-content:flex-end;margin-left:auto}html.theme--catppuccin-macchiato .navbar-dropdown{background-color:#8aadf4;border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid rgba(0,0,0,0.2);box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}html.theme--catppuccin-macchiato .navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}html.theme--catppuccin-macchiato .navbar-dropdown a.navbar-item{padding-right:3rem}html.theme--catppuccin-macchiato .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-macchiato .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#8087a2}html.theme--catppuccin-macchiato .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#8aadf4}.navbar.is-spaced html.theme--catppuccin-macchiato .navbar-dropdown,html.theme--catppuccin-macchiato .navbar-dropdown.is-boxed{border-radius:8px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}html.theme--catppuccin-macchiato .navbar-dropdown.is-right{left:auto;right:0}html.theme--catppuccin-macchiato .navbar-divider{display:block}html.theme--catppuccin-macchiato .navbar>.container .navbar-brand,html.theme--catppuccin-macchiato .container>.navbar .navbar-brand{margin-left:-.75rem}html.theme--catppuccin-macchiato .navbar>.container .navbar-menu,html.theme--catppuccin-macchiato .container>.navbar .navbar-menu{margin-right:-.75rem}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-desktop,html.theme--catppuccin-macchiato .navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-desktop{bottom:0}html.theme--catppuccin-macchiato .navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .navbar.is-fixed-top-desktop{top:0}html.theme--catppuccin-macchiato html.has-navbar-fixed-top-desktop,html.theme--catppuccin-macchiato body.has-navbar-fixed-top-desktop{padding-top:4rem}html.theme--catppuccin-macchiato html.has-navbar-fixed-bottom-desktop,html.theme--catppuccin-macchiato body.has-navbar-fixed-bottom-desktop{padding-bottom:4rem}html.theme--catppuccin-macchiato html.has-spaced-navbar-fixed-top,html.theme--catppuccin-macchiato body.has-spaced-navbar-fixed-top{padding-top:6rem}html.theme--catppuccin-macchiato html.has-spaced-navbar-fixed-bottom,html.theme--catppuccin-macchiato body.has-spaced-navbar-fixed-bottom{padding-bottom:6rem}html.theme--catppuccin-macchiato a.navbar-item.is-active,html.theme--catppuccin-macchiato .navbar-link.is-active{color:#8aadf4}html.theme--catppuccin-macchiato a.navbar-item.is-active:not(:focus):not(:hover),html.theme--catppuccin-macchiato .navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}html.theme--catppuccin-macchiato .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-macchiato .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-macchiato .navbar-item.has-dropdown.is-active .navbar-link{background-color:rgba(0,0,0,0)}}html.theme--catppuccin-macchiato .hero.is-fullheight-with-navbar{min-height:calc(100vh - 4rem)}html.theme--catppuccin-macchiato .pagination{font-size:1rem;margin:-.25rem}html.theme--catppuccin-macchiato .pagination.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}html.theme--catppuccin-macchiato .pagination.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .pagination.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .pagination.is-rounded .pagination-previous,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,html.theme--catppuccin-macchiato .pagination.is-rounded .pagination-next,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}html.theme--catppuccin-macchiato .pagination.is-rounded .pagination-link,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}html.theme--catppuccin-macchiato .pagination,html.theme--catppuccin-macchiato .pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato .pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-link{border-color:#5b6078;color:#8aadf4;min-width:2.5em}html.theme--catppuccin-macchiato .pagination-previous:hover,html.theme--catppuccin-macchiato .pagination-next:hover,html.theme--catppuccin-macchiato .pagination-link:hover{border-color:#6e738d;color:#91d7e3}html.theme--catppuccin-macchiato .pagination-previous:focus,html.theme--catppuccin-macchiato .pagination-next:focus,html.theme--catppuccin-macchiato .pagination-link:focus{border-color:#6e738d}html.theme--catppuccin-macchiato .pagination-previous:active,html.theme--catppuccin-macchiato .pagination-next:active,html.theme--catppuccin-macchiato .pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}html.theme--catppuccin-macchiato .pagination-previous[disabled],html.theme--catppuccin-macchiato .pagination-previous.is-disabled,html.theme--catppuccin-macchiato .pagination-next[disabled],html.theme--catppuccin-macchiato .pagination-next.is-disabled,html.theme--catppuccin-macchiato .pagination-link[disabled],html.theme--catppuccin-macchiato .pagination-link.is-disabled{background-color:#5b6078;border-color:#5b6078;box-shadow:none;color:#f5f7fd;opacity:0.5}html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}html.theme--catppuccin-macchiato .pagination-link.is-current{background-color:#8aadf4;border-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .pagination-ellipsis{color:#6e738d;pointer-events:none}html.theme--catppuccin-macchiato .pagination-list{flex-wrap:wrap}html.theme--catppuccin-macchiato .pagination-list li{list-style:none}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .pagination{flex-wrap:wrap}html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato .pagination-ellipsis{margin-bottom:0;margin-top:0}html.theme--catppuccin-macchiato .pagination-previous{order:2}html.theme--catppuccin-macchiato .pagination-next{order:3}html.theme--catppuccin-macchiato .pagination{justify-content:space-between;margin-bottom:0;margin-top:0}html.theme--catppuccin-macchiato .pagination.is-centered .pagination-previous{order:1}html.theme--catppuccin-macchiato .pagination.is-centered .pagination-list{justify-content:center;order:2}html.theme--catppuccin-macchiato .pagination.is-centered .pagination-next{order:3}html.theme--catppuccin-macchiato .pagination.is-right .pagination-previous{order:1}html.theme--catppuccin-macchiato .pagination.is-right .pagination-next{order:2}html.theme--catppuccin-macchiato .pagination.is-right .pagination-list{justify-content:flex-end;order:3}}html.theme--catppuccin-macchiato .panel{border-radius:8px;box-shadow:#171717;font-size:1rem}html.theme--catppuccin-macchiato .panel:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-macchiato .panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}html.theme--catppuccin-macchiato .panel.is-white .panel-block.is-active .panel-icon{color:#fff}html.theme--catppuccin-macchiato .panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}html.theme--catppuccin-macchiato .panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}html.theme--catppuccin-macchiato .panel.is-light .panel-heading{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .panel.is-light .panel-tabs a.is-active{border-bottom-color:#f5f5f5}html.theme--catppuccin-macchiato .panel.is-light .panel-block.is-active .panel-icon{color:#f5f5f5}html.theme--catppuccin-macchiato .panel.is-dark .panel-heading,html.theme--catppuccin-macchiato .content kbd.panel .panel-heading{background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .panel.is-dark .panel-tabs a.is-active,html.theme--catppuccin-macchiato .content kbd.panel .panel-tabs a.is-active{border-bottom-color:#363a4f}html.theme--catppuccin-macchiato .panel.is-dark .panel-block.is-active .panel-icon,html.theme--catppuccin-macchiato .content kbd.panel .panel-block.is-active .panel-icon{color:#363a4f}html.theme--catppuccin-macchiato .panel.is-primary .panel-heading,html.theme--catppuccin-macchiato .docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .panel.is-primary .panel-tabs a.is-active,html.theme--catppuccin-macchiato .docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#8aadf4}html.theme--catppuccin-macchiato .panel.is-primary .panel-block.is-active .panel-icon,html.theme--catppuccin-macchiato .docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#8aadf4}html.theme--catppuccin-macchiato .panel.is-link .panel-heading{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .panel.is-link .panel-tabs a.is-active{border-bottom-color:#8aadf4}html.theme--catppuccin-macchiato .panel.is-link .panel-block.is-active .panel-icon{color:#8aadf4}html.theme--catppuccin-macchiato .panel.is-info .panel-heading{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .panel.is-info .panel-tabs a.is-active{border-bottom-color:#8bd5ca}html.theme--catppuccin-macchiato .panel.is-info .panel-block.is-active .panel-icon{color:#8bd5ca}html.theme--catppuccin-macchiato .panel.is-success .panel-heading{background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .panel.is-success .panel-tabs a.is-active{border-bottom-color:#a6da95}html.theme--catppuccin-macchiato .panel.is-success .panel-block.is-active .panel-icon{color:#a6da95}html.theme--catppuccin-macchiato .panel.is-warning .panel-heading{background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .panel.is-warning .panel-tabs a.is-active{border-bottom-color:#eed49f}html.theme--catppuccin-macchiato .panel.is-warning .panel-block.is-active .panel-icon{color:#eed49f}html.theme--catppuccin-macchiato .panel.is-danger .panel-heading{background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .panel.is-danger .panel-tabs a.is-active{border-bottom-color:#ed8796}html.theme--catppuccin-macchiato .panel.is-danger .panel-block.is-active .panel-icon{color:#ed8796}html.theme--catppuccin-macchiato .panel-tabs:not(:last-child),html.theme--catppuccin-macchiato .panel-block:not(:last-child){border-bottom:1px solid #ededed}html.theme--catppuccin-macchiato .panel-heading{background-color:#494d64;border-radius:8px 8px 0 0;color:#b5c1f1;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}html.theme--catppuccin-macchiato .panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}html.theme--catppuccin-macchiato .panel-tabs a{border-bottom:1px solid #5b6078;margin-bottom:-1px;padding:0.5em}html.theme--catppuccin-macchiato .panel-tabs a.is-active{border-bottom-color:#494d64;color:#739df2}html.theme--catppuccin-macchiato .panel-list a{color:#cad3f5}html.theme--catppuccin-macchiato .panel-list a:hover{color:#8aadf4}html.theme--catppuccin-macchiato .panel-block{align-items:center;color:#b5c1f1;display:flex;justify-content:flex-start;padding:0.5em 0.75em}html.theme--catppuccin-macchiato .panel-block input[type="checkbox"]{margin-right:.75em}html.theme--catppuccin-macchiato .panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}html.theme--catppuccin-macchiato .panel-block.is-wrapped{flex-wrap:wrap}html.theme--catppuccin-macchiato .panel-block.is-active{border-left-color:#8aadf4;color:#739df2}html.theme--catppuccin-macchiato .panel-block.is-active .panel-icon{color:#8aadf4}html.theme--catppuccin-macchiato .panel-block:last-child{border-bottom-left-radius:8px;border-bottom-right-radius:8px}html.theme--catppuccin-macchiato a.panel-block,html.theme--catppuccin-macchiato label.panel-block{cursor:pointer}html.theme--catppuccin-macchiato a.panel-block:hover,html.theme--catppuccin-macchiato label.panel-block:hover{background-color:#1e2030}html.theme--catppuccin-macchiato .panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#f5f7fd;margin-right:.75em}html.theme--catppuccin-macchiato .panel-icon .fa{font-size:inherit;line-height:inherit}html.theme--catppuccin-macchiato .tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}html.theme--catppuccin-macchiato .tabs a{align-items:center;border-bottom-color:#5b6078;border-bottom-style:solid;border-bottom-width:1px;color:#cad3f5;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}html.theme--catppuccin-macchiato .tabs a:hover{border-bottom-color:#b5c1f1;color:#b5c1f1}html.theme--catppuccin-macchiato .tabs li{display:block}html.theme--catppuccin-macchiato .tabs li.is-active a{border-bottom-color:#8aadf4;color:#8aadf4}html.theme--catppuccin-macchiato .tabs ul{align-items:center;border-bottom-color:#5b6078;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}html.theme--catppuccin-macchiato .tabs ul.is-left{padding-right:0.75em}html.theme--catppuccin-macchiato .tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}html.theme--catppuccin-macchiato .tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}html.theme--catppuccin-macchiato .tabs .icon:first-child{margin-right:.5em}html.theme--catppuccin-macchiato .tabs .icon:last-child{margin-left:.5em}html.theme--catppuccin-macchiato .tabs.is-centered ul{justify-content:center}html.theme--catppuccin-macchiato .tabs.is-right ul{justify-content:flex-end}html.theme--catppuccin-macchiato .tabs.is-boxed a{border:1px solid transparent;border-radius:.4em .4em 0 0}html.theme--catppuccin-macchiato .tabs.is-boxed a:hover{background-color:#1e2030;border-bottom-color:#5b6078}html.theme--catppuccin-macchiato .tabs.is-boxed li.is-active a{background-color:#fff;border-color:#5b6078;border-bottom-color:rgba(0,0,0,0) !important}html.theme--catppuccin-macchiato .tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}html.theme--catppuccin-macchiato .tabs.is-toggle a{border-color:#5b6078;border-style:solid;border-width:1px;margin-bottom:0;position:relative}html.theme--catppuccin-macchiato .tabs.is-toggle a:hover{background-color:#1e2030;border-color:#6e738d;z-index:2}html.theme--catppuccin-macchiato .tabs.is-toggle li+li{margin-left:-1px}html.theme--catppuccin-macchiato .tabs.is-toggle li:first-child a{border-top-left-radius:.4em;border-bottom-left-radius:.4em}html.theme--catppuccin-macchiato .tabs.is-toggle li:last-child a{border-top-right-radius:.4em;border-bottom-right-radius:.4em}html.theme--catppuccin-macchiato .tabs.is-toggle li.is-active a{background-color:#8aadf4;border-color:#8aadf4;color:#fff;z-index:1}html.theme--catppuccin-macchiato .tabs.is-toggle ul{border-bottom:none}html.theme--catppuccin-macchiato .tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}html.theme--catppuccin-macchiato .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}html.theme--catppuccin-macchiato .tabs.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}html.theme--catppuccin-macchiato .tabs.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .tabs.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-narrow{flex:none;width:unset}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-full{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-half{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-half{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-0{flex:none;width:0%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-0{margin-left:0%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-3{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-3{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-6{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-6{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-9{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-9{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-12{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-macchiato .column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .column.is-narrow-mobile{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full-mobile{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters-mobile{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds-mobile{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half-mobile{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third-mobile{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter-mobile{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth-mobile{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths-mobile{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths-mobile{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths-mobile{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters-mobile{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds-mobile{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half-mobile{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third-mobile{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter-mobile{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth-mobile{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths-mobile{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths-mobile{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths-mobile{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0-mobile{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0-mobile{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1-mobile{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1-mobile{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2-mobile{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2-mobile{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3-mobile{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3-mobile{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4-mobile{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4-mobile{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5-mobile{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5-mobile{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6-mobile{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6-mobile{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7-mobile{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7-mobile{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8-mobile{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8-mobile{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9-mobile{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9-mobile{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10-mobile{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10-mobile{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11-mobile{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11-mobile{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12-mobile{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .column.is-narrow,html.theme--catppuccin-macchiato .column.is-narrow-tablet{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full,html.theme--catppuccin-macchiato .column.is-full-tablet{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters,html.theme--catppuccin-macchiato .column.is-three-quarters-tablet{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds,html.theme--catppuccin-macchiato .column.is-two-thirds-tablet{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half,html.theme--catppuccin-macchiato .column.is-half-tablet{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third,html.theme--catppuccin-macchiato .column.is-one-third-tablet{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter,html.theme--catppuccin-macchiato .column.is-one-quarter-tablet{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth,html.theme--catppuccin-macchiato .column.is-one-fifth-tablet{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths,html.theme--catppuccin-macchiato .column.is-two-fifths-tablet{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths,html.theme--catppuccin-macchiato .column.is-three-fifths-tablet{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths,html.theme--catppuccin-macchiato .column.is-four-fifths-tablet{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters,html.theme--catppuccin-macchiato .column.is-offset-three-quarters-tablet{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds,html.theme--catppuccin-macchiato .column.is-offset-two-thirds-tablet{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half,html.theme--catppuccin-macchiato .column.is-offset-half-tablet{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third,html.theme--catppuccin-macchiato .column.is-offset-one-third-tablet{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter,html.theme--catppuccin-macchiato .column.is-offset-one-quarter-tablet{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth,html.theme--catppuccin-macchiato .column.is-offset-one-fifth-tablet{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths,html.theme--catppuccin-macchiato .column.is-offset-two-fifths-tablet{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths,html.theme--catppuccin-macchiato .column.is-offset-three-fifths-tablet{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths,html.theme--catppuccin-macchiato .column.is-offset-four-fifths-tablet{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0,html.theme--catppuccin-macchiato .column.is-0-tablet{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0,html.theme--catppuccin-macchiato .column.is-offset-0-tablet{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1,html.theme--catppuccin-macchiato .column.is-1-tablet{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1,html.theme--catppuccin-macchiato .column.is-offset-1-tablet{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2,html.theme--catppuccin-macchiato .column.is-2-tablet{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2,html.theme--catppuccin-macchiato .column.is-offset-2-tablet{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3,html.theme--catppuccin-macchiato .column.is-3-tablet{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3,html.theme--catppuccin-macchiato .column.is-offset-3-tablet{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4,html.theme--catppuccin-macchiato .column.is-4-tablet{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4,html.theme--catppuccin-macchiato .column.is-offset-4-tablet{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5,html.theme--catppuccin-macchiato .column.is-5-tablet{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5,html.theme--catppuccin-macchiato .column.is-offset-5-tablet{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6,html.theme--catppuccin-macchiato .column.is-6-tablet{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6,html.theme--catppuccin-macchiato .column.is-offset-6-tablet{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7,html.theme--catppuccin-macchiato .column.is-7-tablet{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7,html.theme--catppuccin-macchiato .column.is-offset-7-tablet{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8,html.theme--catppuccin-macchiato .column.is-8-tablet{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8,html.theme--catppuccin-macchiato .column.is-offset-8-tablet{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9,html.theme--catppuccin-macchiato .column.is-9-tablet{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9,html.theme--catppuccin-macchiato .column.is-offset-9-tablet{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10,html.theme--catppuccin-macchiato .column.is-10-tablet{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10,html.theme--catppuccin-macchiato .column.is-offset-10-tablet{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11,html.theme--catppuccin-macchiato .column.is-11-tablet{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11,html.theme--catppuccin-macchiato .column.is-offset-11-tablet{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12,html.theme--catppuccin-macchiato .column.is-12-tablet{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12,html.theme--catppuccin-macchiato .column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .column.is-narrow-touch{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full-touch{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters-touch{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds-touch{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half-touch{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third-touch{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter-touch{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth-touch{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths-touch{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths-touch{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths-touch{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters-touch{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds-touch{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half-touch{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third-touch{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter-touch{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth-touch{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths-touch{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths-touch{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths-touch{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0-touch{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0-touch{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1-touch{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1-touch{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2-touch{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2-touch{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3-touch{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3-touch{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4-touch{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4-touch{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5-touch{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5-touch{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6-touch{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6-touch{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7-touch{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7-touch{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8-touch{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8-touch{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9-touch{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9-touch{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10-touch{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10-touch{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11-touch{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11-touch{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12-touch{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .column.is-narrow-desktop{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full-desktop{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters-desktop{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds-desktop{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half-desktop{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third-desktop{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter-desktop{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth-desktop{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths-desktop{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths-desktop{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths-desktop{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters-desktop{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds-desktop{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half-desktop{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third-desktop{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter-desktop{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth-desktop{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths-desktop{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths-desktop{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths-desktop{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0-desktop{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0-desktop{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1-desktop{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1-desktop{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2-desktop{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2-desktop{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3-desktop{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3-desktop{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4-desktop{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4-desktop{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5-desktop{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5-desktop{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6-desktop{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6-desktop{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7-desktop{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7-desktop{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8-desktop{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8-desktop{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9-desktop{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9-desktop{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10-desktop{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10-desktop{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11-desktop{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11-desktop{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12-desktop{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .column.is-narrow-widescreen{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full-widescreen{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters-widescreen{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds-widescreen{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half-widescreen{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third-widescreen{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter-widescreen{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth-widescreen{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths-widescreen{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths-widescreen{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths-widescreen{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters-widescreen{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds-widescreen{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half-widescreen{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third-widescreen{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter-widescreen{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth-widescreen{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths-widescreen{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths-widescreen{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths-widescreen{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0-widescreen{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0-widescreen{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1-widescreen{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1-widescreen{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2-widescreen{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2-widescreen{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3-widescreen{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3-widescreen{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4-widescreen{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4-widescreen{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5-widescreen{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5-widescreen{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6-widescreen{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6-widescreen{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7-widescreen{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7-widescreen{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8-widescreen{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8-widescreen{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9-widescreen{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9-widescreen{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10-widescreen{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10-widescreen{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11-widescreen{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11-widescreen{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12-widescreen{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .column.is-narrow-fullhd{flex:none;width:unset}html.theme--catppuccin-macchiato .column.is-full-fullhd{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-three-quarters-fullhd{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-two-thirds-fullhd{flex:none;width:66.6666%}html.theme--catppuccin-macchiato .column.is-half-fullhd{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-one-third-fullhd{flex:none;width:33.3333%}html.theme--catppuccin-macchiato .column.is-one-quarter-fullhd{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-one-fifth-fullhd{flex:none;width:20%}html.theme--catppuccin-macchiato .column.is-two-fifths-fullhd{flex:none;width:40%}html.theme--catppuccin-macchiato .column.is-three-fifths-fullhd{flex:none;width:60%}html.theme--catppuccin-macchiato .column.is-four-fifths-fullhd{flex:none;width:80%}html.theme--catppuccin-macchiato .column.is-offset-three-quarters-fullhd{margin-left:75%}html.theme--catppuccin-macchiato .column.is-offset-two-thirds-fullhd{margin-left:66.6666%}html.theme--catppuccin-macchiato .column.is-offset-half-fullhd{margin-left:50%}html.theme--catppuccin-macchiato .column.is-offset-one-third-fullhd{margin-left:33.3333%}html.theme--catppuccin-macchiato .column.is-offset-one-quarter-fullhd{margin-left:25%}html.theme--catppuccin-macchiato .column.is-offset-one-fifth-fullhd{margin-left:20%}html.theme--catppuccin-macchiato .column.is-offset-two-fifths-fullhd{margin-left:40%}html.theme--catppuccin-macchiato .column.is-offset-three-fifths-fullhd{margin-left:60%}html.theme--catppuccin-macchiato .column.is-offset-four-fifths-fullhd{margin-left:80%}html.theme--catppuccin-macchiato .column.is-0-fullhd{flex:none;width:0%}html.theme--catppuccin-macchiato .column.is-offset-0-fullhd{margin-left:0%}html.theme--catppuccin-macchiato .column.is-1-fullhd{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .column.is-offset-1-fullhd{margin-left:8.33333337%}html.theme--catppuccin-macchiato .column.is-2-fullhd{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .column.is-offset-2-fullhd{margin-left:16.66666674%}html.theme--catppuccin-macchiato .column.is-3-fullhd{flex:none;width:25%}html.theme--catppuccin-macchiato .column.is-offset-3-fullhd{margin-left:25%}html.theme--catppuccin-macchiato .column.is-4-fullhd{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .column.is-offset-4-fullhd{margin-left:33.33333337%}html.theme--catppuccin-macchiato .column.is-5-fullhd{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .column.is-offset-5-fullhd{margin-left:41.66666674%}html.theme--catppuccin-macchiato .column.is-6-fullhd{flex:none;width:50%}html.theme--catppuccin-macchiato .column.is-offset-6-fullhd{margin-left:50%}html.theme--catppuccin-macchiato .column.is-7-fullhd{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .column.is-offset-7-fullhd{margin-left:58.33333337%}html.theme--catppuccin-macchiato .column.is-8-fullhd{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .column.is-offset-8-fullhd{margin-left:66.66666674%}html.theme--catppuccin-macchiato .column.is-9-fullhd{flex:none;width:75%}html.theme--catppuccin-macchiato .column.is-offset-9-fullhd{margin-left:75%}html.theme--catppuccin-macchiato .column.is-10-fullhd{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .column.is-offset-10-fullhd{margin-left:83.33333337%}html.theme--catppuccin-macchiato .column.is-11-fullhd{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .column.is-offset-11-fullhd{margin-left:91.66666674%}html.theme--catppuccin-macchiato .column.is-12-fullhd{flex:none;width:100%}html.theme--catppuccin-macchiato .column.is-offset-12-fullhd{margin-left:100%}}html.theme--catppuccin-macchiato .columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-macchiato .columns:last-child{margin-bottom:-.75rem}html.theme--catppuccin-macchiato .columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}html.theme--catppuccin-macchiato .columns.is-centered{justify-content:center}html.theme--catppuccin-macchiato .columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}html.theme--catppuccin-macchiato .columns.is-gapless>.column{margin:0;padding:0 !important}html.theme--catppuccin-macchiato .columns.is-gapless:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-macchiato .columns.is-gapless:last-child{margin-bottom:0}html.theme--catppuccin-macchiato .columns.is-mobile{display:flex}html.theme--catppuccin-macchiato .columns.is-multiline{flex-wrap:wrap}html.theme--catppuccin-macchiato .columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-desktop{display:flex}}html.theme--catppuccin-macchiato .columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}html.theme--catppuccin-macchiato .columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}html.theme--catppuccin-macchiato .columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-0-fullhd{--columnGap: 0rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-1-fullhd{--columnGap: .25rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-2-fullhd{--columnGap: .5rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-3-fullhd{--columnGap: .75rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-4-fullhd{--columnGap: 1rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}html.theme--catppuccin-macchiato .columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-macchiato .columns.is-variable.is-8-fullhd{--columnGap: 2rem}}html.theme--catppuccin-macchiato .tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}html.theme--catppuccin-macchiato .tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-macchiato .tile.is-ancestor:last-child{margin-bottom:-.75rem}html.theme--catppuccin-macchiato .tile.is-ancestor:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-macchiato .tile.is-child{margin:0 !important}html.theme--catppuccin-macchiato .tile.is-parent{padding:.75rem}html.theme--catppuccin-macchiato .tile.is-vertical{flex-direction:column}html.theme--catppuccin-macchiato .tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .tile:not(.is-child){display:flex}html.theme--catppuccin-macchiato .tile.is-1{flex:none;width:8.33333337%}html.theme--catppuccin-macchiato .tile.is-2{flex:none;width:16.66666674%}html.theme--catppuccin-macchiato .tile.is-3{flex:none;width:25%}html.theme--catppuccin-macchiato .tile.is-4{flex:none;width:33.33333337%}html.theme--catppuccin-macchiato .tile.is-5{flex:none;width:41.66666674%}html.theme--catppuccin-macchiato .tile.is-6{flex:none;width:50%}html.theme--catppuccin-macchiato .tile.is-7{flex:none;width:58.33333337%}html.theme--catppuccin-macchiato .tile.is-8{flex:none;width:66.66666674%}html.theme--catppuccin-macchiato .tile.is-9{flex:none;width:75%}html.theme--catppuccin-macchiato .tile.is-10{flex:none;width:83.33333337%}html.theme--catppuccin-macchiato .tile.is-11{flex:none;width:91.66666674%}html.theme--catppuccin-macchiato .tile.is-12{flex:none;width:100%}}html.theme--catppuccin-macchiato .hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}html.theme--catppuccin-macchiato .hero .navbar{background:none}html.theme--catppuccin-macchiato .hero .tabs ul{border-bottom:none}html.theme--catppuccin-macchiato .hero.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-white strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-white .title{color:#0a0a0a}html.theme--catppuccin-macchiato .hero.is-white .subtitle{color:rgba(10,10,10,0.9)}html.theme--catppuccin-macchiato .hero.is-white .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-white .navbar-menu{background-color:#fff}}html.theme--catppuccin-macchiato .hero.is-white .navbar-item,html.theme--catppuccin-macchiato .hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}html.theme--catppuccin-macchiato .hero.is-white a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-white a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-white .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-macchiato .hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-white .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-white .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-white .tabs.is-toggle a{color:#0a0a0a}html.theme--catppuccin-macchiato .hero.is-white .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-white .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-white .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-white .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}html.theme--catppuccin-macchiato .hero.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-macchiato .hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-black strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-black .title{color:#fff}html.theme--catppuccin-macchiato .hero.is-black .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-macchiato .hero.is-black .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-black .navbar-menu{background-color:#0a0a0a}}html.theme--catppuccin-macchiato .hero.is-black .navbar-item,html.theme--catppuccin-macchiato .hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-macchiato .hero.is-black a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-black a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-black .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-macchiato .hero.is-black .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-black .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-black .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-black .tabs.is-toggle a{color:#fff}html.theme--catppuccin-macchiato .hero.is-black .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-black .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-black .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-black .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-macchiato .hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}html.theme--catppuccin-macchiato .hero.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-light strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-light .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-light .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-macchiato .hero.is-light .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-light .navbar-menu{background-color:#f5f5f5}}html.theme--catppuccin-macchiato .hero.is-light .navbar-item,html.theme--catppuccin-macchiato .hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-light a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-light a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-light .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-light .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-macchiato .hero.is-light .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-light .tabs li.is-active a{color:#f5f5f5 !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-light .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-light .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-light .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-light .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-light .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-macchiato .hero.is-light.is-bold{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}}html.theme--catppuccin-macchiato .hero.is-dark,html.theme--catppuccin-macchiato .content kbd.hero{background-color:#363a4f;color:#fff}html.theme--catppuccin-macchiato .hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-dark strong,html.theme--catppuccin-macchiato .content kbd.hero strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-dark .title,html.theme--catppuccin-macchiato .content kbd.hero .title{color:#fff}html.theme--catppuccin-macchiato .hero.is-dark .subtitle,html.theme--catppuccin-macchiato .content kbd.hero .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-macchiato .hero.is-dark .subtitle a:not(.button),html.theme--catppuccin-macchiato .content kbd.hero .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-dark .subtitle strong,html.theme--catppuccin-macchiato .content kbd.hero .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-dark .navbar-menu,html.theme--catppuccin-macchiato .content kbd.hero .navbar-menu{background-color:#363a4f}}html.theme--catppuccin-macchiato .hero.is-dark .navbar-item,html.theme--catppuccin-macchiato .content kbd.hero .navbar-item,html.theme--catppuccin-macchiato .hero.is-dark .navbar-link,html.theme--catppuccin-macchiato .content kbd.hero .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-macchiato .hero.is-dark a.navbar-item:hover,html.theme--catppuccin-macchiato .content kbd.hero a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-dark a.navbar-item.is-active,html.theme--catppuccin-macchiato .content kbd.hero a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-dark .navbar-link:hover,html.theme--catppuccin-macchiato .content kbd.hero .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-dark .navbar-link.is-active,html.theme--catppuccin-macchiato .content kbd.hero .navbar-link.is-active{background-color:#2c2f40;color:#fff}html.theme--catppuccin-macchiato .hero.is-dark .tabs a,html.theme--catppuccin-macchiato .content kbd.hero .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-dark .tabs a:hover,html.theme--catppuccin-macchiato .content kbd.hero .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-dark .tabs li.is-active a,html.theme--catppuccin-macchiato .content kbd.hero .tabs li.is-active a{color:#363a4f !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-boxed a,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-toggle a,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-toggle a{color:#fff}html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-toggle a:hover,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .content kbd.hero .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#363a4f}html.theme--catppuccin-macchiato .hero.is-dark.is-bold,html.theme--catppuccin-macchiato .content kbd.hero.is-bold{background-image:linear-gradient(141deg, #1d2535 0%, #363a4f 71%, #3d3c62 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-dark.is-bold .navbar-menu,html.theme--catppuccin-macchiato .content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #1d2535 0%, #363a4f 71%, #3d3c62 100%)}}html.theme--catppuccin-macchiato .hero.is-primary,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-primary strong,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-primary .title,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .title{color:#fff}html.theme--catppuccin-macchiato .hero.is-primary .subtitle,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-macchiato .hero.is-primary .subtitle a:not(.button),html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-primary .subtitle strong,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-primary .navbar-menu,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#8aadf4}}html.theme--catppuccin-macchiato .hero.is-primary .navbar-item,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .navbar-item,html.theme--catppuccin-macchiato .hero.is-primary .navbar-link,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-macchiato .hero.is-primary a.navbar-item:hover,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-primary a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-primary .navbar-link:hover,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-primary .navbar-link.is-active,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .hero.is-primary .tabs a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-primary .tabs a:hover,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-primary .tabs li.is-active a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#8aadf4 !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-boxed a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-toggle a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-toggle a:hover,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .hero.is-primary.is-bold,html.theme--catppuccin-macchiato .docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #52a5f9 0%, #8aadf4 71%, #9fadf9 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-primary.is-bold .navbar-menu,html.theme--catppuccin-macchiato .docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #52a5f9 0%, #8aadf4 71%, #9fadf9 100%)}}html.theme--catppuccin-macchiato .hero.is-link{background-color:#8aadf4;color:#fff}html.theme--catppuccin-macchiato .hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-link strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-link .title{color:#fff}html.theme--catppuccin-macchiato .hero.is-link .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-macchiato .hero.is-link .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-link .navbar-menu{background-color:#8aadf4}}html.theme--catppuccin-macchiato .hero.is-link .navbar-item,html.theme--catppuccin-macchiato .hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-macchiato .hero.is-link a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-link a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-link .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-link .navbar-link.is-active{background-color:#739df2;color:#fff}html.theme--catppuccin-macchiato .hero.is-link .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-link .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-link .tabs li.is-active a{color:#8aadf4 !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-link .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-link .tabs.is-toggle a{color:#fff}html.theme--catppuccin-macchiato .hero.is-link .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-link .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-link .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-link .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#8aadf4}html.theme--catppuccin-macchiato .hero.is-link.is-bold{background-image:linear-gradient(141deg, #52a5f9 0%, #8aadf4 71%, #9fadf9 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #52a5f9 0%, #8aadf4 71%, #9fadf9 100%)}}html.theme--catppuccin-macchiato .hero.is-info{background-color:#8bd5ca;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-info strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-info .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-info .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-macchiato .hero.is-info .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-info .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-info .navbar-menu{background-color:#8bd5ca}}html.theme--catppuccin-macchiato .hero.is-info .navbar-item,html.theme--catppuccin-macchiato .hero.is-info .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-info a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-info a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-info .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-info .navbar-link.is-active{background-color:#78cec1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-info .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-macchiato .hero.is-info .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-info .tabs li.is-active a{color:#8bd5ca !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-info .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-info .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-info .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-info .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-info .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-info .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#8bd5ca}html.theme--catppuccin-macchiato .hero.is-info.is-bold{background-image:linear-gradient(141deg, #5bd2ac 0%, #8bd5ca 71%, #9adedf 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #5bd2ac 0%, #8bd5ca 71%, #9adedf 100%)}}html.theme--catppuccin-macchiato .hero.is-success{background-color:#a6da95;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-success strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-success .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-success .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-macchiato .hero.is-success .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-success .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-success .navbar-menu{background-color:#a6da95}}html.theme--catppuccin-macchiato .hero.is-success .navbar-item,html.theme--catppuccin-macchiato .hero.is-success .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-success a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-success a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-success .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-success .navbar-link.is-active{background-color:#96d382;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-success .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-macchiato .hero.is-success .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-success .tabs li.is-active a{color:#a6da95 !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-success .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-success .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-success .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-success .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-success .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-success .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#a6da95}html.theme--catppuccin-macchiato .hero.is-success.is-bold{background-image:linear-gradient(141deg, #94d765 0%, #a6da95 71%, #aae4a5 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #94d765 0%, #a6da95 71%, #aae4a5 100%)}}html.theme--catppuccin-macchiato .hero.is-warning{background-color:#eed49f;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-warning strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-warning .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-warning .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-macchiato .hero.is-warning .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-warning .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-warning .navbar-menu{background-color:#eed49f}}html.theme--catppuccin-macchiato .hero.is-warning .navbar-item,html.theme--catppuccin-macchiato .hero.is-warning .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-warning a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-warning a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-warning .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-warning .navbar-link.is-active{background-color:#eaca89;color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-warning .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-macchiato .hero.is-warning .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-warning .tabs li.is-active a{color:#eed49f !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#eed49f}html.theme--catppuccin-macchiato .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #efae6b 0%, #eed49f 71%, #f4e9b2 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #efae6b 0%, #eed49f 71%, #f4e9b2 100%)}}html.theme--catppuccin-macchiato .hero.is-danger{background-color:#ed8796;color:#fff}html.theme--catppuccin-macchiato .hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-macchiato .hero.is-danger strong{color:inherit}html.theme--catppuccin-macchiato .hero.is-danger .title{color:#fff}html.theme--catppuccin-macchiato .hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-macchiato .hero.is-danger .subtitle a:not(.button),html.theme--catppuccin-macchiato .hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .hero.is-danger .navbar-menu{background-color:#ed8796}}html.theme--catppuccin-macchiato .hero.is-danger .navbar-item,html.theme--catppuccin-macchiato .hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-macchiato .hero.is-danger a.navbar-item:hover,html.theme--catppuccin-macchiato .hero.is-danger a.navbar-item.is-active,html.theme--catppuccin-macchiato .hero.is-danger .navbar-link:hover,html.theme--catppuccin-macchiato .hero.is-danger .navbar-link.is-active{background-color:#ea7183;color:#fff}html.theme--catppuccin-macchiato .hero.is-danger .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-macchiato .hero.is-danger .tabs a:hover{opacity:1}html.theme--catppuccin-macchiato .hero.is-danger .tabs li.is-active a{color:#ed8796 !important;opacity:1}html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-boxed a,html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-toggle a{color:#fff}html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-boxed a:hover,html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-boxed li.is-active a,html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-toggle li.is-active a,html.theme--catppuccin-macchiato .hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#ed8796}html.theme--catppuccin-macchiato .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #f05183 0%, #ed8796 71%, #f39c9a 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #f05183 0%, #ed8796 71%, #f39c9a 100%)}}html.theme--catppuccin-macchiato .hero.is-small .hero-body,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .hero.is-large .hero-body{padding:18rem 6rem}}html.theme--catppuccin-macchiato .hero.is-halfheight .hero-body,html.theme--catppuccin-macchiato .hero.is-fullheight .hero-body,html.theme--catppuccin-macchiato .hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}html.theme--catppuccin-macchiato .hero.is-halfheight .hero-body>.container,html.theme--catppuccin-macchiato .hero.is-fullheight .hero-body>.container,html.theme--catppuccin-macchiato .hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}html.theme--catppuccin-macchiato .hero.is-halfheight{min-height:50vh}html.theme--catppuccin-macchiato .hero.is-fullheight{min-height:100vh}html.theme--catppuccin-macchiato .hero-video{overflow:hidden}html.theme--catppuccin-macchiato .hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}html.theme--catppuccin-macchiato .hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero-video{display:none}}html.theme--catppuccin-macchiato .hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-macchiato .hero-buttons .button{display:flex}html.theme--catppuccin-macchiato .hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .hero-buttons{display:flex;justify-content:center}html.theme--catppuccin-macchiato .hero-buttons .button:not(:last-child){margin-right:1.5rem}}html.theme--catppuccin-macchiato .hero-head,html.theme--catppuccin-macchiato .hero-foot{flex-grow:0;flex-shrink:0}html.theme--catppuccin-macchiato .hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-macchiato .hero-body{padding:3rem 3rem}}html.theme--catppuccin-macchiato .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato .section{padding:3rem 3rem}html.theme--catppuccin-macchiato .section.is-medium{padding:9rem 4.5rem}html.theme--catppuccin-macchiato .section.is-large{padding:18rem 6rem}}html.theme--catppuccin-macchiato .footer{background-color:#1e2030;padding:3rem 1.5rem 6rem}html.theme--catppuccin-macchiato h1 .docs-heading-anchor,html.theme--catppuccin-macchiato h1 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h1 .docs-heading-anchor:visited,html.theme--catppuccin-macchiato h2 .docs-heading-anchor,html.theme--catppuccin-macchiato h2 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h2 .docs-heading-anchor:visited,html.theme--catppuccin-macchiato h3 .docs-heading-anchor,html.theme--catppuccin-macchiato h3 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h3 .docs-heading-anchor:visited,html.theme--catppuccin-macchiato h4 .docs-heading-anchor,html.theme--catppuccin-macchiato h4 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h4 .docs-heading-anchor:visited,html.theme--catppuccin-macchiato h5 .docs-heading-anchor,html.theme--catppuccin-macchiato h5 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h5 .docs-heading-anchor:visited,html.theme--catppuccin-macchiato h6 .docs-heading-anchor,html.theme--catppuccin-macchiato h6 .docs-heading-anchor:hover,html.theme--catppuccin-macchiato h6 .docs-heading-anchor:visited{color:#cad3f5}html.theme--catppuccin-macchiato h1 .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h2 .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h3 .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h4 .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h5 .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}html.theme--catppuccin-macchiato h1 .docs-heading-anchor-permalink::before,html.theme--catppuccin-macchiato h2 .docs-heading-anchor-permalink::before,html.theme--catppuccin-macchiato h3 .docs-heading-anchor-permalink::before,html.theme--catppuccin-macchiato h4 .docs-heading-anchor-permalink::before,html.theme--catppuccin-macchiato h5 .docs-heading-anchor-permalink::before,html.theme--catppuccin-macchiato h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}html.theme--catppuccin-macchiato h1:hover .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h2:hover .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h3:hover .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h4:hover .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h5:hover .docs-heading-anchor-permalink,html.theme--catppuccin-macchiato h6:hover .docs-heading-anchor-permalink{visibility:visible}html.theme--catppuccin-macchiato .docs-light-only{display:none !important}html.theme--catppuccin-macchiato pre{position:relative;overflow:hidden}html.theme--catppuccin-macchiato pre code,html.theme--catppuccin-macchiato pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}html.theme--catppuccin-macchiato pre code:first-of-type,html.theme--catppuccin-macchiato pre code.hljs:first-of-type{padding-top:0.5rem !important}html.theme--catppuccin-macchiato pre code:last-of-type,html.theme--catppuccin-macchiato pre code.hljs:last-of-type{padding-bottom:0.5rem !important}html.theme--catppuccin-macchiato pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#cad3f5;cursor:pointer;text-align:center}html.theme--catppuccin-macchiato pre .copy-button:focus,html.theme--catppuccin-macchiato pre .copy-button:hover{opacity:1;background:rgba(202,211,245,0.1);color:#8aadf4}html.theme--catppuccin-macchiato pre .copy-button.success{color:#a6da95;opacity:1}html.theme--catppuccin-macchiato pre .copy-button.error{color:#ed8796;opacity:1}html.theme--catppuccin-macchiato pre:hover .copy-button{opacity:1}html.theme--catppuccin-macchiato .admonition{background-color:#1e2030;border-style:solid;border-width:2px;border-color:#b8c0e0;border-radius:4px;font-size:1rem}html.theme--catppuccin-macchiato .admonition strong{color:currentColor}html.theme--catppuccin-macchiato .admonition.is-small,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}html.theme--catppuccin-macchiato .admonition.is-medium{font-size:1.25rem}html.theme--catppuccin-macchiato .admonition.is-large{font-size:1.5rem}html.theme--catppuccin-macchiato .admonition.is-default{background-color:#1e2030;border-color:#b8c0e0}html.theme--catppuccin-macchiato .admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#b8c0e0}html.theme--catppuccin-macchiato .admonition.is-default>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition.is-info{background-color:#1e2030;border-color:#8bd5ca}html.theme--catppuccin-macchiato .admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#8bd5ca}html.theme--catppuccin-macchiato .admonition.is-info>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition.is-success{background-color:#1e2030;border-color:#a6da95}html.theme--catppuccin-macchiato .admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#a6da95}html.theme--catppuccin-macchiato .admonition.is-success>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition.is-warning{background-color:#1e2030;border-color:#eed49f}html.theme--catppuccin-macchiato .admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#eed49f}html.theme--catppuccin-macchiato .admonition.is-warning>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition.is-danger{background-color:#1e2030;border-color:#ed8796}html.theme--catppuccin-macchiato .admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#ed8796}html.theme--catppuccin-macchiato .admonition.is-danger>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition.is-compat{background-color:#1e2030;border-color:#91d7e3}html.theme--catppuccin-macchiato .admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#91d7e3}html.theme--catppuccin-macchiato .admonition.is-compat>.admonition-body{color:#cad3f5}html.theme--catppuccin-macchiato .admonition-header{color:#b8c0e0;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}html.theme--catppuccin-macchiato .admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}html.theme--catppuccin-macchiato details.admonition.is-details>.admonition-header{list-style:none}html.theme--catppuccin-macchiato details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}html.theme--catppuccin-macchiato details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}html.theme--catppuccin-macchiato .admonition-body{color:#cad3f5;padding:0.5rem .75rem}html.theme--catppuccin-macchiato .admonition-body pre{background-color:#1e2030}html.theme--catppuccin-macchiato .admonition-body code{background-color:#1e2030}html.theme--catppuccin-macchiato .docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #5b6078;border-radius:4px;box-shadow:none;max-width:100%}html.theme--catppuccin-macchiato .docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#1e2030;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #5b6078;overflow:auto}html.theme--catppuccin-macchiato .docstring>header code{background-color:transparent}html.theme--catppuccin-macchiato .docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}html.theme--catppuccin-macchiato .docstring>header .docstring-binding{margin-right:0.3em}html.theme--catppuccin-macchiato .docstring>header .docstring-category{margin-left:0.3em}html.theme--catppuccin-macchiato .docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #5b6078}html.theme--catppuccin-macchiato .docstring>section:last-child{border-bottom:none}html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:focus{opacity:1 !important}html.theme--catppuccin-macchiato .docstring:hover>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-macchiato .docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-macchiato .docstring>section:hover a.docs-sourcelink{opacity:1}html.theme--catppuccin-macchiato .documenter-example-output{background-color:#24273a}html.theme--catppuccin-macchiato .outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#1e2030;color:#cad3f5;border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}html.theme--catppuccin-macchiato .outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}html.theme--catppuccin-macchiato .outdated-warning-overlay a{color:#8aadf4}html.theme--catppuccin-macchiato .outdated-warning-overlay a:hover{color:#91d7e3}html.theme--catppuccin-macchiato .content pre{border:2px solid #5b6078;border-radius:4px}html.theme--catppuccin-macchiato .content code{font-weight:inherit}html.theme--catppuccin-macchiato .content a code{color:#8aadf4}html.theme--catppuccin-macchiato .content a:hover code{color:#91d7e3}html.theme--catppuccin-macchiato .content h1 code,html.theme--catppuccin-macchiato .content h2 code,html.theme--catppuccin-macchiato .content h3 code,html.theme--catppuccin-macchiato .content h4 code,html.theme--catppuccin-macchiato .content h5 code,html.theme--catppuccin-macchiato .content h6 code{color:#cad3f5}html.theme--catppuccin-macchiato .content table{display:block;width:initial;max-width:100%;overflow-x:auto}html.theme--catppuccin-macchiato .content blockquote>ul:first-child,html.theme--catppuccin-macchiato .content blockquote>ol:first-child,html.theme--catppuccin-macchiato .content .admonition-body>ul:first-child,html.theme--catppuccin-macchiato .content .admonition-body>ol:first-child{margin-top:0}html.theme--catppuccin-macchiato pre,html.theme--catppuccin-macchiato code{font-variant-ligatures:no-contextual}html.theme--catppuccin-macchiato .breadcrumb a.is-disabled{cursor:default;pointer-events:none}html.theme--catppuccin-macchiato .breadcrumb a.is-disabled,html.theme--catppuccin-macchiato .breadcrumb a.is-disabled:hover{color:#b5c1f1}html.theme--catppuccin-macchiato .hljs{background:initial !important}html.theme--catppuccin-macchiato .katex .katex-mathml{top:0;right:0}html.theme--catppuccin-macchiato .katex-display,html.theme--catppuccin-macchiato mjx-container,html.theme--catppuccin-macchiato .MathJax_Display{margin:0.5em 0 !important}html.theme--catppuccin-macchiato html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}html.theme--catppuccin-macchiato li.no-marker{list-style:none}html.theme--catppuccin-macchiato #documenter .docs-main>article{overflow-wrap:break-word}html.theme--catppuccin-macchiato #documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato #documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato #documenter .docs-main{width:100%}html.theme--catppuccin-macchiato #documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}html.theme--catppuccin-macchiato #documenter .docs-main>header,html.theme--catppuccin-macchiato #documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar{background-color:#24273a;border-bottom:1px solid #5b6078;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-right .docs-icon,html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #171717;transition-duration:0.7s;-webkit-transition-duration:0.7s}html.theme--catppuccin-macchiato #documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}html.theme--catppuccin-macchiato #documenter .docs-main section.footnotes{border-top:1px solid #5b6078}html.theme--catppuccin-macchiato #documenter .docs-main section.footnotes li .tag:first-child,html.theme--catppuccin-macchiato #documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,html.theme--catppuccin-macchiato #documenter .docs-main section.footnotes li .content kbd:first-child,html.theme--catppuccin-macchiato .content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #5b6078;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer .docs-footer-nextpage,html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}html.theme--catppuccin-macchiato #documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}html.theme--catppuccin-macchiato #documenter .docs-sidebar{display:flex;flex-direction:column;color:#cad3f5;background-color:#1e2030;border-right:1px solid #5b6078;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}html.theme--catppuccin-macchiato #documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #171717}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato #documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato #documenter .docs-sidebar{left:0;top:0}}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-package-name a,html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-package-name a:hover{color:#cad3f5}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-version-selector{border-top:1px solid #5b6078;display:none;padding:0.5rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar .docs-version-selector.visible{display:flex}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #5b6078;padding-bottom:1.5rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #5b6078}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu .tocitem,html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#cad3f5;background:#1e2030}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu a.tocitem:hover,html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#cad3f5;background-color:#26283d}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #5b6078;border-bottom:1px solid #5b6078;background-color:#181926}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#181926;color:#cad3f5}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#26283d;color:#cad3f5}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #5b6078}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input{width:14.4rem}html.theme--catppuccin-macchiato #documenter .docs-sidebar #documenter-search-query{color:#868c98;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#2e3149}html.theme--catppuccin-macchiato #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#3d4162}}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato #documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-macchiato #documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-macchiato #documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#2e3149}html.theme--catppuccin-macchiato #documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#3d4162}}html.theme--catppuccin-macchiato kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(245,245,245,0.6);box-shadow:0 2px 0 1px rgba(245,245,245,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}html.theme--catppuccin-macchiato .search-min-width-50{min-width:50%}html.theme--catppuccin-macchiato .search-min-height-100{min-height:100%}html.theme--catppuccin-macchiato .search-modal-card-body{max-height:calc(100vh - 15rem)}html.theme--catppuccin-macchiato .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-macchiato .search-result-link:hover,html.theme--catppuccin-macchiato .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--catppuccin-macchiato .search-result-link .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-macchiato .property-search-result-badge,html.theme--catppuccin-macchiato .search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}html.theme--catppuccin-macchiato .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link:hover .search-filter,html.theme--catppuccin-macchiato .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link:focus .search-filter{color:#333;background-color:#f1f5f9}html.theme--catppuccin-macchiato .search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}html.theme--catppuccin-macchiato .search-filter:hover,html.theme--catppuccin-macchiato .search-filter:focus{color:#333}html.theme--catppuccin-macchiato .search-filter-selected{color:#363a4f;background-color:#b7bdf8}html.theme--catppuccin-macchiato .search-filter-selected:hover,html.theme--catppuccin-macchiato .search-filter-selected:focus{color:#363a4f}html.theme--catppuccin-macchiato .search-result-highlight{background-color:#ffdd57;color:black}html.theme--catppuccin-macchiato .search-divider{border-bottom:1px solid #5b6078}html.theme--catppuccin-macchiato .search-result-title{width:85%;color:#f5f5f5}html.theme--catppuccin-macchiato .search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-macchiato #search-modal .modal-card-body::-webkit-scrollbar,html.theme--catppuccin-macchiato #search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}html.theme--catppuccin-macchiato #search-modal .modal-card-body::-webkit-scrollbar-thumb,html.theme--catppuccin-macchiato #search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}html.theme--catppuccin-macchiato #search-modal .modal-card-body::-webkit-scrollbar-track,html.theme--catppuccin-macchiato #search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}html.theme--catppuccin-macchiato .w-100{width:100%}html.theme--catppuccin-macchiato .gap-2{gap:0.5rem}html.theme--catppuccin-macchiato .gap-4{gap:1rem}html.theme--catppuccin-macchiato .gap-8{gap:2rem}html.theme--catppuccin-macchiato{background-color:#24273a;font-size:16px;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-macchiato a{transition:all 200ms ease}html.theme--catppuccin-macchiato .label{color:#cad3f5}html.theme--catppuccin-macchiato .button,html.theme--catppuccin-macchiato .control.has-icons-left .icon,html.theme--catppuccin-macchiato .control.has-icons-right .icon,html.theme--catppuccin-macchiato .input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato .pagination-ellipsis,html.theme--catppuccin-macchiato .pagination-link,html.theme--catppuccin-macchiato .pagination-next,html.theme--catppuccin-macchiato .pagination-previous,html.theme--catppuccin-macchiato .select,html.theme--catppuccin-macchiato .select select,html.theme--catppuccin-macchiato .textarea{height:2.5em;color:#cad3f5}html.theme--catppuccin-macchiato .input,html.theme--catppuccin-macchiato #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-macchiato .textarea{transition:all 200ms ease;box-shadow:none;border-width:1px;padding-left:1em;padding-right:1em;color:#cad3f5}html.theme--catppuccin-macchiato .select:after,html.theme--catppuccin-macchiato .select select{border-width:1px}html.theme--catppuccin-macchiato .menu-list a{transition:all 300ms ease}html.theme--catppuccin-macchiato .modal-card-foot,html.theme--catppuccin-macchiato .modal-card-head{border-color:#5b6078}html.theme--catppuccin-macchiato .navbar{border-radius:.4em}html.theme--catppuccin-macchiato .navbar.is-transparent{background:none}html.theme--catppuccin-macchiato .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-macchiato .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#8aadf4}@media screen and (max-width: 1055px){html.theme--catppuccin-macchiato .navbar .navbar-menu{background-color:#8aadf4;border-radius:0 0 .4em .4em}}html.theme--catppuccin-macchiato .docstring>section>a.docs-sourcelink:not(body){color:#363a4f}html.theme--catppuccin-macchiato .tag.is-link:not(body),html.theme--catppuccin-macchiato .docstring>section>a.is-link.docs-sourcelink:not(body),html.theme--catppuccin-macchiato .content kbd.is-link:not(body){color:#363a4f}html.theme--catppuccin-macchiato .ansi span.sgr1{font-weight:bolder}html.theme--catppuccin-macchiato .ansi span.sgr2{font-weight:lighter}html.theme--catppuccin-macchiato .ansi span.sgr3{font-style:italic}html.theme--catppuccin-macchiato .ansi span.sgr4{text-decoration:underline}html.theme--catppuccin-macchiato .ansi span.sgr7{color:#24273a;background-color:#cad3f5}html.theme--catppuccin-macchiato .ansi span.sgr8{color:transparent}html.theme--catppuccin-macchiato .ansi span.sgr8 span{color:transparent}html.theme--catppuccin-macchiato .ansi span.sgr9{text-decoration:line-through}html.theme--catppuccin-macchiato .ansi span.sgr30{color:#494d64}html.theme--catppuccin-macchiato .ansi span.sgr31{color:#ed8796}html.theme--catppuccin-macchiato .ansi span.sgr32{color:#a6da95}html.theme--catppuccin-macchiato .ansi span.sgr33{color:#eed49f}html.theme--catppuccin-macchiato .ansi span.sgr34{color:#8aadf4}html.theme--catppuccin-macchiato .ansi span.sgr35{color:#f5bde6}html.theme--catppuccin-macchiato .ansi span.sgr36{color:#8bd5ca}html.theme--catppuccin-macchiato .ansi span.sgr37{color:#b8c0e0}html.theme--catppuccin-macchiato .ansi span.sgr40{background-color:#494d64}html.theme--catppuccin-macchiato .ansi span.sgr41{background-color:#ed8796}html.theme--catppuccin-macchiato .ansi span.sgr42{background-color:#a6da95}html.theme--catppuccin-macchiato .ansi span.sgr43{background-color:#eed49f}html.theme--catppuccin-macchiato .ansi span.sgr44{background-color:#8aadf4}html.theme--catppuccin-macchiato .ansi span.sgr45{background-color:#f5bde6}html.theme--catppuccin-macchiato .ansi span.sgr46{background-color:#8bd5ca}html.theme--catppuccin-macchiato .ansi span.sgr47{background-color:#b8c0e0}html.theme--catppuccin-macchiato .ansi span.sgr90{color:#5b6078}html.theme--catppuccin-macchiato .ansi span.sgr91{color:#ed8796}html.theme--catppuccin-macchiato .ansi span.sgr92{color:#a6da95}html.theme--catppuccin-macchiato .ansi span.sgr93{color:#eed49f}html.theme--catppuccin-macchiato .ansi span.sgr94{color:#8aadf4}html.theme--catppuccin-macchiato .ansi span.sgr95{color:#f5bde6}html.theme--catppuccin-macchiato .ansi span.sgr96{color:#8bd5ca}html.theme--catppuccin-macchiato .ansi span.sgr97{color:#a5adcb}html.theme--catppuccin-macchiato .ansi span.sgr100{background-color:#5b6078}html.theme--catppuccin-macchiato .ansi span.sgr101{background-color:#ed8796}html.theme--catppuccin-macchiato .ansi span.sgr102{background-color:#a6da95}html.theme--catppuccin-macchiato .ansi span.sgr103{background-color:#eed49f}html.theme--catppuccin-macchiato .ansi span.sgr104{background-color:#8aadf4}html.theme--catppuccin-macchiato .ansi span.sgr105{background-color:#f5bde6}html.theme--catppuccin-macchiato .ansi span.sgr106{background-color:#8bd5ca}html.theme--catppuccin-macchiato .ansi span.sgr107{background-color:#a5adcb}html.theme--catppuccin-macchiato code.language-julia-repl>span.hljs-meta{color:#a6da95;font-weight:bolder}html.theme--catppuccin-macchiato code .hljs{color:#cad3f5;background:#24273a}html.theme--catppuccin-macchiato code .hljs-keyword{color:#c6a0f6}html.theme--catppuccin-macchiato code .hljs-built_in{color:#ed8796}html.theme--catppuccin-macchiato code .hljs-type{color:#eed49f}html.theme--catppuccin-macchiato code .hljs-literal{color:#f5a97f}html.theme--catppuccin-macchiato code .hljs-number{color:#f5a97f}html.theme--catppuccin-macchiato code .hljs-operator{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-punctuation{color:#b8c0e0}html.theme--catppuccin-macchiato code .hljs-property{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-regexp{color:#f5bde6}html.theme--catppuccin-macchiato code .hljs-string{color:#a6da95}html.theme--catppuccin-macchiato code .hljs-char.escape_{color:#a6da95}html.theme--catppuccin-macchiato code .hljs-subst{color:#a5adcb}html.theme--catppuccin-macchiato code .hljs-symbol{color:#f0c6c6}html.theme--catppuccin-macchiato code .hljs-variable{color:#c6a0f6}html.theme--catppuccin-macchiato code .hljs-variable.language_{color:#c6a0f6}html.theme--catppuccin-macchiato code .hljs-variable.constant_{color:#f5a97f}html.theme--catppuccin-macchiato code .hljs-title{color:#8aadf4}html.theme--catppuccin-macchiato code .hljs-title.class_{color:#eed49f}html.theme--catppuccin-macchiato code .hljs-title.function_{color:#8aadf4}html.theme--catppuccin-macchiato code .hljs-params{color:#cad3f5}html.theme--catppuccin-macchiato code .hljs-comment{color:#5b6078}html.theme--catppuccin-macchiato code .hljs-doctag{color:#ed8796}html.theme--catppuccin-macchiato code .hljs-meta{color:#f5a97f}html.theme--catppuccin-macchiato code .hljs-section{color:#8aadf4}html.theme--catppuccin-macchiato code .hljs-tag{color:#a5adcb}html.theme--catppuccin-macchiato code .hljs-name{color:#c6a0f6}html.theme--catppuccin-macchiato code .hljs-attr{color:#8aadf4}html.theme--catppuccin-macchiato code .hljs-attribute{color:#a6da95}html.theme--catppuccin-macchiato code .hljs-bullet{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-code{color:#a6da95}html.theme--catppuccin-macchiato code .hljs-emphasis{color:#ed8796;font-style:italic}html.theme--catppuccin-macchiato code .hljs-strong{color:#ed8796;font-weight:bold}html.theme--catppuccin-macchiato code .hljs-formula{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-link{color:#7dc4e4;font-style:italic}html.theme--catppuccin-macchiato code .hljs-quote{color:#a6da95;font-style:italic}html.theme--catppuccin-macchiato code .hljs-selector-tag{color:#eed49f}html.theme--catppuccin-macchiato code .hljs-selector-id{color:#8aadf4}html.theme--catppuccin-macchiato code .hljs-selector-class{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-selector-attr{color:#c6a0f6}html.theme--catppuccin-macchiato code .hljs-selector-pseudo{color:#8bd5ca}html.theme--catppuccin-macchiato code .hljs-template-tag{color:#f0c6c6}html.theme--catppuccin-macchiato code .hljs-template-variable{color:#f0c6c6}html.theme--catppuccin-macchiato code .hljs-addition{color:#a6da95;background:rgba(166,227,161,0.15)}html.theme--catppuccin-macchiato code .hljs-deletion{color:#ed8796;background:rgba(243,139,168,0.15)}html.theme--catppuccin-macchiato .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-macchiato .search-result-link:hover,html.theme--catppuccin-macchiato .search-result-link:focus{background-color:#363a4f}html.theme--catppuccin-macchiato .search-result-link .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-macchiato .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link:hover .search-filter,html.theme--catppuccin-macchiato .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-macchiato .search-result-link:focus .search-filter{color:#363a4f !important;background-color:#b7bdf8 !important}html.theme--catppuccin-macchiato .search-result-title{color:#cad3f5}html.theme--catppuccin-macchiato .search-result-highlight{background-color:#ed8796;color:#1e2030}html.theme--catppuccin-macchiato .search-divider{border-bottom:1px solid #5e6d6f50}html.theme--catppuccin-macchiato .w-100{width:100%}html.theme--catppuccin-macchiato .gap-2{gap:0.5rem}html.theme--catppuccin-macchiato .gap-4{gap:1rem} diff --git a/v0.16.1/assets/themes/catppuccin-mocha.css b/v0.16.1/assets/themes/catppuccin-mocha.css new file mode 100644 index 000000000..6f27b4c5f --- /dev/null +++ b/v0.16.1/assets/themes/catppuccin-mocha.css @@ -0,0 +1 @@ +html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha .pagination-ellipsis,html.theme--catppuccin-mocha .file-cta,html.theme--catppuccin-mocha .file-name,html.theme--catppuccin-mocha .select select,html.theme--catppuccin-mocha .textarea,html.theme--catppuccin-mocha .input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha .button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:.4em;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}html.theme--catppuccin-mocha .pagination-previous:focus,html.theme--catppuccin-mocha .pagination-next:focus,html.theme--catppuccin-mocha .pagination-link:focus,html.theme--catppuccin-mocha .pagination-ellipsis:focus,html.theme--catppuccin-mocha .file-cta:focus,html.theme--catppuccin-mocha .file-name:focus,html.theme--catppuccin-mocha .select select:focus,html.theme--catppuccin-mocha .textarea:focus,html.theme--catppuccin-mocha .input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-mocha .button:focus,html.theme--catppuccin-mocha .is-focused.pagination-previous,html.theme--catppuccin-mocha .is-focused.pagination-next,html.theme--catppuccin-mocha .is-focused.pagination-link,html.theme--catppuccin-mocha .is-focused.pagination-ellipsis,html.theme--catppuccin-mocha .is-focused.file-cta,html.theme--catppuccin-mocha .is-focused.file-name,html.theme--catppuccin-mocha .select select.is-focused,html.theme--catppuccin-mocha .is-focused.textarea,html.theme--catppuccin-mocha .is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-focused.button,html.theme--catppuccin-mocha .pagination-previous:active,html.theme--catppuccin-mocha .pagination-next:active,html.theme--catppuccin-mocha .pagination-link:active,html.theme--catppuccin-mocha .pagination-ellipsis:active,html.theme--catppuccin-mocha .file-cta:active,html.theme--catppuccin-mocha .file-name:active,html.theme--catppuccin-mocha .select select:active,html.theme--catppuccin-mocha .textarea:active,html.theme--catppuccin-mocha .input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-mocha .button:active,html.theme--catppuccin-mocha .is-active.pagination-previous,html.theme--catppuccin-mocha .is-active.pagination-next,html.theme--catppuccin-mocha .is-active.pagination-link,html.theme--catppuccin-mocha .is-active.pagination-ellipsis,html.theme--catppuccin-mocha .is-active.file-cta,html.theme--catppuccin-mocha .is-active.file-name,html.theme--catppuccin-mocha .select select.is-active,html.theme--catppuccin-mocha .is-active.textarea,html.theme--catppuccin-mocha .is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-mocha .is-active.button{outline:none}html.theme--catppuccin-mocha .pagination-previous[disabled],html.theme--catppuccin-mocha .pagination-next[disabled],html.theme--catppuccin-mocha .pagination-link[disabled],html.theme--catppuccin-mocha .pagination-ellipsis[disabled],html.theme--catppuccin-mocha .file-cta[disabled],html.theme--catppuccin-mocha .file-name[disabled],html.theme--catppuccin-mocha .select select[disabled],html.theme--catppuccin-mocha .textarea[disabled],html.theme--catppuccin-mocha .input[disabled],html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled],html.theme--catppuccin-mocha .button[disabled],fieldset[disabled] html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha fieldset[disabled] .pagination-previous,fieldset[disabled] html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha fieldset[disabled] .pagination-next,fieldset[disabled] html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha fieldset[disabled] .pagination-link,fieldset[disabled] html.theme--catppuccin-mocha .pagination-ellipsis,html.theme--catppuccin-mocha fieldset[disabled] .pagination-ellipsis,fieldset[disabled] html.theme--catppuccin-mocha .file-cta,html.theme--catppuccin-mocha fieldset[disabled] .file-cta,fieldset[disabled] html.theme--catppuccin-mocha .file-name,html.theme--catppuccin-mocha fieldset[disabled] .file-name,fieldset[disabled] html.theme--catppuccin-mocha .select select,fieldset[disabled] html.theme--catppuccin-mocha .textarea,fieldset[disabled] html.theme--catppuccin-mocha .input,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha fieldset[disabled] .select select,html.theme--catppuccin-mocha .select fieldset[disabled] select,html.theme--catppuccin-mocha fieldset[disabled] .textarea,html.theme--catppuccin-mocha fieldset[disabled] .input,html.theme--catppuccin-mocha fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] html.theme--catppuccin-mocha .button,html.theme--catppuccin-mocha fieldset[disabled] .button{cursor:not-allowed}html.theme--catppuccin-mocha .tabs,html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha .pagination-ellipsis,html.theme--catppuccin-mocha .breadcrumb,html.theme--catppuccin-mocha .file,html.theme--catppuccin-mocha .button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}html.theme--catppuccin-mocha .navbar-link:not(.is-arrowless)::after,html.theme--catppuccin-mocha .select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}html.theme--catppuccin-mocha .admonition:not(:last-child),html.theme--catppuccin-mocha .tabs:not(:last-child),html.theme--catppuccin-mocha .pagination:not(:last-child),html.theme--catppuccin-mocha .message:not(:last-child),html.theme--catppuccin-mocha .level:not(:last-child),html.theme--catppuccin-mocha .breadcrumb:not(:last-child),html.theme--catppuccin-mocha .block:not(:last-child),html.theme--catppuccin-mocha .title:not(:last-child),html.theme--catppuccin-mocha .subtitle:not(:last-child),html.theme--catppuccin-mocha .table-container:not(:last-child),html.theme--catppuccin-mocha .table:not(:last-child),html.theme--catppuccin-mocha .progress:not(:last-child),html.theme--catppuccin-mocha .notification:not(:last-child),html.theme--catppuccin-mocha .content:not(:last-child),html.theme--catppuccin-mocha .box:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-mocha .modal-close,html.theme--catppuccin-mocha .delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}html.theme--catppuccin-mocha .modal-close::before,html.theme--catppuccin-mocha .delete::before,html.theme--catppuccin-mocha .modal-close::after,html.theme--catppuccin-mocha .delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-mocha .modal-close::before,html.theme--catppuccin-mocha .delete::before{height:2px;width:50%}html.theme--catppuccin-mocha .modal-close::after,html.theme--catppuccin-mocha .delete::after{height:50%;width:2px}html.theme--catppuccin-mocha .modal-close:hover,html.theme--catppuccin-mocha .delete:hover,html.theme--catppuccin-mocha .modal-close:focus,html.theme--catppuccin-mocha .delete:focus{background-color:rgba(10,10,10,0.3)}html.theme--catppuccin-mocha .modal-close:active,html.theme--catppuccin-mocha .delete:active{background-color:rgba(10,10,10,0.4)}html.theme--catppuccin-mocha .is-small.modal-close,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.modal-close,html.theme--catppuccin-mocha .is-small.delete,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}html.theme--catppuccin-mocha .is-medium.modal-close,html.theme--catppuccin-mocha .is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}html.theme--catppuccin-mocha .is-large.modal-close,html.theme--catppuccin-mocha .is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}html.theme--catppuccin-mocha .control.is-loading::after,html.theme--catppuccin-mocha .select.is-loading::after,html.theme--catppuccin-mocha .loader,html.theme--catppuccin-mocha .button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #7f849c;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}html.theme--catppuccin-mocha .hero-video,html.theme--catppuccin-mocha .modal-background,html.theme--catppuccin-mocha .modal,html.theme--catppuccin-mocha .image.is-square img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-mocha .image.is-square .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-mocha .image.is-1by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-mocha .image.is-1by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-mocha .image.is-5by4 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-mocha .image.is-5by4 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-mocha .image.is-4by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-mocha .image.is-4by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-mocha .image.is-3by2 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-mocha .image.is-3by2 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-mocha .image.is-5by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-mocha .image.is-5by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-mocha .image.is-16by9 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-mocha .image.is-16by9 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-mocha .image.is-2by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-mocha .image.is-2by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-mocha .image.is-3by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-mocha .image.is-3by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-mocha .image.is-4by5 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-mocha .image.is-4by5 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-mocha .image.is-3by4 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-mocha .image.is-3by4 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-mocha .image.is-2by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-mocha .image.is-2by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-mocha .image.is-3by5 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-mocha .image.is-3by5 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-mocha .image.is-9by16 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-mocha .image.is-9by16 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-mocha .image.is-1by2 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-mocha .image.is-1by2 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-mocha .image.is-1by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-mocha .image.is-1by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}html.theme--catppuccin-mocha .navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#f5f5f5 !important}a.has-text-light:hover,a.has-text-light:focus{color:#dbdbdb !important}.has-background-light{background-color:#f5f5f5 !important}.has-text-dark{color:#313244 !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#1c1c26 !important}.has-background-dark{background-color:#313244 !important}.has-text-primary{color:#89b4fa !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#5895f8 !important}.has-background-primary{background-color:#89b4fa !important}.has-text-primary-light{color:#ebf3fe !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#bbd3fc !important}.has-background-primary-light{background-color:#ebf3fe !important}.has-text-primary-dark{color:#063c93 !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#0850c4 !important}.has-background-primary-dark{background-color:#063c93 !important}.has-text-link{color:#89b4fa !important}a.has-text-link:hover,a.has-text-link:focus{color:#5895f8 !important}.has-background-link{background-color:#89b4fa !important}.has-text-link-light{color:#ebf3fe !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#bbd3fc !important}.has-background-link-light{background-color:#ebf3fe !important}.has-text-link-dark{color:#063c93 !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#0850c4 !important}.has-background-link-dark{background-color:#063c93 !important}.has-text-info{color:#94e2d5 !important}a.has-text-info:hover,a.has-text-info:focus{color:#6cd7c5 !important}.has-background-info{background-color:#94e2d5 !important}.has-text-info-light{color:#effbf9 !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#c7f0e9 !important}.has-background-info-light{background-color:#effbf9 !important}.has-text-info-dark{color:#207466 !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#2a9c89 !important}.has-background-info-dark{background-color:#207466 !important}.has-text-success{color:#a6e3a1 !important}a.has-text-success:hover,a.has-text-success:focus{color:#81d77a !important}.has-background-success{background-color:#a6e3a1 !important}.has-text-success-light{color:#f0faef !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#cbefc8 !important}.has-background-success-light{background-color:#f0faef !important}.has-text-success-dark{color:#287222 !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#36992e !important}.has-background-success-dark{background-color:#287222 !important}.has-text-warning{color:#f9e2af !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#f5d180 !important}.has-background-warning{background-color:#f9e2af !important}.has-text-warning-light{color:#fef8ec !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#fae7bd !important}.has-background-warning-light{background-color:#fef8ec !important}.has-text-warning-dark{color:#8a620a !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#b9840e !important}.has-background-warning-dark{background-color:#8a620a !important}.has-text-danger{color:#f38ba8 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#ee5d85 !important}.has-background-danger{background-color:#f38ba8 !important}.has-text-danger-light{color:#fdedf1 !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#f8bece !important}.has-background-danger-light{background-color:#fdedf1 !important}.has-text-danger-dark{color:#991036 !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#c71546 !important}.has-background-danger-dark{background-color:#991036 !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#313244 !important}.has-background-grey-darker{background-color:#313244 !important}.has-text-grey-dark{color:#45475a !important}.has-background-grey-dark{background-color:#45475a !important}.has-text-grey{color:#585b70 !important}.has-background-grey{background-color:#585b70 !important}.has-text-grey-light{color:#6c7086 !important}.has-background-grey-light{background-color:#6c7086 !important}.has-text-grey-lighter{color:#7f849c !important}.has-background-grey-lighter{background-color:#7f849c !important}.has-text-white-ter{color:#f5f5f5 !important}.has-background-white-ter{background-color:#f5f5f5 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}html.theme--catppuccin-mocha html{background-color:#1e1e2e;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-mocha article,html.theme--catppuccin-mocha aside,html.theme--catppuccin-mocha figure,html.theme--catppuccin-mocha footer,html.theme--catppuccin-mocha header,html.theme--catppuccin-mocha hgroup,html.theme--catppuccin-mocha section{display:block}html.theme--catppuccin-mocha body,html.theme--catppuccin-mocha button,html.theme--catppuccin-mocha input,html.theme--catppuccin-mocha optgroup,html.theme--catppuccin-mocha select,html.theme--catppuccin-mocha textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}html.theme--catppuccin-mocha code,html.theme--catppuccin-mocha pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-mocha body{color:#cdd6f4;font-size:1em;font-weight:400;line-height:1.5}html.theme--catppuccin-mocha a{color:#89b4fa;cursor:pointer;text-decoration:none}html.theme--catppuccin-mocha a strong{color:currentColor}html.theme--catppuccin-mocha a:hover{color:#89dceb}html.theme--catppuccin-mocha code{background-color:#181825;color:#cdd6f4;font-size:.875em;font-weight:normal;padding:.1em}html.theme--catppuccin-mocha hr{background-color:#181825;border:none;display:block;height:2px;margin:1.5rem 0}html.theme--catppuccin-mocha img{height:auto;max-width:100%}html.theme--catppuccin-mocha input[type="checkbox"],html.theme--catppuccin-mocha input[type="radio"]{vertical-align:baseline}html.theme--catppuccin-mocha small{font-size:.875em}html.theme--catppuccin-mocha span{font-style:inherit;font-weight:inherit}html.theme--catppuccin-mocha strong{color:#b8c5ef;font-weight:700}html.theme--catppuccin-mocha fieldset{border:none}html.theme--catppuccin-mocha pre{-webkit-overflow-scrolling:touch;background-color:#181825;color:#cdd6f4;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}html.theme--catppuccin-mocha pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}html.theme--catppuccin-mocha table td,html.theme--catppuccin-mocha table th{vertical-align:top}html.theme--catppuccin-mocha table td:not([align]),html.theme--catppuccin-mocha table th:not([align]){text-align:inherit}html.theme--catppuccin-mocha table th{color:#b8c5ef}html.theme--catppuccin-mocha .box{background-color:#45475a;border-radius:8px;box-shadow:none;color:#cdd6f4;display:block;padding:1.25rem}html.theme--catppuccin-mocha a.box:hover,html.theme--catppuccin-mocha a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #89b4fa}html.theme--catppuccin-mocha a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #89b4fa}html.theme--catppuccin-mocha .button{background-color:#181825;border-color:#363653;border-width:1px;color:#89b4fa;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}html.theme--catppuccin-mocha .button strong{color:inherit}html.theme--catppuccin-mocha .button .icon,html.theme--catppuccin-mocha .button .icon.is-small,html.theme--catppuccin-mocha .button #documenter .docs-sidebar form.docs-search>input.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .button form.docs-search>input.icon,html.theme--catppuccin-mocha .button .icon.is-medium,html.theme--catppuccin-mocha .button .icon.is-large{height:1.5em;width:1.5em}html.theme--catppuccin-mocha .button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}html.theme--catppuccin-mocha .button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-mocha .button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}html.theme--catppuccin-mocha .button:hover,html.theme--catppuccin-mocha .button.is-hovered{border-color:#6c7086;color:#b8c5ef}html.theme--catppuccin-mocha .button:focus,html.theme--catppuccin-mocha .button.is-focused{border-color:#6c7086;color:#71a4f9}html.theme--catppuccin-mocha .button:focus:not(:active),html.theme--catppuccin-mocha .button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .button:active,html.theme--catppuccin-mocha .button.is-active{border-color:#45475a;color:#b8c5ef}html.theme--catppuccin-mocha .button.is-text{background-color:transparent;border-color:transparent;color:#cdd6f4;text-decoration:underline}html.theme--catppuccin-mocha .button.is-text:hover,html.theme--catppuccin-mocha .button.is-text.is-hovered,html.theme--catppuccin-mocha .button.is-text:focus,html.theme--catppuccin-mocha .button.is-text.is-focused{background-color:#181825;color:#b8c5ef}html.theme--catppuccin-mocha .button.is-text:active,html.theme--catppuccin-mocha .button.is-text.is-active{background-color:#0e0e16;color:#b8c5ef}html.theme--catppuccin-mocha .button.is-text[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}html.theme--catppuccin-mocha .button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#89b4fa;text-decoration:none}html.theme--catppuccin-mocha .button.is-ghost:hover,html.theme--catppuccin-mocha .button.is-ghost.is-hovered{color:#89b4fa;text-decoration:underline}html.theme--catppuccin-mocha .button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white:hover,html.theme--catppuccin-mocha .button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white:focus,html.theme--catppuccin-mocha .button.is-white.is-focused{border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white:focus:not(:active),html.theme--catppuccin-mocha .button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-mocha .button.is-white:active,html.theme--catppuccin-mocha .button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}html.theme--catppuccin-mocha .button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .button.is-white.is-inverted:hover,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-hovered{background-color:#000}html.theme--catppuccin-mocha .button.is-white.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-mocha .button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-white.is-outlined:hover,html.theme--catppuccin-mocha .button.is-white.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-white.is-outlined:focus,html.theme--catppuccin-mocha .button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-white.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-white.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-white.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-mocha .button.is-white.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-black:hover,html.theme--catppuccin-mocha .button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-black:focus,html.theme--catppuccin-mocha .button.is-black.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-black:focus:not(:active),html.theme--catppuccin-mocha .button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-mocha .button.is-black:active,html.theme--catppuccin-mocha .button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-black[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}html.theme--catppuccin-mocha .button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black.is-inverted:hover,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-mocha .button.is-black.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black.is-outlined:hover,html.theme--catppuccin-mocha .button.is-black.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-black.is-outlined:focus,html.theme--catppuccin-mocha .button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-mocha .button.is-black.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-black.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-black.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-black.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-light{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light:hover,html.theme--catppuccin-mocha .button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light:focus,html.theme--catppuccin-mocha .button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light:focus:not(:active),html.theme--catppuccin-mocha .button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-mocha .button.is-light:active,html.theme--catppuccin-mocha .button.is-light.is-active{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-light{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none}html.theme--catppuccin-mocha .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-mocha .button.is-light.is-inverted:hover,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-mocha .button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;color:#f5f5f5}html.theme--catppuccin-mocha .button.is-light.is-outlined:hover,html.theme--catppuccin-mocha .button.is-light.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-light.is-outlined:focus,html.theme--catppuccin-mocha .button.is-light.is-outlined.is-focused{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-mocha .button.is-light.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-light.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-light.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-light.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;box-shadow:none;color:#f5f5f5}html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-dark,html.theme--catppuccin-mocha .content kbd.button{background-color:#313244;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-dark:hover,html.theme--catppuccin-mocha .content kbd.button:hover,html.theme--catppuccin-mocha .button.is-dark.is-hovered,html.theme--catppuccin-mocha .content kbd.button.is-hovered{background-color:#2c2d3d;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-dark:focus,html.theme--catppuccin-mocha .content kbd.button:focus,html.theme--catppuccin-mocha .button.is-dark.is-focused,html.theme--catppuccin-mocha .content kbd.button.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-dark:focus:not(:active),html.theme--catppuccin-mocha .content kbd.button:focus:not(:active),html.theme--catppuccin-mocha .button.is-dark.is-focused:not(:active),html.theme--catppuccin-mocha .content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(49,50,68,0.25)}html.theme--catppuccin-mocha .button.is-dark:active,html.theme--catppuccin-mocha .content kbd.button:active,html.theme--catppuccin-mocha .button.is-dark.is-active,html.theme--catppuccin-mocha .content kbd.button.is-active{background-color:#262735;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-dark[disabled],html.theme--catppuccin-mocha .content kbd.button[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-dark,fieldset[disabled] html.theme--catppuccin-mocha .content kbd.button{background-color:#313244;border-color:#313244;box-shadow:none}html.theme--catppuccin-mocha .button.is-dark.is-inverted,html.theme--catppuccin-mocha .content kbd.button.is-inverted{background-color:#fff;color:#313244}html.theme--catppuccin-mocha .button.is-dark.is-inverted:hover,html.theme--catppuccin-mocha .content kbd.button.is-inverted:hover,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-hovered,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-mocha .button.is-dark.is-inverted[disabled],html.theme--catppuccin-mocha .content kbd.button.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-dark.is-inverted,fieldset[disabled] html.theme--catppuccin-mocha .content kbd.button.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#313244}html.theme--catppuccin-mocha .button.is-dark.is-loading::after,html.theme--catppuccin-mocha .content kbd.button.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-dark.is-outlined,html.theme--catppuccin-mocha .content kbd.button.is-outlined{background-color:transparent;border-color:#313244;color:#313244}html.theme--catppuccin-mocha .button.is-dark.is-outlined:hover,html.theme--catppuccin-mocha .content kbd.button.is-outlined:hover,html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-hovered,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-dark.is-outlined:focus,html.theme--catppuccin-mocha .content kbd.button.is-outlined:focus,html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-focused,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-focused{background-color:#313244;border-color:#313244;color:#fff}html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-loading::after,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #313244 #313244 !important}html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-dark.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-mocha .content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-dark.is-outlined[disabled],html.theme--catppuccin-mocha .content kbd.button.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-dark.is-outlined,fieldset[disabled] html.theme--catppuccin-mocha .content kbd.button.is-outlined{background-color:transparent;border-color:#313244;box-shadow:none;color:#313244}html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-focused,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-focused{background-color:#fff;color:#313244}html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #313244 #313244 !important}html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined[disabled],html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-dark.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-mocha .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-primary,html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink{background-color:#89b4fa;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-primary:hover,html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink:hover,html.theme--catppuccin-mocha .button.is-primary.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#7dacf9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-primary:focus,html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink:focus,html.theme--catppuccin-mocha .button.is-primary.is-focused,html.theme--catppuccin-mocha .docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-primary:focus:not(:active),html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink:focus:not(:active),html.theme--catppuccin-mocha .button.is-primary.is-focused:not(:active),html.theme--catppuccin-mocha .docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .button.is-primary:active,html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink:active,html.theme--catppuccin-mocha .button.is-primary.is-active,html.theme--catppuccin-mocha .docstring>section>a.button.is-active.docs-sourcelink{background-color:#71a4f9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-primary[disabled],html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-primary,fieldset[disabled] html.theme--catppuccin-mocha .docstring>section>a.button.docs-sourcelink{background-color:#89b4fa;border-color:#89b4fa;box-shadow:none}html.theme--catppuccin-mocha .button.is-primary.is-inverted,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .button.is-primary.is-inverted:hover,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.docs-sourcelink:hover,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}html.theme--catppuccin-mocha .button.is-primary.is-inverted[disabled],html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-primary.is-inverted,fieldset[disabled] html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#89b4fa}html.theme--catppuccin-mocha .button.is-primary.is-loading::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-primary.is-outlined,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#89b4fa;color:#89b4fa}html.theme--catppuccin-mocha .button.is-primary.is-outlined:hover,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-mocha .button.is-primary.is-outlined:focus,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-focused,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#89b4fa;border-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-loading::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #89b4fa #89b4fa !important}html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-mocha .button.is-primary.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-primary.is-outlined[disabled],html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-primary.is-outlined,fieldset[disabled] html.theme--catppuccin-mocha .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#89b4fa;box-shadow:none;color:#89b4fa}html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-focused,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #89b4fa #89b4fa !important}html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined[disabled],html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-primary.is-inverted.is-outlined,fieldset[disabled] html.theme--catppuccin-mocha .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-primary.is-light,html.theme--catppuccin-mocha .docstring>section>a.button.is-light.docs-sourcelink{background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .button.is-primary.is-light:hover,html.theme--catppuccin-mocha .docstring>section>a.button.is-light.docs-sourcelink:hover,html.theme--catppuccin-mocha .button.is-primary.is-light.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#dfebfe;border-color:transparent;color:#063c93}html.theme--catppuccin-mocha .button.is-primary.is-light:active,html.theme--catppuccin-mocha .docstring>section>a.button.is-light.docs-sourcelink:active,html.theme--catppuccin-mocha .button.is-primary.is-light.is-active,html.theme--catppuccin-mocha .docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#d3e3fd;border-color:transparent;color:#063c93}html.theme--catppuccin-mocha .button.is-link{background-color:#89b4fa;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-link:hover,html.theme--catppuccin-mocha .button.is-link.is-hovered{background-color:#7dacf9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-link:focus,html.theme--catppuccin-mocha .button.is-link.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-link:focus:not(:active),html.theme--catppuccin-mocha .button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .button.is-link:active,html.theme--catppuccin-mocha .button.is-link.is-active{background-color:#71a4f9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-link[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-link{background-color:#89b4fa;border-color:#89b4fa;box-shadow:none}html.theme--catppuccin-mocha .button.is-link.is-inverted{background-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .button.is-link.is-inverted:hover,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-mocha .button.is-link.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#89b4fa}html.theme--catppuccin-mocha .button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-link.is-outlined{background-color:transparent;border-color:#89b4fa;color:#89b4fa}html.theme--catppuccin-mocha .button.is-link.is-outlined:hover,html.theme--catppuccin-mocha .button.is-link.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-link.is-outlined:focus,html.theme--catppuccin-mocha .button.is-link.is-outlined.is-focused{background-color:#89b4fa;border-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #89b4fa #89b4fa !important}html.theme--catppuccin-mocha .button.is-link.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-link.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-link.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-link.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-link.is-outlined{background-color:transparent;border-color:#89b4fa;box-shadow:none;color:#89b4fa}html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #89b4fa #89b4fa !important}html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-link.is-light{background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .button.is-link.is-light:hover,html.theme--catppuccin-mocha .button.is-link.is-light.is-hovered{background-color:#dfebfe;border-color:transparent;color:#063c93}html.theme--catppuccin-mocha .button.is-link.is-light:active,html.theme--catppuccin-mocha .button.is-link.is-light.is-active{background-color:#d3e3fd;border-color:transparent;color:#063c93}html.theme--catppuccin-mocha .button.is-info{background-color:#94e2d5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info:hover,html.theme--catppuccin-mocha .button.is-info.is-hovered{background-color:#8adfd1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info:focus,html.theme--catppuccin-mocha .button.is-info.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info:focus:not(:active),html.theme--catppuccin-mocha .button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(148,226,213,0.25)}html.theme--catppuccin-mocha .button.is-info:active,html.theme--catppuccin-mocha .button.is-info.is-active{background-color:#80ddcd;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-info{background-color:#94e2d5;border-color:#94e2d5;box-shadow:none}html.theme--catppuccin-mocha .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);color:#94e2d5}html.theme--catppuccin-mocha .button.is-info.is-inverted:hover,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-info.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#94e2d5}html.theme--catppuccin-mocha .button.is-info.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-info.is-outlined{background-color:transparent;border-color:#94e2d5;color:#94e2d5}html.theme--catppuccin-mocha .button.is-info.is-outlined:hover,html.theme--catppuccin-mocha .button.is-info.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-info.is-outlined:focus,html.theme--catppuccin-mocha .button.is-info.is-outlined.is-focused{background-color:#94e2d5;border-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #94e2d5 #94e2d5 !important}html.theme--catppuccin-mocha .button.is-info.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-info.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-info.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-info.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-info.is-outlined{background-color:transparent;border-color:#94e2d5;box-shadow:none;color:#94e2d5}html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#94e2d5}html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #94e2d5 #94e2d5 !important}html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-info.is-light{background-color:#effbf9;color:#207466}html.theme--catppuccin-mocha .button.is-info.is-light:hover,html.theme--catppuccin-mocha .button.is-info.is-light.is-hovered{background-color:#e5f8f5;border-color:transparent;color:#207466}html.theme--catppuccin-mocha .button.is-info.is-light:active,html.theme--catppuccin-mocha .button.is-info.is-light.is-active{background-color:#dbf5f1;border-color:transparent;color:#207466}html.theme--catppuccin-mocha .button.is-success{background-color:#a6e3a1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success:hover,html.theme--catppuccin-mocha .button.is-success.is-hovered{background-color:#9de097;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success:focus,html.theme--catppuccin-mocha .button.is-success.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success:focus:not(:active),html.theme--catppuccin-mocha .button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(166,227,161,0.25)}html.theme--catppuccin-mocha .button.is-success:active,html.theme--catppuccin-mocha .button.is-success.is-active{background-color:#93dd8d;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-success{background-color:#a6e3a1;border-color:#a6e3a1;box-shadow:none}html.theme--catppuccin-mocha .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);color:#a6e3a1}html.theme--catppuccin-mocha .button.is-success.is-inverted:hover,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-success.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#a6e3a1}html.theme--catppuccin-mocha .button.is-success.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-success.is-outlined{background-color:transparent;border-color:#a6e3a1;color:#a6e3a1}html.theme--catppuccin-mocha .button.is-success.is-outlined:hover,html.theme--catppuccin-mocha .button.is-success.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-success.is-outlined:focus,html.theme--catppuccin-mocha .button.is-success.is-outlined.is-focused{background-color:#a6e3a1;border-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #a6e3a1 #a6e3a1 !important}html.theme--catppuccin-mocha .button.is-success.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-success.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-success.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-success.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-success.is-outlined{background-color:transparent;border-color:#a6e3a1;box-shadow:none;color:#a6e3a1}html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#a6e3a1}html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #a6e3a1 #a6e3a1 !important}html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-success.is-light{background-color:#f0faef;color:#287222}html.theme--catppuccin-mocha .button.is-success.is-light:hover,html.theme--catppuccin-mocha .button.is-success.is-light.is-hovered{background-color:#e7f7e5;border-color:transparent;color:#287222}html.theme--catppuccin-mocha .button.is-success.is-light:active,html.theme--catppuccin-mocha .button.is-success.is-light.is-active{background-color:#def4dc;border-color:transparent;color:#287222}html.theme--catppuccin-mocha .button.is-warning{background-color:#f9e2af;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning:hover,html.theme--catppuccin-mocha .button.is-warning.is-hovered{background-color:#f8dea3;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning:focus,html.theme--catppuccin-mocha .button.is-warning.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning:focus:not(:active),html.theme--catppuccin-mocha .button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(249,226,175,0.25)}html.theme--catppuccin-mocha .button.is-warning:active,html.theme--catppuccin-mocha .button.is-warning.is-active{background-color:#f7d997;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-warning{background-color:#f9e2af;border-color:#f9e2af;box-shadow:none}html.theme--catppuccin-mocha .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);color:#f9e2af}html.theme--catppuccin-mocha .button.is-warning.is-inverted:hover,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f9e2af}html.theme--catppuccin-mocha .button.is-warning.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-warning.is-outlined{background-color:transparent;border-color:#f9e2af;color:#f9e2af}html.theme--catppuccin-mocha .button.is-warning.is-outlined:hover,html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-warning.is-outlined:focus,html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-focused{background-color:#f9e2af;border-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #f9e2af #f9e2af !important}html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--catppuccin-mocha .button.is-warning.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-warning.is-outlined{background-color:transparent;border-color:#f9e2af;box-shadow:none;color:#f9e2af}html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f9e2af}html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f9e2af #f9e2af !important}html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .button.is-warning.is-light{background-color:#fef8ec;color:#8a620a}html.theme--catppuccin-mocha .button.is-warning.is-light:hover,html.theme--catppuccin-mocha .button.is-warning.is-light.is-hovered{background-color:#fdf4e0;border-color:transparent;color:#8a620a}html.theme--catppuccin-mocha .button.is-warning.is-light:active,html.theme--catppuccin-mocha .button.is-warning.is-light.is-active{background-color:#fcf0d4;border-color:transparent;color:#8a620a}html.theme--catppuccin-mocha .button.is-danger{background-color:#f38ba8;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-danger:hover,html.theme--catppuccin-mocha .button.is-danger.is-hovered{background-color:#f27f9f;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-danger:focus,html.theme--catppuccin-mocha .button.is-danger.is-focused{border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-danger:focus:not(:active),html.theme--catppuccin-mocha .button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(243,139,168,0.25)}html.theme--catppuccin-mocha .button.is-danger:active,html.theme--catppuccin-mocha .button.is-danger.is-active{background-color:#f17497;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .button.is-danger[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-danger{background-color:#f38ba8;border-color:#f38ba8;box-shadow:none}html.theme--catppuccin-mocha .button.is-danger.is-inverted{background-color:#fff;color:#f38ba8}html.theme--catppuccin-mocha .button.is-danger.is-inverted:hover,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--catppuccin-mocha .button.is-danger.is-inverted[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#f38ba8}html.theme--catppuccin-mocha .button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-danger.is-outlined{background-color:transparent;border-color:#f38ba8;color:#f38ba8}html.theme--catppuccin-mocha .button.is-danger.is-outlined:hover,html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-danger.is-outlined:focus,html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-focused{background-color:#f38ba8;border-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #f38ba8 #f38ba8 !important}html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--catppuccin-mocha .button.is-danger.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-danger.is-outlined{background-color:transparent;border-color:#f38ba8;box-shadow:none;color:#f38ba8}html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined:hover,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-hovered,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined:focus,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#f38ba8}html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-loading:hover::after,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-loading:focus::after,html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f38ba8 #f38ba8 !important}html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--catppuccin-mocha .button.is-danger.is-light{background-color:#fdedf1;color:#991036}html.theme--catppuccin-mocha .button.is-danger.is-light:hover,html.theme--catppuccin-mocha .button.is-danger.is-light.is-hovered{background-color:#fce1e8;border-color:transparent;color:#991036}html.theme--catppuccin-mocha .button.is-danger.is-light:active,html.theme--catppuccin-mocha .button.is-danger.is-light.is-active{background-color:#fbd5e0;border-color:transparent;color:#991036}html.theme--catppuccin-mocha .button.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}html.theme--catppuccin-mocha .button.is-small:not(.is-rounded),html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:3px}html.theme--catppuccin-mocha .button.is-normal{font-size:1rem}html.theme--catppuccin-mocha .button.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .button.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .button[disabled],fieldset[disabled] html.theme--catppuccin-mocha .button{background-color:#6c7086;border-color:#585b70;box-shadow:none;opacity:.5}html.theme--catppuccin-mocha .button.is-fullwidth{display:flex;width:100%}html.theme--catppuccin-mocha .button.is-loading{color:transparent !important;pointer-events:none}html.theme--catppuccin-mocha .button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}html.theme--catppuccin-mocha .button.is-static{background-color:#181825;border-color:#585b70;color:#7f849c;box-shadow:none;pointer-events:none}html.theme--catppuccin-mocha .button.is-rounded,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}html.theme--catppuccin-mocha .buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-mocha .buttons .button{margin-bottom:0.5rem}html.theme--catppuccin-mocha .buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}html.theme--catppuccin-mocha .buttons:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-mocha .buttons:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-mocha .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}html.theme--catppuccin-mocha .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:3px}html.theme--catppuccin-mocha .buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}html.theme--catppuccin-mocha .buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}html.theme--catppuccin-mocha .buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-mocha .buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}html.theme--catppuccin-mocha .buttons.has-addons .button:last-child{margin-right:0}html.theme--catppuccin-mocha .buttons.has-addons .button:hover,html.theme--catppuccin-mocha .buttons.has-addons .button.is-hovered{z-index:2}html.theme--catppuccin-mocha .buttons.has-addons .button:focus,html.theme--catppuccin-mocha .buttons.has-addons .button.is-focused,html.theme--catppuccin-mocha .buttons.has-addons .button:active,html.theme--catppuccin-mocha .buttons.has-addons .button.is-active,html.theme--catppuccin-mocha .buttons.has-addons .button.is-selected{z-index:3}html.theme--catppuccin-mocha .buttons.has-addons .button:focus:hover,html.theme--catppuccin-mocha .buttons.has-addons .button.is-focused:hover,html.theme--catppuccin-mocha .buttons.has-addons .button:active:hover,html.theme--catppuccin-mocha .buttons.has-addons .button.is-active:hover,html.theme--catppuccin-mocha .buttons.has-addons .button.is-selected:hover{z-index:4}html.theme--catppuccin-mocha .buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .buttons.is-centered{justify-content:center}html.theme--catppuccin-mocha .buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}html.theme--catppuccin-mocha .buttons.is-right{justify-content:flex-end}html.theme--catppuccin-mocha .buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .button.is-responsive.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}html.theme--catppuccin-mocha .button.is-responsive,html.theme--catppuccin-mocha .button.is-responsive.is-normal{font-size:.65625rem}html.theme--catppuccin-mocha .button.is-responsive.is-medium{font-size:.75rem}html.theme--catppuccin-mocha .button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .button.is-responsive.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}html.theme--catppuccin-mocha .button.is-responsive,html.theme--catppuccin-mocha .button.is-responsive.is-normal{font-size:.75rem}html.theme--catppuccin-mocha .button.is-responsive.is-medium{font-size:1rem}html.theme--catppuccin-mocha .button.is-responsive.is-large{font-size:1.25rem}}html.theme--catppuccin-mocha .container{flex-grow:1;margin:0 auto;position:relative;width:auto}html.theme--catppuccin-mocha .container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .container{max-width:992px}}@media screen and (max-width: 1215px){html.theme--catppuccin-mocha .container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){html.theme--catppuccin-mocha .container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}html.theme--catppuccin-mocha .content li+li{margin-top:0.25em}html.theme--catppuccin-mocha .content p:not(:last-child),html.theme--catppuccin-mocha .content dl:not(:last-child),html.theme--catppuccin-mocha .content ol:not(:last-child),html.theme--catppuccin-mocha .content ul:not(:last-child),html.theme--catppuccin-mocha .content blockquote:not(:last-child),html.theme--catppuccin-mocha .content pre:not(:last-child),html.theme--catppuccin-mocha .content table:not(:last-child){margin-bottom:1em}html.theme--catppuccin-mocha .content h1,html.theme--catppuccin-mocha .content h2,html.theme--catppuccin-mocha .content h3,html.theme--catppuccin-mocha .content h4,html.theme--catppuccin-mocha .content h5,html.theme--catppuccin-mocha .content h6{color:#cdd6f4;font-weight:600;line-height:1.125}html.theme--catppuccin-mocha .content h1{font-size:2em;margin-bottom:0.5em}html.theme--catppuccin-mocha .content h1:not(:first-child){margin-top:1em}html.theme--catppuccin-mocha .content h2{font-size:1.75em;margin-bottom:0.5714em}html.theme--catppuccin-mocha .content h2:not(:first-child){margin-top:1.1428em}html.theme--catppuccin-mocha .content h3{font-size:1.5em;margin-bottom:0.6666em}html.theme--catppuccin-mocha .content h3:not(:first-child){margin-top:1.3333em}html.theme--catppuccin-mocha .content h4{font-size:1.25em;margin-bottom:0.8em}html.theme--catppuccin-mocha .content h5{font-size:1.125em;margin-bottom:0.8888em}html.theme--catppuccin-mocha .content h6{font-size:1em;margin-bottom:1em}html.theme--catppuccin-mocha .content blockquote{background-color:#181825;border-left:5px solid #585b70;padding:1.25em 1.5em}html.theme--catppuccin-mocha .content ol{list-style-position:outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-mocha .content ol:not([type]){list-style-type:decimal}html.theme--catppuccin-mocha .content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}html.theme--catppuccin-mocha .content ol.is-lower-roman:not([type]){list-style-type:lower-roman}html.theme--catppuccin-mocha .content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}html.theme--catppuccin-mocha .content ol.is-upper-roman:not([type]){list-style-type:upper-roman}html.theme--catppuccin-mocha .content ul{list-style:disc outside;margin-left:2em;margin-top:1em}html.theme--catppuccin-mocha .content ul ul{list-style-type:circle;margin-top:0.5em}html.theme--catppuccin-mocha .content ul ul ul{list-style-type:square}html.theme--catppuccin-mocha .content dd{margin-left:2em}html.theme--catppuccin-mocha .content figure{margin-left:2em;margin-right:2em;text-align:center}html.theme--catppuccin-mocha .content figure:not(:first-child){margin-top:2em}html.theme--catppuccin-mocha .content figure:not(:last-child){margin-bottom:2em}html.theme--catppuccin-mocha .content figure img{display:inline-block}html.theme--catppuccin-mocha .content figure figcaption{font-style:italic}html.theme--catppuccin-mocha .content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}html.theme--catppuccin-mocha .content sup,html.theme--catppuccin-mocha .content sub{font-size:75%}html.theme--catppuccin-mocha .content table{width:100%}html.theme--catppuccin-mocha .content table td,html.theme--catppuccin-mocha .content table th{border:1px solid #585b70;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-mocha .content table th{color:#b8c5ef}html.theme--catppuccin-mocha .content table th:not([align]){text-align:inherit}html.theme--catppuccin-mocha .content table thead td,html.theme--catppuccin-mocha .content table thead th{border-width:0 0 2px;color:#b8c5ef}html.theme--catppuccin-mocha .content table tfoot td,html.theme--catppuccin-mocha .content table tfoot th{border-width:2px 0 0;color:#b8c5ef}html.theme--catppuccin-mocha .content table tbody tr:last-child td,html.theme--catppuccin-mocha .content table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-mocha .content .tabs li+li{margin-top:0}html.theme--catppuccin-mocha .content.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}html.theme--catppuccin-mocha .content.is-normal{font-size:1rem}html.theme--catppuccin-mocha .content.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .content.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}html.theme--catppuccin-mocha .icon.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}html.theme--catppuccin-mocha .icon.is-medium{height:2rem;width:2rem}html.theme--catppuccin-mocha .icon.is-large{height:3rem;width:3rem}html.theme--catppuccin-mocha .icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}html.theme--catppuccin-mocha .icon-text .icon{flex-grow:0;flex-shrink:0}html.theme--catppuccin-mocha .icon-text .icon:not(:last-child){margin-right:.25em}html.theme--catppuccin-mocha .icon-text .icon:not(:first-child){margin-left:.25em}html.theme--catppuccin-mocha div.icon-text{display:flex}html.theme--catppuccin-mocha .image,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img{display:block;position:relative}html.theme--catppuccin-mocha .image img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}html.theme--catppuccin-mocha .image img.is-rounded,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}html.theme--catppuccin-mocha .image.is-fullwidth,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}html.theme--catppuccin-mocha .image.is-square img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--catppuccin-mocha .image.is-square .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--catppuccin-mocha .image.is-1by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--catppuccin-mocha .image.is-1by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--catppuccin-mocha .image.is-5by4 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--catppuccin-mocha .image.is-5by4 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--catppuccin-mocha .image.is-4by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--catppuccin-mocha .image.is-4by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--catppuccin-mocha .image.is-3by2 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--catppuccin-mocha .image.is-3by2 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--catppuccin-mocha .image.is-5by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--catppuccin-mocha .image.is-5by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--catppuccin-mocha .image.is-16by9 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--catppuccin-mocha .image.is-16by9 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--catppuccin-mocha .image.is-2by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--catppuccin-mocha .image.is-2by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--catppuccin-mocha .image.is-3by1 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--catppuccin-mocha .image.is-3by1 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--catppuccin-mocha .image.is-4by5 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--catppuccin-mocha .image.is-4by5 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--catppuccin-mocha .image.is-3by4 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--catppuccin-mocha .image.is-3by4 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--catppuccin-mocha .image.is-2by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--catppuccin-mocha .image.is-2by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--catppuccin-mocha .image.is-3by5 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--catppuccin-mocha .image.is-3by5 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--catppuccin-mocha .image.is-9by16 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--catppuccin-mocha .image.is-9by16 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--catppuccin-mocha .image.is-1by2 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--catppuccin-mocha .image.is-1by2 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--catppuccin-mocha .image.is-1by3 img,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--catppuccin-mocha .image.is-1by3 .has-ratio,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}html.theme--catppuccin-mocha .image.is-square,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-square,html.theme--catppuccin-mocha .image.is-1by1,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}html.theme--catppuccin-mocha .image.is-5by4,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}html.theme--catppuccin-mocha .image.is-4by3,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}html.theme--catppuccin-mocha .image.is-3by2,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}html.theme--catppuccin-mocha .image.is-5by3,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}html.theme--catppuccin-mocha .image.is-16by9,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}html.theme--catppuccin-mocha .image.is-2by1,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}html.theme--catppuccin-mocha .image.is-3by1,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}html.theme--catppuccin-mocha .image.is-4by5,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}html.theme--catppuccin-mocha .image.is-3by4,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}html.theme--catppuccin-mocha .image.is-2by3,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}html.theme--catppuccin-mocha .image.is-3by5,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}html.theme--catppuccin-mocha .image.is-9by16,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}html.theme--catppuccin-mocha .image.is-1by2,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}html.theme--catppuccin-mocha .image.is-1by3,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}html.theme--catppuccin-mocha .image.is-16x16,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}html.theme--catppuccin-mocha .image.is-24x24,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}html.theme--catppuccin-mocha .image.is-32x32,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}html.theme--catppuccin-mocha .image.is-48x48,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}html.theme--catppuccin-mocha .image.is-64x64,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}html.theme--catppuccin-mocha .image.is-96x96,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}html.theme--catppuccin-mocha .image.is-128x128,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}html.theme--catppuccin-mocha .notification{background-color:#181825;border-radius:.4em;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}html.theme--catppuccin-mocha .notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-mocha .notification strong{color:currentColor}html.theme--catppuccin-mocha .notification code,html.theme--catppuccin-mocha .notification pre{background:#fff}html.theme--catppuccin-mocha .notification pre code{background:transparent}html.theme--catppuccin-mocha .notification>.delete{right:.5rem;position:absolute;top:0.5rem}html.theme--catppuccin-mocha .notification .title,html.theme--catppuccin-mocha .notification .subtitle,html.theme--catppuccin-mocha .notification .content{color:currentColor}html.theme--catppuccin-mocha .notification.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .notification.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .notification.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .notification.is-dark,html.theme--catppuccin-mocha .content kbd.notification{background-color:#313244;color:#fff}html.theme--catppuccin-mocha .notification.is-primary,html.theme--catppuccin-mocha .docstring>section>a.notification.docs-sourcelink{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .notification.is-primary.is-light,html.theme--catppuccin-mocha .docstring>section>a.notification.is-light.docs-sourcelink{background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .notification.is-link{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .notification.is-link.is-light{background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .notification.is-info{background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .notification.is-info.is-light{background-color:#effbf9;color:#207466}html.theme--catppuccin-mocha .notification.is-success{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .notification.is-success.is-light{background-color:#f0faef;color:#287222}html.theme--catppuccin-mocha .notification.is-warning{background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .notification.is-warning.is-light{background-color:#fef8ec;color:#8a620a}html.theme--catppuccin-mocha .notification.is-danger{background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .notification.is-danger.is-light{background-color:#fdedf1;color:#991036}html.theme--catppuccin-mocha .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}html.theme--catppuccin-mocha .progress::-webkit-progress-bar{background-color:#45475a}html.theme--catppuccin-mocha .progress::-webkit-progress-value{background-color:#7f849c}html.theme--catppuccin-mocha .progress::-moz-progress-bar{background-color:#7f849c}html.theme--catppuccin-mocha .progress::-ms-fill{background-color:#7f849c;border:none}html.theme--catppuccin-mocha .progress.is-white::-webkit-progress-value{background-color:#fff}html.theme--catppuccin-mocha .progress.is-white::-moz-progress-bar{background-color:#fff}html.theme--catppuccin-mocha .progress.is-white::-ms-fill{background-color:#fff}html.theme--catppuccin-mocha .progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-black::-webkit-progress-value{background-color:#0a0a0a}html.theme--catppuccin-mocha .progress.is-black::-moz-progress-bar{background-color:#0a0a0a}html.theme--catppuccin-mocha .progress.is-black::-ms-fill{background-color:#0a0a0a}html.theme--catppuccin-mocha .progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-light::-webkit-progress-value{background-color:#f5f5f5}html.theme--catppuccin-mocha .progress.is-light::-moz-progress-bar{background-color:#f5f5f5}html.theme--catppuccin-mocha .progress.is-light::-ms-fill{background-color:#f5f5f5}html.theme--catppuccin-mocha .progress.is-light:indeterminate{background-image:linear-gradient(to right, #f5f5f5 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-dark::-webkit-progress-value,html.theme--catppuccin-mocha .content kbd.progress::-webkit-progress-value{background-color:#313244}html.theme--catppuccin-mocha .progress.is-dark::-moz-progress-bar,html.theme--catppuccin-mocha .content kbd.progress::-moz-progress-bar{background-color:#313244}html.theme--catppuccin-mocha .progress.is-dark::-ms-fill,html.theme--catppuccin-mocha .content kbd.progress::-ms-fill{background-color:#313244}html.theme--catppuccin-mocha .progress.is-dark:indeterminate,html.theme--catppuccin-mocha .content kbd.progress:indeterminate{background-image:linear-gradient(to right, #313244 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-primary::-webkit-progress-value,html.theme--catppuccin-mocha .docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-primary::-moz-progress-bar,html.theme--catppuccin-mocha .docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-primary::-ms-fill,html.theme--catppuccin-mocha .docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-primary:indeterminate,html.theme--catppuccin-mocha .docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #89b4fa 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-link::-webkit-progress-value{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-link::-moz-progress-bar{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-link::-ms-fill{background-color:#89b4fa}html.theme--catppuccin-mocha .progress.is-link:indeterminate{background-image:linear-gradient(to right, #89b4fa 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-info::-webkit-progress-value{background-color:#94e2d5}html.theme--catppuccin-mocha .progress.is-info::-moz-progress-bar{background-color:#94e2d5}html.theme--catppuccin-mocha .progress.is-info::-ms-fill{background-color:#94e2d5}html.theme--catppuccin-mocha .progress.is-info:indeterminate{background-image:linear-gradient(to right, #94e2d5 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-success::-webkit-progress-value{background-color:#a6e3a1}html.theme--catppuccin-mocha .progress.is-success::-moz-progress-bar{background-color:#a6e3a1}html.theme--catppuccin-mocha .progress.is-success::-ms-fill{background-color:#a6e3a1}html.theme--catppuccin-mocha .progress.is-success:indeterminate{background-image:linear-gradient(to right, #a6e3a1 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-warning::-webkit-progress-value{background-color:#f9e2af}html.theme--catppuccin-mocha .progress.is-warning::-moz-progress-bar{background-color:#f9e2af}html.theme--catppuccin-mocha .progress.is-warning::-ms-fill{background-color:#f9e2af}html.theme--catppuccin-mocha .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #f9e2af 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress.is-danger::-webkit-progress-value{background-color:#f38ba8}html.theme--catppuccin-mocha .progress.is-danger::-moz-progress-bar{background-color:#f38ba8}html.theme--catppuccin-mocha .progress.is-danger::-ms-fill{background-color:#f38ba8}html.theme--catppuccin-mocha .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #f38ba8 30%, #45475a 30%)}html.theme--catppuccin-mocha .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#45475a;background-image:linear-gradient(to right, #cdd6f4 30%, #45475a 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}html.theme--catppuccin-mocha .progress:indeterminate::-webkit-progress-bar{background-color:transparent}html.theme--catppuccin-mocha .progress:indeterminate::-moz-progress-bar{background-color:transparent}html.theme--catppuccin-mocha .progress:indeterminate::-ms-fill{animation-name:none}html.theme--catppuccin-mocha .progress.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}html.theme--catppuccin-mocha .progress.is-medium{height:1.25rem}html.theme--catppuccin-mocha .progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}html.theme--catppuccin-mocha .table{background-color:#45475a;color:#cdd6f4}html.theme--catppuccin-mocha .table td,html.theme--catppuccin-mocha .table th{border:1px solid #585b70;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--catppuccin-mocha .table td.is-white,html.theme--catppuccin-mocha .table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .table td.is-black,html.theme--catppuccin-mocha .table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .table td.is-light,html.theme--catppuccin-mocha .table th.is-light{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .table td.is-dark,html.theme--catppuccin-mocha .table th.is-dark{background-color:#313244;border-color:#313244;color:#fff}html.theme--catppuccin-mocha .table td.is-primary,html.theme--catppuccin-mocha .table th.is-primary{background-color:#89b4fa;border-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .table td.is-link,html.theme--catppuccin-mocha .table th.is-link{background-color:#89b4fa;border-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .table td.is-info,html.theme--catppuccin-mocha .table th.is-info{background-color:#94e2d5;border-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .table td.is-success,html.theme--catppuccin-mocha .table th.is-success{background-color:#a6e3a1;border-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .table td.is-warning,html.theme--catppuccin-mocha .table th.is-warning{background-color:#f9e2af;border-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .table td.is-danger,html.theme--catppuccin-mocha .table th.is-danger{background-color:#f38ba8;border-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .table td.is-narrow,html.theme--catppuccin-mocha .table th.is-narrow{white-space:nowrap;width:1%}html.theme--catppuccin-mocha .table td.is-selected,html.theme--catppuccin-mocha .table th.is-selected{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .table td.is-selected a,html.theme--catppuccin-mocha .table td.is-selected strong,html.theme--catppuccin-mocha .table th.is-selected a,html.theme--catppuccin-mocha .table th.is-selected strong{color:currentColor}html.theme--catppuccin-mocha .table td.is-vcentered,html.theme--catppuccin-mocha .table th.is-vcentered{vertical-align:middle}html.theme--catppuccin-mocha .table th{color:#b8c5ef}html.theme--catppuccin-mocha .table th:not([align]){text-align:left}html.theme--catppuccin-mocha .table tr.is-selected{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .table tr.is-selected a,html.theme--catppuccin-mocha .table tr.is-selected strong{color:currentColor}html.theme--catppuccin-mocha .table tr.is-selected td,html.theme--catppuccin-mocha .table tr.is-selected th{border-color:#fff;color:currentColor}html.theme--catppuccin-mocha .table thead{background-color:rgba(0,0,0,0)}html.theme--catppuccin-mocha .table thead td,html.theme--catppuccin-mocha .table thead th{border-width:0 0 2px;color:#b8c5ef}html.theme--catppuccin-mocha .table tfoot{background-color:rgba(0,0,0,0)}html.theme--catppuccin-mocha .table tfoot td,html.theme--catppuccin-mocha .table tfoot th{border-width:2px 0 0;color:#b8c5ef}html.theme--catppuccin-mocha .table tbody{background-color:rgba(0,0,0,0)}html.theme--catppuccin-mocha .table tbody tr:last-child td,html.theme--catppuccin-mocha .table tbody tr:last-child th{border-bottom-width:0}html.theme--catppuccin-mocha .table.is-bordered td,html.theme--catppuccin-mocha .table.is-bordered th{border-width:1px}html.theme--catppuccin-mocha .table.is-bordered tr:last-child td,html.theme--catppuccin-mocha .table.is-bordered tr:last-child th{border-bottom-width:1px}html.theme--catppuccin-mocha .table.is-fullwidth{width:100%}html.theme--catppuccin-mocha .table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#313244}html.theme--catppuccin-mocha .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#313244}html.theme--catppuccin-mocha .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#35364a}html.theme--catppuccin-mocha .table.is-narrow td,html.theme--catppuccin-mocha .table.is-narrow th{padding:0.25em 0.5em}html.theme--catppuccin-mocha .table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#313244}html.theme--catppuccin-mocha .table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}html.theme--catppuccin-mocha .tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-mocha .tags .tag,html.theme--catppuccin-mocha .tags .content kbd,html.theme--catppuccin-mocha .content .tags kbd,html.theme--catppuccin-mocha .tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}html.theme--catppuccin-mocha .tags .tag:not(:last-child),html.theme--catppuccin-mocha .tags .content kbd:not(:last-child),html.theme--catppuccin-mocha .content .tags kbd:not(:last-child),html.theme--catppuccin-mocha .tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}html.theme--catppuccin-mocha .tags:last-child{margin-bottom:-0.5rem}html.theme--catppuccin-mocha .tags:not(:last-child){margin-bottom:1rem}html.theme--catppuccin-mocha .tags.are-medium .tag:not(.is-normal):not(.is-large),html.theme--catppuccin-mocha .tags.are-medium .content kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-mocha .content .tags.are-medium kbd:not(.is-normal):not(.is-large),html.theme--catppuccin-mocha .tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}html.theme--catppuccin-mocha .tags.are-large .tag:not(.is-normal):not(.is-medium),html.theme--catppuccin-mocha .tags.are-large .content kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-mocha .content .tags.are-large kbd:not(.is-normal):not(.is-medium),html.theme--catppuccin-mocha .tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}html.theme--catppuccin-mocha .tags.is-centered{justify-content:center}html.theme--catppuccin-mocha .tags.is-centered .tag,html.theme--catppuccin-mocha .tags.is-centered .content kbd,html.theme--catppuccin-mocha .content .tags.is-centered kbd,html.theme--catppuccin-mocha .tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}html.theme--catppuccin-mocha .tags.is-right{justify-content:flex-end}html.theme--catppuccin-mocha .tags.is-right .tag:not(:first-child),html.theme--catppuccin-mocha .tags.is-right .content kbd:not(:first-child),html.theme--catppuccin-mocha .content .tags.is-right kbd:not(:first-child),html.theme--catppuccin-mocha .tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}html.theme--catppuccin-mocha .tags.is-right .tag:not(:last-child),html.theme--catppuccin-mocha .tags.is-right .content kbd:not(:last-child),html.theme--catppuccin-mocha .content .tags.is-right kbd:not(:last-child),html.theme--catppuccin-mocha .tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}html.theme--catppuccin-mocha .tags.has-addons .tag,html.theme--catppuccin-mocha .tags.has-addons .content kbd,html.theme--catppuccin-mocha .content .tags.has-addons kbd,html.theme--catppuccin-mocha .tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}html.theme--catppuccin-mocha .tags.has-addons .tag:not(:first-child),html.theme--catppuccin-mocha .tags.has-addons .content kbd:not(:first-child),html.theme--catppuccin-mocha .content .tags.has-addons kbd:not(:first-child),html.theme--catppuccin-mocha .tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}html.theme--catppuccin-mocha .tags.has-addons .tag:not(:last-child),html.theme--catppuccin-mocha .tags.has-addons .content kbd:not(:last-child),html.theme--catppuccin-mocha .content .tags.has-addons kbd:not(:last-child),html.theme--catppuccin-mocha .tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}html.theme--catppuccin-mocha .tag:not(body),html.theme--catppuccin-mocha .content kbd:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#181825;border-radius:.4em;color:#cdd6f4;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}html.theme--catppuccin-mocha .tag:not(body) .delete,html.theme--catppuccin-mocha .content kbd:not(body) .delete,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}html.theme--catppuccin-mocha .tag.is-white:not(body),html.theme--catppuccin-mocha .content kbd.is-white:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .tag.is-black:not(body),html.theme--catppuccin-mocha .content kbd.is-black:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .tag.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .tag.is-dark:not(body),html.theme--catppuccin-mocha .content kbd:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-dark:not(body),html.theme--catppuccin-mocha .content .docstring>section>kbd:not(body){background-color:#313244;color:#fff}html.theme--catppuccin-mocha .tag.is-primary:not(body),html.theme--catppuccin-mocha .content kbd.is-primary:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body){background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .tag.is-primary.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-primary.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .tag.is-link:not(body),html.theme--catppuccin-mocha .content kbd.is-link:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .tag.is-link.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-link.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#ebf3fe;color:#063c93}html.theme--catppuccin-mocha .tag.is-info:not(body),html.theme--catppuccin-mocha .content kbd.is-info:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .tag.is-info.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-info.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#effbf9;color:#207466}html.theme--catppuccin-mocha .tag.is-success:not(body),html.theme--catppuccin-mocha .content kbd.is-success:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .tag.is-success.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-success.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#f0faef;color:#287222}html.theme--catppuccin-mocha .tag.is-warning:not(body),html.theme--catppuccin-mocha .content kbd.is-warning:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .tag.is-warning.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-warning.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fef8ec;color:#8a620a}html.theme--catppuccin-mocha .tag.is-danger:not(body),html.theme--catppuccin-mocha .content kbd.is-danger:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .tag.is-danger.is-light:not(body),html.theme--catppuccin-mocha .content kbd.is-danger.is-light:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#fdedf1;color:#991036}html.theme--catppuccin-mocha .tag.is-normal:not(body),html.theme--catppuccin-mocha .content kbd.is-normal:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}html.theme--catppuccin-mocha .tag.is-medium:not(body),html.theme--catppuccin-mocha .content kbd.is-medium:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}html.theme--catppuccin-mocha .tag.is-large:not(body),html.theme--catppuccin-mocha .content kbd.is-large:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}html.theme--catppuccin-mocha .tag:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-mocha .content kbd:not(body) .icon:first-child:not(:last-child),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}html.theme--catppuccin-mocha .tag:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-mocha .content kbd:not(body) .icon:last-child:not(:first-child),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}html.theme--catppuccin-mocha .tag:not(body) .icon:first-child:last-child,html.theme--catppuccin-mocha .content kbd:not(body) .icon:first-child:last-child,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}html.theme--catppuccin-mocha .tag.is-delete:not(body),html.theme--catppuccin-mocha .content kbd.is-delete:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}html.theme--catppuccin-mocha .tag.is-delete:not(body)::before,html.theme--catppuccin-mocha .content kbd.is-delete:not(body)::before,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body)::before,html.theme--catppuccin-mocha .tag.is-delete:not(body)::after,html.theme--catppuccin-mocha .content kbd.is-delete:not(body)::after,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--catppuccin-mocha .tag.is-delete:not(body)::before,html.theme--catppuccin-mocha .content kbd.is-delete:not(body)::before,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}html.theme--catppuccin-mocha .tag.is-delete:not(body)::after,html.theme--catppuccin-mocha .content kbd.is-delete:not(body)::after,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}html.theme--catppuccin-mocha .tag.is-delete:not(body):hover,html.theme--catppuccin-mocha .content kbd.is-delete:not(body):hover,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body):hover,html.theme--catppuccin-mocha .tag.is-delete:not(body):focus,html.theme--catppuccin-mocha .content kbd.is-delete:not(body):focus,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#0e0e16}html.theme--catppuccin-mocha .tag.is-delete:not(body):active,html.theme--catppuccin-mocha .content kbd.is-delete:not(body):active,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#040406}html.theme--catppuccin-mocha .tag.is-rounded:not(body),html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:not(body),html.theme--catppuccin-mocha .content kbd.is-rounded:not(body),html.theme--catppuccin-mocha #documenter .docs-sidebar .content form.docs-search>input:not(body),html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}html.theme--catppuccin-mocha a.tag:hover,html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:hover{text-decoration:underline}html.theme--catppuccin-mocha .title,html.theme--catppuccin-mocha .subtitle{word-break:break-word}html.theme--catppuccin-mocha .title em,html.theme--catppuccin-mocha .title span,html.theme--catppuccin-mocha .subtitle em,html.theme--catppuccin-mocha .subtitle span{font-weight:inherit}html.theme--catppuccin-mocha .title sub,html.theme--catppuccin-mocha .subtitle sub{font-size:.75em}html.theme--catppuccin-mocha .title sup,html.theme--catppuccin-mocha .subtitle sup{font-size:.75em}html.theme--catppuccin-mocha .title .tag,html.theme--catppuccin-mocha .title .content kbd,html.theme--catppuccin-mocha .content .title kbd,html.theme--catppuccin-mocha .title .docstring>section>a.docs-sourcelink,html.theme--catppuccin-mocha .subtitle .tag,html.theme--catppuccin-mocha .subtitle .content kbd,html.theme--catppuccin-mocha .content .subtitle kbd,html.theme--catppuccin-mocha .subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}html.theme--catppuccin-mocha .title{color:#fff;font-size:2rem;font-weight:500;line-height:1.125}html.theme--catppuccin-mocha .title strong{color:inherit;font-weight:inherit}html.theme--catppuccin-mocha .title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}html.theme--catppuccin-mocha .title.is-1{font-size:3rem}html.theme--catppuccin-mocha .title.is-2{font-size:2.5rem}html.theme--catppuccin-mocha .title.is-3{font-size:2rem}html.theme--catppuccin-mocha .title.is-4{font-size:1.5rem}html.theme--catppuccin-mocha .title.is-5{font-size:1.25rem}html.theme--catppuccin-mocha .title.is-6{font-size:1rem}html.theme--catppuccin-mocha .title.is-7{font-size:.75rem}html.theme--catppuccin-mocha .subtitle{color:#6c7086;font-size:1.25rem;font-weight:400;line-height:1.25}html.theme--catppuccin-mocha .subtitle strong{color:#6c7086;font-weight:600}html.theme--catppuccin-mocha .subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}html.theme--catppuccin-mocha .subtitle.is-1{font-size:3rem}html.theme--catppuccin-mocha .subtitle.is-2{font-size:2.5rem}html.theme--catppuccin-mocha .subtitle.is-3{font-size:2rem}html.theme--catppuccin-mocha .subtitle.is-4{font-size:1.5rem}html.theme--catppuccin-mocha .subtitle.is-5{font-size:1.25rem}html.theme--catppuccin-mocha .subtitle.is-6{font-size:1rem}html.theme--catppuccin-mocha .subtitle.is-7{font-size:.75rem}html.theme--catppuccin-mocha .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--catppuccin-mocha .number{align-items:center;background-color:#181825;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}html.theme--catppuccin-mocha .select select,html.theme--catppuccin-mocha .textarea,html.theme--catppuccin-mocha .input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{background-color:#1e1e2e;border-color:#585b70;border-radius:.4em;color:#7f849c}html.theme--catppuccin-mocha .select select::-moz-placeholder,html.theme--catppuccin-mocha .textarea::-moz-placeholder,html.theme--catppuccin-mocha .input::-moz-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#868c98}html.theme--catppuccin-mocha .select select::-webkit-input-placeholder,html.theme--catppuccin-mocha .textarea::-webkit-input-placeholder,html.theme--catppuccin-mocha .input::-webkit-input-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#868c98}html.theme--catppuccin-mocha .select select:-moz-placeholder,html.theme--catppuccin-mocha .textarea:-moz-placeholder,html.theme--catppuccin-mocha .input:-moz-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#868c98}html.theme--catppuccin-mocha .select select:-ms-input-placeholder,html.theme--catppuccin-mocha .textarea:-ms-input-placeholder,html.theme--catppuccin-mocha .input:-ms-input-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#868c98}html.theme--catppuccin-mocha .select select:hover,html.theme--catppuccin-mocha .textarea:hover,html.theme--catppuccin-mocha .input:hover,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:hover,html.theme--catppuccin-mocha .select select.is-hovered,html.theme--catppuccin-mocha .is-hovered.textarea,html.theme--catppuccin-mocha .is-hovered.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#6c7086}html.theme--catppuccin-mocha .select select:focus,html.theme--catppuccin-mocha .textarea:focus,html.theme--catppuccin-mocha .input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:focus,html.theme--catppuccin-mocha .select select.is-focused,html.theme--catppuccin-mocha .is-focused.textarea,html.theme--catppuccin-mocha .is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .select select:active,html.theme--catppuccin-mocha .textarea:active,html.theme--catppuccin-mocha .input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:active,html.theme--catppuccin-mocha .select select.is-active,html.theme--catppuccin-mocha .is-active.textarea,html.theme--catppuccin-mocha .is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{border-color:#89b4fa;box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .select select[disabled],html.theme--catppuccin-mocha .textarea[disabled],html.theme--catppuccin-mocha .input[disabled],html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] html.theme--catppuccin-mocha .select select,fieldset[disabled] html.theme--catppuccin-mocha .textarea,fieldset[disabled] html.theme--catppuccin-mocha .input,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{background-color:#6c7086;border-color:#181825;box-shadow:none;color:#f7f8fd}html.theme--catppuccin-mocha .select select[disabled]::-moz-placeholder,html.theme--catppuccin-mocha .textarea[disabled]::-moz-placeholder,html.theme--catppuccin-mocha .input[disabled]::-moz-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .select select::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .textarea::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .input::-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(247,248,253,0.3)}html.theme--catppuccin-mocha .select select[disabled]::-webkit-input-placeholder,html.theme--catppuccin-mocha .textarea[disabled]::-webkit-input-placeholder,html.theme--catppuccin-mocha .input[disabled]::-webkit-input-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .select select::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .textarea::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .input::-webkit-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(247,248,253,0.3)}html.theme--catppuccin-mocha .select select[disabled]:-moz-placeholder,html.theme--catppuccin-mocha .textarea[disabled]:-moz-placeholder,html.theme--catppuccin-mocha .input[disabled]:-moz-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .select select:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .textarea:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .input:-moz-placeholder,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(247,248,253,0.3)}html.theme--catppuccin-mocha .select select[disabled]:-ms-input-placeholder,html.theme--catppuccin-mocha .textarea[disabled]:-ms-input-placeholder,html.theme--catppuccin-mocha .input[disabled]:-ms-input-placeholder,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .select select:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .textarea:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha .input:-ms-input-placeholder,fieldset[disabled] html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(247,248,253,0.3)}html.theme--catppuccin-mocha .textarea,html.theme--catppuccin-mocha .input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}html.theme--catppuccin-mocha .textarea[readonly],html.theme--catppuccin-mocha .input[readonly],html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}html.theme--catppuccin-mocha .is-white.textarea,html.theme--catppuccin-mocha .is-white.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}html.theme--catppuccin-mocha .is-white.textarea:focus,html.theme--catppuccin-mocha .is-white.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-white:focus,html.theme--catppuccin-mocha .is-white.is-focused.textarea,html.theme--catppuccin-mocha .is-white.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-white.textarea:active,html.theme--catppuccin-mocha .is-white.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-white:active,html.theme--catppuccin-mocha .is-white.is-active.textarea,html.theme--catppuccin-mocha .is-white.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-mocha .is-black.textarea,html.theme--catppuccin-mocha .is-black.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}html.theme--catppuccin-mocha .is-black.textarea:focus,html.theme--catppuccin-mocha .is-black.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-black:focus,html.theme--catppuccin-mocha .is-black.is-focused.textarea,html.theme--catppuccin-mocha .is-black.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-black.textarea:active,html.theme--catppuccin-mocha .is-black.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-black:active,html.theme--catppuccin-mocha .is-black.is-active.textarea,html.theme--catppuccin-mocha .is-black.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-mocha .is-light.textarea,html.theme--catppuccin-mocha .is-light.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-light{border-color:#f5f5f5}html.theme--catppuccin-mocha .is-light.textarea:focus,html.theme--catppuccin-mocha .is-light.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-light:focus,html.theme--catppuccin-mocha .is-light.is-focused.textarea,html.theme--catppuccin-mocha .is-light.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-light.textarea:active,html.theme--catppuccin-mocha .is-light.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-light:active,html.theme--catppuccin-mocha .is-light.is-active.textarea,html.theme--catppuccin-mocha .is-light.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-mocha .is-dark.textarea,html.theme--catppuccin-mocha .content kbd.textarea,html.theme--catppuccin-mocha .is-dark.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-dark,html.theme--catppuccin-mocha .content kbd.input{border-color:#313244}html.theme--catppuccin-mocha .is-dark.textarea:focus,html.theme--catppuccin-mocha .content kbd.textarea:focus,html.theme--catppuccin-mocha .is-dark.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-dark:focus,html.theme--catppuccin-mocha .content kbd.input:focus,html.theme--catppuccin-mocha .is-dark.is-focused.textarea,html.theme--catppuccin-mocha .content kbd.is-focused.textarea,html.theme--catppuccin-mocha .is-dark.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .content kbd.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar .content form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-dark.textarea:active,html.theme--catppuccin-mocha .content kbd.textarea:active,html.theme--catppuccin-mocha .is-dark.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-dark:active,html.theme--catppuccin-mocha .content kbd.input:active,html.theme--catppuccin-mocha .is-dark.is-active.textarea,html.theme--catppuccin-mocha .content kbd.is-active.textarea,html.theme--catppuccin-mocha .is-dark.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-mocha .content kbd.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(49,50,68,0.25)}html.theme--catppuccin-mocha .is-primary.textarea,html.theme--catppuccin-mocha .docstring>section>a.textarea.docs-sourcelink,html.theme--catppuccin-mocha .is-primary.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-primary,html.theme--catppuccin-mocha .docstring>section>a.input.docs-sourcelink{border-color:#89b4fa}html.theme--catppuccin-mocha .is-primary.textarea:focus,html.theme--catppuccin-mocha .docstring>section>a.textarea.docs-sourcelink:focus,html.theme--catppuccin-mocha .is-primary.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-primary:focus,html.theme--catppuccin-mocha .docstring>section>a.input.docs-sourcelink:focus,html.theme--catppuccin-mocha .is-primary.is-focused.textarea,html.theme--catppuccin-mocha .docstring>section>a.is-focused.textarea.docs-sourcelink,html.theme--catppuccin-mocha .is-primary.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .docstring>section>a.is-focused.input.docs-sourcelink,html.theme--catppuccin-mocha .is-primary.textarea:active,html.theme--catppuccin-mocha .docstring>section>a.textarea.docs-sourcelink:active,html.theme--catppuccin-mocha .is-primary.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-primary:active,html.theme--catppuccin-mocha .docstring>section>a.input.docs-sourcelink:active,html.theme--catppuccin-mocha .is-primary.is-active.textarea,html.theme--catppuccin-mocha .docstring>section>a.is-active.textarea.docs-sourcelink,html.theme--catppuccin-mocha .is-primary.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--catppuccin-mocha .docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .is-link.textarea,html.theme--catppuccin-mocha .is-link.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-link{border-color:#89b4fa}html.theme--catppuccin-mocha .is-link.textarea:focus,html.theme--catppuccin-mocha .is-link.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-link:focus,html.theme--catppuccin-mocha .is-link.is-focused.textarea,html.theme--catppuccin-mocha .is-link.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-link.textarea:active,html.theme--catppuccin-mocha .is-link.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-link:active,html.theme--catppuccin-mocha .is-link.is-active.textarea,html.theme--catppuccin-mocha .is-link.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .is-info.textarea,html.theme--catppuccin-mocha .is-info.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-info{border-color:#94e2d5}html.theme--catppuccin-mocha .is-info.textarea:focus,html.theme--catppuccin-mocha .is-info.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-info:focus,html.theme--catppuccin-mocha .is-info.is-focused.textarea,html.theme--catppuccin-mocha .is-info.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-info.textarea:active,html.theme--catppuccin-mocha .is-info.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-info:active,html.theme--catppuccin-mocha .is-info.is-active.textarea,html.theme--catppuccin-mocha .is-info.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(148,226,213,0.25)}html.theme--catppuccin-mocha .is-success.textarea,html.theme--catppuccin-mocha .is-success.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-success{border-color:#a6e3a1}html.theme--catppuccin-mocha .is-success.textarea:focus,html.theme--catppuccin-mocha .is-success.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-success:focus,html.theme--catppuccin-mocha .is-success.is-focused.textarea,html.theme--catppuccin-mocha .is-success.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-success.textarea:active,html.theme--catppuccin-mocha .is-success.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-success:active,html.theme--catppuccin-mocha .is-success.is-active.textarea,html.theme--catppuccin-mocha .is-success.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(166,227,161,0.25)}html.theme--catppuccin-mocha .is-warning.textarea,html.theme--catppuccin-mocha .is-warning.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#f9e2af}html.theme--catppuccin-mocha .is-warning.textarea:focus,html.theme--catppuccin-mocha .is-warning.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-warning:focus,html.theme--catppuccin-mocha .is-warning.is-focused.textarea,html.theme--catppuccin-mocha .is-warning.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-warning.textarea:active,html.theme--catppuccin-mocha .is-warning.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-warning:active,html.theme--catppuccin-mocha .is-warning.is-active.textarea,html.theme--catppuccin-mocha .is-warning.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(249,226,175,0.25)}html.theme--catppuccin-mocha .is-danger.textarea,html.theme--catppuccin-mocha .is-danger.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#f38ba8}html.theme--catppuccin-mocha .is-danger.textarea:focus,html.theme--catppuccin-mocha .is-danger.input:focus,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-danger:focus,html.theme--catppuccin-mocha .is-danger.is-focused.textarea,html.theme--catppuccin-mocha .is-danger.is-focused.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--catppuccin-mocha .is-danger.textarea:active,html.theme--catppuccin-mocha .is-danger.input:active,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-danger:active,html.theme--catppuccin-mocha .is-danger.is-active.textarea,html.theme--catppuccin-mocha .is-danger.is-active.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(243,139,168,0.25)}html.theme--catppuccin-mocha .is-small.textarea,html.theme--catppuccin-mocha .is-small.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{border-radius:3px;font-size:.75rem}html.theme--catppuccin-mocha .is-medium.textarea,html.theme--catppuccin-mocha .is-medium.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .is-large.textarea,html.theme--catppuccin-mocha .is-large.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .is-fullwidth.textarea,html.theme--catppuccin-mocha .is-fullwidth.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}html.theme--catppuccin-mocha .is-inline.textarea,html.theme--catppuccin-mocha .is-inline.input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}html.theme--catppuccin-mocha .input.is-rounded,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}html.theme--catppuccin-mocha .input.is-static,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}html.theme--catppuccin-mocha .textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}html.theme--catppuccin-mocha .textarea:not([rows]){max-height:40em;min-height:8em}html.theme--catppuccin-mocha .textarea[rows]{height:initial}html.theme--catppuccin-mocha .textarea.has-fixed-size{resize:none}html.theme--catppuccin-mocha .radio,html.theme--catppuccin-mocha .checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}html.theme--catppuccin-mocha .radio input,html.theme--catppuccin-mocha .checkbox input{cursor:pointer}html.theme--catppuccin-mocha .radio:hover,html.theme--catppuccin-mocha .checkbox:hover{color:#89dceb}html.theme--catppuccin-mocha .radio[disabled],html.theme--catppuccin-mocha .checkbox[disabled],fieldset[disabled] html.theme--catppuccin-mocha .radio,fieldset[disabled] html.theme--catppuccin-mocha .checkbox,html.theme--catppuccin-mocha .radio input[disabled],html.theme--catppuccin-mocha .checkbox input[disabled]{color:#f7f8fd;cursor:not-allowed}html.theme--catppuccin-mocha .radio+.radio{margin-left:.5em}html.theme--catppuccin-mocha .select{display:inline-block;max-width:100%;position:relative;vertical-align:top}html.theme--catppuccin-mocha .select:not(.is-multiple){height:2.5em}html.theme--catppuccin-mocha .select:not(.is-multiple):not(.is-loading)::after{border-color:#89b4fa;right:1.125em;z-index:4}html.theme--catppuccin-mocha .select.is-rounded select,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}html.theme--catppuccin-mocha .select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}html.theme--catppuccin-mocha .select select::-ms-expand{display:none}html.theme--catppuccin-mocha .select select[disabled]:hover,fieldset[disabled] html.theme--catppuccin-mocha .select select:hover{border-color:#181825}html.theme--catppuccin-mocha .select select:not([multiple]){padding-right:2.5em}html.theme--catppuccin-mocha .select select[multiple]{height:auto;padding:0}html.theme--catppuccin-mocha .select select[multiple] option{padding:0.5em 1em}html.theme--catppuccin-mocha .select:not(.is-multiple):not(.is-loading):hover::after{border-color:#89dceb}html.theme--catppuccin-mocha .select.is-white:not(:hover)::after{border-color:#fff}html.theme--catppuccin-mocha .select.is-white select{border-color:#fff}html.theme--catppuccin-mocha .select.is-white select:hover,html.theme--catppuccin-mocha .select.is-white select.is-hovered{border-color:#f2f2f2}html.theme--catppuccin-mocha .select.is-white select:focus,html.theme--catppuccin-mocha .select.is-white select.is-focused,html.theme--catppuccin-mocha .select.is-white select:active,html.theme--catppuccin-mocha .select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--catppuccin-mocha .select.is-black:not(:hover)::after{border-color:#0a0a0a}html.theme--catppuccin-mocha .select.is-black select{border-color:#0a0a0a}html.theme--catppuccin-mocha .select.is-black select:hover,html.theme--catppuccin-mocha .select.is-black select.is-hovered{border-color:#000}html.theme--catppuccin-mocha .select.is-black select:focus,html.theme--catppuccin-mocha .select.is-black select.is-focused,html.theme--catppuccin-mocha .select.is-black select:active,html.theme--catppuccin-mocha .select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--catppuccin-mocha .select.is-light:not(:hover)::after{border-color:#f5f5f5}html.theme--catppuccin-mocha .select.is-light select{border-color:#f5f5f5}html.theme--catppuccin-mocha .select.is-light select:hover,html.theme--catppuccin-mocha .select.is-light select.is-hovered{border-color:#e8e8e8}html.theme--catppuccin-mocha .select.is-light select:focus,html.theme--catppuccin-mocha .select.is-light select.is-focused,html.theme--catppuccin-mocha .select.is-light select:active,html.theme--catppuccin-mocha .select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}html.theme--catppuccin-mocha .select.is-dark:not(:hover)::after,html.theme--catppuccin-mocha .content kbd.select:not(:hover)::after{border-color:#313244}html.theme--catppuccin-mocha .select.is-dark select,html.theme--catppuccin-mocha .content kbd.select select{border-color:#313244}html.theme--catppuccin-mocha .select.is-dark select:hover,html.theme--catppuccin-mocha .content kbd.select select:hover,html.theme--catppuccin-mocha .select.is-dark select.is-hovered,html.theme--catppuccin-mocha .content kbd.select select.is-hovered{border-color:#262735}html.theme--catppuccin-mocha .select.is-dark select:focus,html.theme--catppuccin-mocha .content kbd.select select:focus,html.theme--catppuccin-mocha .select.is-dark select.is-focused,html.theme--catppuccin-mocha .content kbd.select select.is-focused,html.theme--catppuccin-mocha .select.is-dark select:active,html.theme--catppuccin-mocha .content kbd.select select:active,html.theme--catppuccin-mocha .select.is-dark select.is-active,html.theme--catppuccin-mocha .content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(49,50,68,0.25)}html.theme--catppuccin-mocha .select.is-primary:not(:hover)::after,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#89b4fa}html.theme--catppuccin-mocha .select.is-primary select,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select{border-color:#89b4fa}html.theme--catppuccin-mocha .select.is-primary select:hover,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select:hover,html.theme--catppuccin-mocha .select.is-primary select.is-hovered,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#71a4f9}html.theme--catppuccin-mocha .select.is-primary select:focus,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select:focus,html.theme--catppuccin-mocha .select.is-primary select.is-focused,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select.is-focused,html.theme--catppuccin-mocha .select.is-primary select:active,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select:active,html.theme--catppuccin-mocha .select.is-primary select.is-active,html.theme--catppuccin-mocha .docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .select.is-link:not(:hover)::after{border-color:#89b4fa}html.theme--catppuccin-mocha .select.is-link select{border-color:#89b4fa}html.theme--catppuccin-mocha .select.is-link select:hover,html.theme--catppuccin-mocha .select.is-link select.is-hovered{border-color:#71a4f9}html.theme--catppuccin-mocha .select.is-link select:focus,html.theme--catppuccin-mocha .select.is-link select.is-focused,html.theme--catppuccin-mocha .select.is-link select:active,html.theme--catppuccin-mocha .select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(137,180,250,0.25)}html.theme--catppuccin-mocha .select.is-info:not(:hover)::after{border-color:#94e2d5}html.theme--catppuccin-mocha .select.is-info select{border-color:#94e2d5}html.theme--catppuccin-mocha .select.is-info select:hover,html.theme--catppuccin-mocha .select.is-info select.is-hovered{border-color:#80ddcd}html.theme--catppuccin-mocha .select.is-info select:focus,html.theme--catppuccin-mocha .select.is-info select.is-focused,html.theme--catppuccin-mocha .select.is-info select:active,html.theme--catppuccin-mocha .select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(148,226,213,0.25)}html.theme--catppuccin-mocha .select.is-success:not(:hover)::after{border-color:#a6e3a1}html.theme--catppuccin-mocha .select.is-success select{border-color:#a6e3a1}html.theme--catppuccin-mocha .select.is-success select:hover,html.theme--catppuccin-mocha .select.is-success select.is-hovered{border-color:#93dd8d}html.theme--catppuccin-mocha .select.is-success select:focus,html.theme--catppuccin-mocha .select.is-success select.is-focused,html.theme--catppuccin-mocha .select.is-success select:active,html.theme--catppuccin-mocha .select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(166,227,161,0.25)}html.theme--catppuccin-mocha .select.is-warning:not(:hover)::after{border-color:#f9e2af}html.theme--catppuccin-mocha .select.is-warning select{border-color:#f9e2af}html.theme--catppuccin-mocha .select.is-warning select:hover,html.theme--catppuccin-mocha .select.is-warning select.is-hovered{border-color:#f7d997}html.theme--catppuccin-mocha .select.is-warning select:focus,html.theme--catppuccin-mocha .select.is-warning select.is-focused,html.theme--catppuccin-mocha .select.is-warning select:active,html.theme--catppuccin-mocha .select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(249,226,175,0.25)}html.theme--catppuccin-mocha .select.is-danger:not(:hover)::after{border-color:#f38ba8}html.theme--catppuccin-mocha .select.is-danger select{border-color:#f38ba8}html.theme--catppuccin-mocha .select.is-danger select:hover,html.theme--catppuccin-mocha .select.is-danger select.is-hovered{border-color:#f17497}html.theme--catppuccin-mocha .select.is-danger select:focus,html.theme--catppuccin-mocha .select.is-danger select.is-focused,html.theme--catppuccin-mocha .select.is-danger select:active,html.theme--catppuccin-mocha .select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(243,139,168,0.25)}html.theme--catppuccin-mocha .select.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.select{border-radius:3px;font-size:.75rem}html.theme--catppuccin-mocha .select.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .select.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .select.is-disabled::after{border-color:#f7f8fd !important;opacity:0.5}html.theme--catppuccin-mocha .select.is-fullwidth{width:100%}html.theme--catppuccin-mocha .select.is-fullwidth select{width:100%}html.theme--catppuccin-mocha .select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}html.theme--catppuccin-mocha .select.is-loading.is-small:after,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-mocha .select.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-mocha .select.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-mocha .file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}html.theme--catppuccin-mocha .file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .file.is-white:hover .file-cta,html.theme--catppuccin-mocha .file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .file.is-white:focus .file-cta,html.theme--catppuccin-mocha .file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}html.theme--catppuccin-mocha .file.is-white:active .file-cta,html.theme--catppuccin-mocha .file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--catppuccin-mocha .file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-black:hover .file-cta,html.theme--catppuccin-mocha .file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-black:focus .file-cta,html.theme--catppuccin-mocha .file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}html.theme--catppuccin-mocha .file.is-black:active .file-cta,html.theme--catppuccin-mocha .file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-light .file-cta{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-light:hover .file-cta,html.theme--catppuccin-mocha .file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-light:focus .file-cta,html.theme--catppuccin-mocha .file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(245,245,245,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-light:active .file-cta,html.theme--catppuccin-mocha .file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-dark .file-cta,html.theme--catppuccin-mocha .content kbd.file .file-cta{background-color:#313244;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-dark:hover .file-cta,html.theme--catppuccin-mocha .content kbd.file:hover .file-cta,html.theme--catppuccin-mocha .file.is-dark.is-hovered .file-cta,html.theme--catppuccin-mocha .content kbd.file.is-hovered .file-cta{background-color:#2c2d3d;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-dark:focus .file-cta,html.theme--catppuccin-mocha .content kbd.file:focus .file-cta,html.theme--catppuccin-mocha .file.is-dark.is-focused .file-cta,html.theme--catppuccin-mocha .content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(49,50,68,0.25);color:#fff}html.theme--catppuccin-mocha .file.is-dark:active .file-cta,html.theme--catppuccin-mocha .content kbd.file:active .file-cta,html.theme--catppuccin-mocha .file.is-dark.is-active .file-cta,html.theme--catppuccin-mocha .content kbd.file.is-active .file-cta{background-color:#262735;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-primary .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.docs-sourcelink .file-cta{background-color:#89b4fa;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-primary:hover .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.docs-sourcelink:hover .file-cta,html.theme--catppuccin-mocha .file.is-primary.is-hovered .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#7dacf9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-primary:focus .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.docs-sourcelink:focus .file-cta,html.theme--catppuccin-mocha .file.is-primary.is-focused .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(137,180,250,0.25);color:#fff}html.theme--catppuccin-mocha .file.is-primary:active .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.docs-sourcelink:active .file-cta,html.theme--catppuccin-mocha .file.is-primary.is-active .file-cta,html.theme--catppuccin-mocha .docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#71a4f9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-link .file-cta{background-color:#89b4fa;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-link:hover .file-cta,html.theme--catppuccin-mocha .file.is-link.is-hovered .file-cta{background-color:#7dacf9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-link:focus .file-cta,html.theme--catppuccin-mocha .file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(137,180,250,0.25);color:#fff}html.theme--catppuccin-mocha .file.is-link:active .file-cta,html.theme--catppuccin-mocha .file.is-link.is-active .file-cta{background-color:#71a4f9;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-info .file-cta{background-color:#94e2d5;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-info:hover .file-cta,html.theme--catppuccin-mocha .file.is-info.is-hovered .file-cta{background-color:#8adfd1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-info:focus .file-cta,html.theme--catppuccin-mocha .file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(148,226,213,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-info:active .file-cta,html.theme--catppuccin-mocha .file.is-info.is-active .file-cta{background-color:#80ddcd;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-success .file-cta{background-color:#a6e3a1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-success:hover .file-cta,html.theme--catppuccin-mocha .file.is-success.is-hovered .file-cta{background-color:#9de097;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-success:focus .file-cta,html.theme--catppuccin-mocha .file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(166,227,161,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-success:active .file-cta,html.theme--catppuccin-mocha .file.is-success.is-active .file-cta{background-color:#93dd8d;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-warning .file-cta{background-color:#f9e2af;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-warning:hover .file-cta,html.theme--catppuccin-mocha .file.is-warning.is-hovered .file-cta{background-color:#f8dea3;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-warning:focus .file-cta,html.theme--catppuccin-mocha .file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(249,226,175,0.25);color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-warning:active .file-cta,html.theme--catppuccin-mocha .file.is-warning.is-active .file-cta{background-color:#f7d997;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .file.is-danger .file-cta{background-color:#f38ba8;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-danger:hover .file-cta,html.theme--catppuccin-mocha .file.is-danger.is-hovered .file-cta{background-color:#f27f9f;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-danger:focus .file-cta,html.theme--catppuccin-mocha .file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(243,139,168,0.25);color:#fff}html.theme--catppuccin-mocha .file.is-danger:active .file-cta,html.theme--catppuccin-mocha .file.is-danger.is-active .file-cta{background-color:#f17497;border-color:transparent;color:#fff}html.theme--catppuccin-mocha .file.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}html.theme--catppuccin-mocha .file.is-normal{font-size:1rem}html.theme--catppuccin-mocha .file.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .file.is-medium .file-icon .fa{font-size:21px}html.theme--catppuccin-mocha .file.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .file.is-large .file-icon .fa{font-size:28px}html.theme--catppuccin-mocha .file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-mocha .file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-mocha .file.has-name.is-empty .file-cta{border-radius:.4em}html.theme--catppuccin-mocha .file.has-name.is-empty .file-name{display:none}html.theme--catppuccin-mocha .file.is-boxed .file-label{flex-direction:column}html.theme--catppuccin-mocha .file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}html.theme--catppuccin-mocha .file.is-boxed .file-name{border-width:0 1px 1px}html.theme--catppuccin-mocha .file.is-boxed .file-icon{height:1.5em;width:1.5em}html.theme--catppuccin-mocha .file.is-boxed .file-icon .fa{font-size:21px}html.theme--catppuccin-mocha .file.is-boxed.is-small .file-icon .fa,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}html.theme--catppuccin-mocha .file.is-boxed.is-medium .file-icon .fa{font-size:28px}html.theme--catppuccin-mocha .file.is-boxed.is-large .file-icon .fa{font-size:35px}html.theme--catppuccin-mocha .file.is-boxed.has-name .file-cta{border-radius:.4em .4em 0 0}html.theme--catppuccin-mocha .file.is-boxed.has-name .file-name{border-radius:0 0 .4em .4em;border-width:0 1px 1px}html.theme--catppuccin-mocha .file.is-centered{justify-content:center}html.theme--catppuccin-mocha .file.is-fullwidth .file-label{width:100%}html.theme--catppuccin-mocha .file.is-fullwidth .file-name{flex-grow:1;max-width:none}html.theme--catppuccin-mocha .file.is-right{justify-content:flex-end}html.theme--catppuccin-mocha .file.is-right .file-cta{border-radius:0 .4em .4em 0}html.theme--catppuccin-mocha .file.is-right .file-name{border-radius:.4em 0 0 .4em;border-width:1px 0 1px 1px;order:-1}html.theme--catppuccin-mocha .file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}html.theme--catppuccin-mocha .file-label:hover .file-cta{background-color:#2c2d3d;color:#b8c5ef}html.theme--catppuccin-mocha .file-label:hover .file-name{border-color:#525569}html.theme--catppuccin-mocha .file-label:active .file-cta{background-color:#262735;color:#b8c5ef}html.theme--catppuccin-mocha .file-label:active .file-name{border-color:#4d4f62}html.theme--catppuccin-mocha .file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}html.theme--catppuccin-mocha .file-cta,html.theme--catppuccin-mocha .file-name{border-color:#585b70;border-radius:.4em;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}html.theme--catppuccin-mocha .file-cta{background-color:#313244;color:#cdd6f4}html.theme--catppuccin-mocha .file-name{border-color:#585b70;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}html.theme--catppuccin-mocha .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}html.theme--catppuccin-mocha .file-icon .fa{font-size:14px}html.theme--catppuccin-mocha .label{color:#b8c5ef;display:block;font-size:1rem;font-weight:700}html.theme--catppuccin-mocha .label:not(:last-child){margin-bottom:0.5em}html.theme--catppuccin-mocha .label.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}html.theme--catppuccin-mocha .label.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .label.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .help{display:block;font-size:.75rem;margin-top:0.25rem}html.theme--catppuccin-mocha .help.is-white{color:#fff}html.theme--catppuccin-mocha .help.is-black{color:#0a0a0a}html.theme--catppuccin-mocha .help.is-light{color:#f5f5f5}html.theme--catppuccin-mocha .help.is-dark,html.theme--catppuccin-mocha .content kbd.help{color:#313244}html.theme--catppuccin-mocha .help.is-primary,html.theme--catppuccin-mocha .docstring>section>a.help.docs-sourcelink{color:#89b4fa}html.theme--catppuccin-mocha .help.is-link{color:#89b4fa}html.theme--catppuccin-mocha .help.is-info{color:#94e2d5}html.theme--catppuccin-mocha .help.is-success{color:#a6e3a1}html.theme--catppuccin-mocha .help.is-warning{color:#f9e2af}html.theme--catppuccin-mocha .help.is-danger{color:#f38ba8}html.theme--catppuccin-mocha .field:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-mocha .field.has-addons{display:flex;justify-content:flex-start}html.theme--catppuccin-mocha .field.has-addons .control:not(:last-child){margin-right:-1px}html.theme--catppuccin-mocha .field.has-addons .control:not(:first-child):not(:last-child) .button,html.theme--catppuccin-mocha .field.has-addons .control:not(:first-child):not(:last-child) .input,html.theme--catppuccin-mocha .field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,html.theme--catppuccin-mocha .field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}html.theme--catppuccin-mocha .field.has-addons .control:first-child:not(:only-child) .button,html.theme--catppuccin-mocha .field.has-addons .control:first-child:not(:only-child) .input,html.theme--catppuccin-mocha .field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-mocha .field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--catppuccin-mocha .field.has-addons .control:last-child:not(:only-child) .button,html.theme--catppuccin-mocha .field.has-addons .control:last-child:not(:only-child) .input,html.theme--catppuccin-mocha .field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,html.theme--catppuccin-mocha .field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--catppuccin-mocha .field.has-addons .control .button:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .button.is-hovered:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .input:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .input.is-hovered:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .select select:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}html.theme--catppuccin-mocha .field.has-addons .control .button:not([disabled]):focus,html.theme--catppuccin-mocha .field.has-addons .control .button.is-focused:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .button:not([disabled]):active,html.theme--catppuccin-mocha .field.has-addons .control .button.is-active:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .input:not([disabled]):focus,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,html.theme--catppuccin-mocha .field.has-addons .control .input.is-focused:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .input:not([disabled]):active,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,html.theme--catppuccin-mocha .field.has-addons .control .input.is-active:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .select select:not([disabled]):focus,html.theme--catppuccin-mocha .field.has-addons .control .select select.is-focused:not([disabled]),html.theme--catppuccin-mocha .field.has-addons .control .select select:not([disabled]):active,html.theme--catppuccin-mocha .field.has-addons .control .select select.is-active:not([disabled]){z-index:3}html.theme--catppuccin-mocha .field.has-addons .control .button:not([disabled]):focus:hover,html.theme--catppuccin-mocha .field.has-addons .control .button.is-focused:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .button:not([disabled]):active:hover,html.theme--catppuccin-mocha .field.has-addons .control .button.is-active:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .input:not([disabled]):focus:hover,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,html.theme--catppuccin-mocha .field.has-addons .control .input.is-focused:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .input:not([disabled]):active:hover,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,html.theme--catppuccin-mocha .field.has-addons .control .input.is-active:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-mocha #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .select select:not([disabled]):focus:hover,html.theme--catppuccin-mocha .field.has-addons .control .select select.is-focused:not([disabled]):hover,html.theme--catppuccin-mocha .field.has-addons .control .select select:not([disabled]):active:hover,html.theme--catppuccin-mocha .field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}html.theme--catppuccin-mocha .field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .field.has-addons.has-addons-centered{justify-content:center}html.theme--catppuccin-mocha .field.has-addons.has-addons-right{justify-content:flex-end}html.theme--catppuccin-mocha .field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}html.theme--catppuccin-mocha .field.is-grouped{display:flex;justify-content:flex-start}html.theme--catppuccin-mocha .field.is-grouped>.control{flex-shrink:0}html.theme--catppuccin-mocha .field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-mocha .field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-centered{justify-content:center}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-right{justify-content:flex-end}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-multiline{flex-wrap:wrap}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-multiline>.control:last-child,html.theme--catppuccin-mocha .field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}html.theme--catppuccin-mocha .field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .field.is-horizontal{display:flex}}html.theme--catppuccin-mocha .field-label .label{font-size:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}html.theme--catppuccin-mocha .field-label.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}html.theme--catppuccin-mocha .field-label.is-normal{padding-top:0.375em}html.theme--catppuccin-mocha .field-label.is-medium{font-size:1.25rem;padding-top:0.375em}html.theme--catppuccin-mocha .field-label.is-large{font-size:1.5rem;padding-top:0.375em}}html.theme--catppuccin-mocha .field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}html.theme--catppuccin-mocha .field-body .field{margin-bottom:0}html.theme--catppuccin-mocha .field-body>.field{flex-shrink:1}html.theme--catppuccin-mocha .field-body>.field:not(.is-narrow){flex-grow:1}html.theme--catppuccin-mocha .field-body>.field:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-mocha .control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}html.theme--catppuccin-mocha .control.has-icons-left .input:focus~.icon,html.theme--catppuccin-mocha .control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,html.theme--catppuccin-mocha .control.has-icons-left .select:focus~.icon,html.theme--catppuccin-mocha .control.has-icons-right .input:focus~.icon,html.theme--catppuccin-mocha .control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,html.theme--catppuccin-mocha .control.has-icons-right .select:focus~.icon{color:#313244}html.theme--catppuccin-mocha .control.has-icons-left .input.is-small~.icon,html.theme--catppuccin-mocha .control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,html.theme--catppuccin-mocha .control.has-icons-left .select.is-small~.icon,html.theme--catppuccin-mocha .control.has-icons-right .input.is-small~.icon,html.theme--catppuccin-mocha .control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,html.theme--catppuccin-mocha .control.has-icons-right .select.is-small~.icon{font-size:.75rem}html.theme--catppuccin-mocha .control.has-icons-left .input.is-medium~.icon,html.theme--catppuccin-mocha .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,html.theme--catppuccin-mocha .control.has-icons-left .select.is-medium~.icon,html.theme--catppuccin-mocha .control.has-icons-right .input.is-medium~.icon,html.theme--catppuccin-mocha .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,html.theme--catppuccin-mocha .control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}html.theme--catppuccin-mocha .control.has-icons-left .input.is-large~.icon,html.theme--catppuccin-mocha .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,html.theme--catppuccin-mocha .control.has-icons-left .select.is-large~.icon,html.theme--catppuccin-mocha .control.has-icons-right .input.is-large~.icon,html.theme--catppuccin-mocha .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,html.theme--catppuccin-mocha .control.has-icons-right .select.is-large~.icon{font-size:1.5rem}html.theme--catppuccin-mocha .control.has-icons-left .icon,html.theme--catppuccin-mocha .control.has-icons-right .icon{color:#585b70;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}html.theme--catppuccin-mocha .control.has-icons-left .input,html.theme--catppuccin-mocha .control.has-icons-left #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-left form.docs-search>input,html.theme--catppuccin-mocha .control.has-icons-left .select select{padding-left:2.5em}html.theme--catppuccin-mocha .control.has-icons-left .icon.is-left{left:0}html.theme--catppuccin-mocha .control.has-icons-right .input,html.theme--catppuccin-mocha .control.has-icons-right #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha #documenter .docs-sidebar .control.has-icons-right form.docs-search>input,html.theme--catppuccin-mocha .control.has-icons-right .select select{padding-right:2.5em}html.theme--catppuccin-mocha .control.has-icons-right .icon.is-right{right:0}html.theme--catppuccin-mocha .control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}html.theme--catppuccin-mocha .control.is-loading.is-small:after,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--catppuccin-mocha .control.is-loading.is-medium:after{font-size:1.25rem}html.theme--catppuccin-mocha .control.is-loading.is-large:after{font-size:1.5rem}html.theme--catppuccin-mocha .breadcrumb{font-size:1rem;white-space:nowrap}html.theme--catppuccin-mocha .breadcrumb a{align-items:center;color:#89b4fa;display:flex;justify-content:center;padding:0 .75em}html.theme--catppuccin-mocha .breadcrumb a:hover{color:#89dceb}html.theme--catppuccin-mocha .breadcrumb li{align-items:center;display:flex}html.theme--catppuccin-mocha .breadcrumb li:first-child a{padding-left:0}html.theme--catppuccin-mocha .breadcrumb li.is-active a{color:#b8c5ef;cursor:default;pointer-events:none}html.theme--catppuccin-mocha .breadcrumb li+li::before{color:#6c7086;content:"\0002f"}html.theme--catppuccin-mocha .breadcrumb ul,html.theme--catppuccin-mocha .breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--catppuccin-mocha .breadcrumb .icon:first-child{margin-right:.5em}html.theme--catppuccin-mocha .breadcrumb .icon:last-child{margin-left:.5em}html.theme--catppuccin-mocha .breadcrumb.is-centered ol,html.theme--catppuccin-mocha .breadcrumb.is-centered ul{justify-content:center}html.theme--catppuccin-mocha .breadcrumb.is-right ol,html.theme--catppuccin-mocha .breadcrumb.is-right ul{justify-content:flex-end}html.theme--catppuccin-mocha .breadcrumb.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}html.theme--catppuccin-mocha .breadcrumb.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .breadcrumb.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .breadcrumb.has-arrow-separator li+li::before{content:"\02192"}html.theme--catppuccin-mocha .breadcrumb.has-bullet-separator li+li::before{content:"\02022"}html.theme--catppuccin-mocha .breadcrumb.has-dot-separator li+li::before{content:"\000b7"}html.theme--catppuccin-mocha .breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}html.theme--catppuccin-mocha .card{background-color:#fff;border-radius:.25rem;box-shadow:#171717;color:#cdd6f4;max-width:100%;position:relative}html.theme--catppuccin-mocha .card-footer:first-child,html.theme--catppuccin-mocha .card-content:first-child,html.theme--catppuccin-mocha .card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-mocha .card-footer:last-child,html.theme--catppuccin-mocha .card-content:last-child,html.theme--catppuccin-mocha .card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-mocha .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}html.theme--catppuccin-mocha .card-header-title{align-items:center;color:#b8c5ef;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}html.theme--catppuccin-mocha .card-header-title.is-centered{justify-content:center}html.theme--catppuccin-mocha .card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}html.theme--catppuccin-mocha .card-image{display:block;position:relative}html.theme--catppuccin-mocha .card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--catppuccin-mocha .card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--catppuccin-mocha .card-content{background-color:rgba(0,0,0,0);padding:1.5rem}html.theme--catppuccin-mocha .card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}html.theme--catppuccin-mocha .card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}html.theme--catppuccin-mocha .card-footer-item:not(:last-child){border-right:1px solid #ededed}html.theme--catppuccin-mocha .card .media:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-mocha .dropdown{display:inline-flex;position:relative;vertical-align:top}html.theme--catppuccin-mocha .dropdown.is-active .dropdown-menu,html.theme--catppuccin-mocha .dropdown.is-hoverable:hover .dropdown-menu{display:block}html.theme--catppuccin-mocha .dropdown.is-right .dropdown-menu{left:auto;right:0}html.theme--catppuccin-mocha .dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}html.theme--catppuccin-mocha .dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}html.theme--catppuccin-mocha .dropdown-content{background-color:#181825;border-radius:.4em;box-shadow:#171717;padding-bottom:.5rem;padding-top:.5rem}html.theme--catppuccin-mocha .dropdown-item{color:#cdd6f4;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}html.theme--catppuccin-mocha a.dropdown-item,html.theme--catppuccin-mocha button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}html.theme--catppuccin-mocha a.dropdown-item:hover,html.theme--catppuccin-mocha button.dropdown-item:hover{background-color:#181825;color:#0a0a0a}html.theme--catppuccin-mocha a.dropdown-item.is-active,html.theme--catppuccin-mocha button.dropdown-item.is-active{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}html.theme--catppuccin-mocha .level{align-items:center;justify-content:space-between}html.theme--catppuccin-mocha .level code{border-radius:.4em}html.theme--catppuccin-mocha .level img{display:inline-block;vertical-align:top}html.theme--catppuccin-mocha .level.is-mobile{display:flex}html.theme--catppuccin-mocha .level.is-mobile .level-left,html.theme--catppuccin-mocha .level.is-mobile .level-right{display:flex}html.theme--catppuccin-mocha .level.is-mobile .level-left+.level-right{margin-top:0}html.theme--catppuccin-mocha .level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--catppuccin-mocha .level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .level{display:flex}html.theme--catppuccin-mocha .level>.level-item:not(.is-narrow){flex-grow:1}}html.theme--catppuccin-mocha .level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}html.theme--catppuccin-mocha .level-item .title,html.theme--catppuccin-mocha .level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .level-item:not(:last-child){margin-bottom:.75rem}}html.theme--catppuccin-mocha .level-left,html.theme--catppuccin-mocha .level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-mocha .level-left .level-item.is-flexible,html.theme--catppuccin-mocha .level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .level-left .level-item:not(:last-child),html.theme--catppuccin-mocha .level-right .level-item:not(:last-child){margin-right:.75rem}}html.theme--catppuccin-mocha .level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .level-left{display:flex}}html.theme--catppuccin-mocha .level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .level-right{display:flex}}html.theme--catppuccin-mocha .media{align-items:flex-start;display:flex;text-align:inherit}html.theme--catppuccin-mocha .media .content:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-mocha .media .media{border-top:1px solid rgba(88,91,112,0.5);display:flex;padding-top:.75rem}html.theme--catppuccin-mocha .media .media .content:not(:last-child),html.theme--catppuccin-mocha .media .media .control:not(:last-child){margin-bottom:.5rem}html.theme--catppuccin-mocha .media .media .media{padding-top:.5rem}html.theme--catppuccin-mocha .media .media .media+.media{margin-top:.5rem}html.theme--catppuccin-mocha .media+.media{border-top:1px solid rgba(88,91,112,0.5);margin-top:1rem;padding-top:1rem}html.theme--catppuccin-mocha .media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}html.theme--catppuccin-mocha .media-left,html.theme--catppuccin-mocha .media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--catppuccin-mocha .media-left{margin-right:1rem}html.theme--catppuccin-mocha .media-right{margin-left:1rem}html.theme--catppuccin-mocha .media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .media-content{overflow-x:auto}}html.theme--catppuccin-mocha .menu{font-size:1rem}html.theme--catppuccin-mocha .menu.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}html.theme--catppuccin-mocha .menu.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .menu.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .menu-list{line-height:1.25}html.theme--catppuccin-mocha .menu-list a{border-radius:3px;color:#cdd6f4;display:block;padding:0.5em 0.75em}html.theme--catppuccin-mocha .menu-list a:hover{background-color:#181825;color:#b8c5ef}html.theme--catppuccin-mocha .menu-list a.is-active{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .menu-list li ul{border-left:1px solid #585b70;margin:.75em;padding-left:.75em}html.theme--catppuccin-mocha .menu-label{color:#f7f8fd;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}html.theme--catppuccin-mocha .menu-label:not(:first-child){margin-top:1em}html.theme--catppuccin-mocha .menu-label:not(:last-child){margin-bottom:1em}html.theme--catppuccin-mocha .message{background-color:#181825;border-radius:.4em;font-size:1rem}html.theme--catppuccin-mocha .message strong{color:currentColor}html.theme--catppuccin-mocha .message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--catppuccin-mocha .message.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}html.theme--catppuccin-mocha .message.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .message.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .message.is-white{background-color:#fff}html.theme--catppuccin-mocha .message.is-white .message-header{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .message.is-white .message-body{border-color:#fff}html.theme--catppuccin-mocha .message.is-black{background-color:#fafafa}html.theme--catppuccin-mocha .message.is-black .message-header{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .message.is-black .message-body{border-color:#0a0a0a}html.theme--catppuccin-mocha .message.is-light{background-color:#fafafa}html.theme--catppuccin-mocha .message.is-light .message-header{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .message.is-light .message-body{border-color:#f5f5f5}html.theme--catppuccin-mocha .message.is-dark,html.theme--catppuccin-mocha .content kbd.message{background-color:#f9f9fb}html.theme--catppuccin-mocha .message.is-dark .message-header,html.theme--catppuccin-mocha .content kbd.message .message-header{background-color:#313244;color:#fff}html.theme--catppuccin-mocha .message.is-dark .message-body,html.theme--catppuccin-mocha .content kbd.message .message-body{border-color:#313244}html.theme--catppuccin-mocha .message.is-primary,html.theme--catppuccin-mocha .docstring>section>a.message.docs-sourcelink{background-color:#ebf3fe}html.theme--catppuccin-mocha .message.is-primary .message-header,html.theme--catppuccin-mocha .docstring>section>a.message.docs-sourcelink .message-header{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .message.is-primary .message-body,html.theme--catppuccin-mocha .docstring>section>a.message.docs-sourcelink .message-body{border-color:#89b4fa;color:#063c93}html.theme--catppuccin-mocha .message.is-link{background-color:#ebf3fe}html.theme--catppuccin-mocha .message.is-link .message-header{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .message.is-link .message-body{border-color:#89b4fa;color:#063c93}html.theme--catppuccin-mocha .message.is-info{background-color:#effbf9}html.theme--catppuccin-mocha .message.is-info .message-header{background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .message.is-info .message-body{border-color:#94e2d5;color:#207466}html.theme--catppuccin-mocha .message.is-success{background-color:#f0faef}html.theme--catppuccin-mocha .message.is-success .message-header{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .message.is-success .message-body{border-color:#a6e3a1;color:#287222}html.theme--catppuccin-mocha .message.is-warning{background-color:#fef8ec}html.theme--catppuccin-mocha .message.is-warning .message-header{background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .message.is-warning .message-body{border-color:#f9e2af;color:#8a620a}html.theme--catppuccin-mocha .message.is-danger{background-color:#fdedf1}html.theme--catppuccin-mocha .message.is-danger .message-header{background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .message.is-danger .message-body{border-color:#f38ba8;color:#991036}html.theme--catppuccin-mocha .message-header{align-items:center;background-color:#cdd6f4;border-radius:.4em .4em 0 0;color:rgba(0,0,0,0.7);display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}html.theme--catppuccin-mocha .message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}html.theme--catppuccin-mocha .message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}html.theme--catppuccin-mocha .message-body{border-color:#585b70;border-radius:.4em;border-style:solid;border-width:0 0 0 4px;color:#cdd6f4;padding:1.25em 1.5em}html.theme--catppuccin-mocha .message-body code,html.theme--catppuccin-mocha .message-body pre{background-color:#fff}html.theme--catppuccin-mocha .message-body pre code{background-color:rgba(0,0,0,0)}html.theme--catppuccin-mocha .modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}html.theme--catppuccin-mocha .modal.is-active{display:flex}html.theme--catppuccin-mocha .modal-background{background-color:rgba(10,10,10,0.86)}html.theme--catppuccin-mocha .modal-content,html.theme--catppuccin-mocha .modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){html.theme--catppuccin-mocha .modal-content,html.theme--catppuccin-mocha .modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}html.theme--catppuccin-mocha .modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}html.theme--catppuccin-mocha .modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}html.theme--catppuccin-mocha .modal-card-head,html.theme--catppuccin-mocha .modal-card-foot{align-items:center;background-color:#181825;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}html.theme--catppuccin-mocha .modal-card-head{border-bottom:1px solid #585b70;border-top-left-radius:8px;border-top-right-radius:8px}html.theme--catppuccin-mocha .modal-card-title{color:#cdd6f4;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}html.theme--catppuccin-mocha .modal-card-foot{border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid #585b70}html.theme--catppuccin-mocha .modal-card-foot .button:not(:last-child){margin-right:.5em}html.theme--catppuccin-mocha .modal-card-body{-webkit-overflow-scrolling:touch;background-color:#1e1e2e;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}html.theme--catppuccin-mocha .navbar{background-color:#89b4fa;min-height:4rem;position:relative;z-index:30}html.theme--catppuccin-mocha .navbar.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-white .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-white .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-white .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-white .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-white .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-white .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-white .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-mocha .navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}html.theme--catppuccin-mocha .navbar.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-black .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-black .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-black .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-black .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-black .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-black .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-black .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-black .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}html.theme--catppuccin-mocha .navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}html.theme--catppuccin-mocha .navbar.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-light .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-light .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-light .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-light .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-light .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-light .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-light .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-light .navbar-end .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-mocha .navbar.is-dark,html.theme--catppuccin-mocha .content kbd.navbar{background-color:#313244;color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand .navbar-link.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#262735;color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-brand .navbar-link::after,html.theme--catppuccin-mocha .content kbd.navbar .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-burger,html.theme--catppuccin-mocha .content kbd.navbar .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-dark .navbar-start>.navbar-item,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end>.navbar-item,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end .navbar-link.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#262735;color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .content kbd.navbar .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-dark .navbar-end .navbar-link::after,html.theme--catppuccin-mocha .content kbd.navbar .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-mocha .content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#262735;color:#fff}html.theme--catppuccin-mocha .navbar.is-dark .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-mocha .content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#313244;color:#fff}}html.theme--catppuccin-mocha .navbar.is-primary,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand .navbar-link.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-brand .navbar-link::after,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-burger,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-primary .navbar-start>.navbar-item,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end>.navbar-item,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end .navbar-link.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-primary .navbar-end .navbar-link::after,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#89b4fa;color:#fff}}html.theme--catppuccin-mocha .navbar.is-link{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-link .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-link .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-link .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-link .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-link .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-link .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-link .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-link .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-link .navbar-end .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#89b4fa;color:#fff}}html.theme--catppuccin-mocha .navbar.is-info{background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#80ddcd;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-info .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-info .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-info .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-info .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-info .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-info .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-info .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-info .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-info .navbar-end .navbar-link.is-active{background-color:#80ddcd;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-info .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#80ddcd;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#94e2d5;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-mocha .navbar.is-success{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#93dd8d;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-success .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-success .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-success .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-success .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-success .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-success .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-success .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-success .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-success .navbar-end .navbar-link.is-active{background-color:#93dd8d;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-success .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#93dd8d;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-mocha .navbar.is-warning{background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#f7d997;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-warning .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#f7d997;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-warning .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f7d997;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#f9e2af;color:rgba(0,0,0,0.7)}}html.theme--catppuccin-mocha .navbar.is-danger{background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand>.navbar-item,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#f17497;color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar.is-danger .navbar-start>.navbar-item,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start .navbar-link,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end>.navbar-item,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end .navbar-link{color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-start>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-start .navbar-link.is-active,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end>a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end>a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end>a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#f17497;color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-start .navbar-link::after,html.theme--catppuccin-mocha .navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f17497;color:#fff}html.theme--catppuccin-mocha .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#f38ba8;color:#fff}}html.theme--catppuccin-mocha .navbar>.container{align-items:stretch;display:flex;min-height:4rem;width:100%}html.theme--catppuccin-mocha .navbar.has-shadow{box-shadow:0 2px 0 0 #181825}html.theme--catppuccin-mocha .navbar.is-fixed-bottom,html.theme--catppuccin-mocha .navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-mocha .navbar.is-fixed-bottom{bottom:0}html.theme--catppuccin-mocha .navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #181825}html.theme--catppuccin-mocha .navbar.is-fixed-top{top:0}html.theme--catppuccin-mocha html.has-navbar-fixed-top,html.theme--catppuccin-mocha body.has-navbar-fixed-top{padding-top:4rem}html.theme--catppuccin-mocha html.has-navbar-fixed-bottom,html.theme--catppuccin-mocha body.has-navbar-fixed-bottom{padding-bottom:4rem}html.theme--catppuccin-mocha .navbar-brand,html.theme--catppuccin-mocha .navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:4rem}html.theme--catppuccin-mocha .navbar-brand a.navbar-item:focus,html.theme--catppuccin-mocha .navbar-brand a.navbar-item:hover{background-color:transparent}html.theme--catppuccin-mocha .navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}html.theme--catppuccin-mocha .navbar-burger{color:#cdd6f4;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:4rem;position:relative;width:4rem;margin-left:auto}html.theme--catppuccin-mocha .navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}html.theme--catppuccin-mocha .navbar-burger span:nth-child(1){top:calc(50% - 6px)}html.theme--catppuccin-mocha .navbar-burger span:nth-child(2){top:calc(50% - 1px)}html.theme--catppuccin-mocha .navbar-burger span:nth-child(3){top:calc(50% + 4px)}html.theme--catppuccin-mocha .navbar-burger:hover{background-color:rgba(0,0,0,0.05)}html.theme--catppuccin-mocha .navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}html.theme--catppuccin-mocha .navbar-burger.is-active span:nth-child(2){opacity:0}html.theme--catppuccin-mocha .navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}html.theme--catppuccin-mocha .navbar-menu{display:none}html.theme--catppuccin-mocha .navbar-item,html.theme--catppuccin-mocha .navbar-link{color:#cdd6f4;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}html.theme--catppuccin-mocha .navbar-item .icon:only-child,html.theme--catppuccin-mocha .navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}html.theme--catppuccin-mocha a.navbar-item,html.theme--catppuccin-mocha .navbar-link{cursor:pointer}html.theme--catppuccin-mocha a.navbar-item:focus,html.theme--catppuccin-mocha a.navbar-item:focus-within,html.theme--catppuccin-mocha a.navbar-item:hover,html.theme--catppuccin-mocha a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar-link:focus,html.theme--catppuccin-mocha .navbar-link:focus-within,html.theme--catppuccin-mocha .navbar-link:hover,html.theme--catppuccin-mocha .navbar-link.is-active{background-color:rgba(0,0,0,0);color:#89b4fa}html.theme--catppuccin-mocha .navbar-item{flex-grow:0;flex-shrink:0}html.theme--catppuccin-mocha .navbar-item img{max-height:1.75rem}html.theme--catppuccin-mocha .navbar-item.has-dropdown{padding:0}html.theme--catppuccin-mocha .navbar-item.is-expanded{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .navbar-item.is-tab{border-bottom:1px solid transparent;min-height:4rem;padding-bottom:calc(0.5rem - 1px)}html.theme--catppuccin-mocha .navbar-item.is-tab:focus,html.theme--catppuccin-mocha .navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#89b4fa}html.theme--catppuccin-mocha .navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#89b4fa;border-bottom-style:solid;border-bottom-width:3px;color:#89b4fa;padding-bottom:calc(0.5rem - 3px)}html.theme--catppuccin-mocha .navbar-content{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .navbar-link:not(.is-arrowless){padding-right:2.5em}html.theme--catppuccin-mocha .navbar-link:not(.is-arrowless)::after{border-color:#fff;margin-top:-0.375em;right:1.125em}html.theme--catppuccin-mocha .navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}html.theme--catppuccin-mocha .navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}html.theme--catppuccin-mocha .navbar-divider{background-color:rgba(0,0,0,0.2);border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .navbar>.container{display:block}html.theme--catppuccin-mocha .navbar-brand .navbar-item,html.theme--catppuccin-mocha .navbar-tabs .navbar-item{align-items:center;display:flex}html.theme--catppuccin-mocha .navbar-link::after{display:none}html.theme--catppuccin-mocha .navbar-menu{background-color:#89b4fa;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}html.theme--catppuccin-mocha .navbar-menu.is-active{display:block}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-touch,html.theme--catppuccin-mocha .navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-touch{bottom:0}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .navbar.is-fixed-top-touch{top:0}html.theme--catppuccin-mocha .navbar.is-fixed-top .navbar-menu,html.theme--catppuccin-mocha .navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 4rem);overflow:auto}html.theme--catppuccin-mocha html.has-navbar-fixed-top-touch,html.theme--catppuccin-mocha body.has-navbar-fixed-top-touch{padding-top:4rem}html.theme--catppuccin-mocha html.has-navbar-fixed-bottom-touch,html.theme--catppuccin-mocha body.has-navbar-fixed-bottom-touch{padding-bottom:4rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .navbar,html.theme--catppuccin-mocha .navbar-menu,html.theme--catppuccin-mocha .navbar-start,html.theme--catppuccin-mocha .navbar-end{align-items:stretch;display:flex}html.theme--catppuccin-mocha .navbar{min-height:4rem}html.theme--catppuccin-mocha .navbar.is-spaced{padding:1rem 2rem}html.theme--catppuccin-mocha .navbar.is-spaced .navbar-start,html.theme--catppuccin-mocha .navbar.is-spaced .navbar-end{align-items:center}html.theme--catppuccin-mocha .navbar.is-spaced a.navbar-item,html.theme--catppuccin-mocha .navbar.is-spaced .navbar-link{border-radius:.4em}html.theme--catppuccin-mocha .navbar.is-transparent a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-transparent a.navbar-item:hover,html.theme--catppuccin-mocha .navbar.is-transparent a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-link:focus,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-link:hover,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}html.theme--catppuccin-mocha .navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}html.theme--catppuccin-mocha .navbar.is-transparent .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-mocha .navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#7f849c}html.theme--catppuccin-mocha .navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#89b4fa}html.theme--catppuccin-mocha .navbar-burger{display:none}html.theme--catppuccin-mocha .navbar-item,html.theme--catppuccin-mocha .navbar-link{align-items:center;display:flex}html.theme--catppuccin-mocha .navbar-item.has-dropdown{align-items:stretch}html.theme--catppuccin-mocha .navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}html.theme--catppuccin-mocha .navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:1px solid rgba(0,0,0,0.2);border-radius:8px 8px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}html.theme--catppuccin-mocha .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced html.theme--catppuccin-mocha .navbar-item.is-active .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--catppuccin-mocha .navbar-item.is-hoverable:hover .navbar-dropdown,html.theme--catppuccin-mocha .navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}html.theme--catppuccin-mocha .navbar-menu{flex-grow:1;flex-shrink:0}html.theme--catppuccin-mocha .navbar-start{justify-content:flex-start;margin-right:auto}html.theme--catppuccin-mocha .navbar-end{justify-content:flex-end;margin-left:auto}html.theme--catppuccin-mocha .navbar-dropdown{background-color:#89b4fa;border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid rgba(0,0,0,0.2);box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}html.theme--catppuccin-mocha .navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}html.theme--catppuccin-mocha .navbar-dropdown a.navbar-item{padding-right:3rem}html.theme--catppuccin-mocha .navbar-dropdown a.navbar-item:focus,html.theme--catppuccin-mocha .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#7f849c}html.theme--catppuccin-mocha .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#89b4fa}.navbar.is-spaced html.theme--catppuccin-mocha .navbar-dropdown,html.theme--catppuccin-mocha .navbar-dropdown.is-boxed{border-radius:8px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}html.theme--catppuccin-mocha .navbar-dropdown.is-right{left:auto;right:0}html.theme--catppuccin-mocha .navbar-divider{display:block}html.theme--catppuccin-mocha .navbar>.container .navbar-brand,html.theme--catppuccin-mocha .container>.navbar .navbar-brand{margin-left:-.75rem}html.theme--catppuccin-mocha .navbar>.container .navbar-menu,html.theme--catppuccin-mocha .container>.navbar .navbar-menu{margin-right:-.75rem}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-desktop,html.theme--catppuccin-mocha .navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-desktop{bottom:0}html.theme--catppuccin-mocha .navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .navbar.is-fixed-top-desktop{top:0}html.theme--catppuccin-mocha html.has-navbar-fixed-top-desktop,html.theme--catppuccin-mocha body.has-navbar-fixed-top-desktop{padding-top:4rem}html.theme--catppuccin-mocha html.has-navbar-fixed-bottom-desktop,html.theme--catppuccin-mocha body.has-navbar-fixed-bottom-desktop{padding-bottom:4rem}html.theme--catppuccin-mocha html.has-spaced-navbar-fixed-top,html.theme--catppuccin-mocha body.has-spaced-navbar-fixed-top{padding-top:6rem}html.theme--catppuccin-mocha html.has-spaced-navbar-fixed-bottom,html.theme--catppuccin-mocha body.has-spaced-navbar-fixed-bottom{padding-bottom:6rem}html.theme--catppuccin-mocha a.navbar-item.is-active,html.theme--catppuccin-mocha .navbar-link.is-active{color:#89b4fa}html.theme--catppuccin-mocha a.navbar-item.is-active:not(:focus):not(:hover),html.theme--catppuccin-mocha .navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}html.theme--catppuccin-mocha .navbar-item.has-dropdown:focus .navbar-link,html.theme--catppuccin-mocha .navbar-item.has-dropdown:hover .navbar-link,html.theme--catppuccin-mocha .navbar-item.has-dropdown.is-active .navbar-link{background-color:rgba(0,0,0,0)}}html.theme--catppuccin-mocha .hero.is-fullheight-with-navbar{min-height:calc(100vh - 4rem)}html.theme--catppuccin-mocha .pagination{font-size:1rem;margin:-.25rem}html.theme--catppuccin-mocha .pagination.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}html.theme--catppuccin-mocha .pagination.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .pagination.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .pagination.is-rounded .pagination-previous,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,html.theme--catppuccin-mocha .pagination.is-rounded .pagination-next,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}html.theme--catppuccin-mocha .pagination.is-rounded .pagination-link,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}html.theme--catppuccin-mocha .pagination,html.theme--catppuccin-mocha .pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha .pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-link{border-color:#585b70;color:#89b4fa;min-width:2.5em}html.theme--catppuccin-mocha .pagination-previous:hover,html.theme--catppuccin-mocha .pagination-next:hover,html.theme--catppuccin-mocha .pagination-link:hover{border-color:#6c7086;color:#89dceb}html.theme--catppuccin-mocha .pagination-previous:focus,html.theme--catppuccin-mocha .pagination-next:focus,html.theme--catppuccin-mocha .pagination-link:focus{border-color:#6c7086}html.theme--catppuccin-mocha .pagination-previous:active,html.theme--catppuccin-mocha .pagination-next:active,html.theme--catppuccin-mocha .pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}html.theme--catppuccin-mocha .pagination-previous[disabled],html.theme--catppuccin-mocha .pagination-previous.is-disabled,html.theme--catppuccin-mocha .pagination-next[disabled],html.theme--catppuccin-mocha .pagination-next.is-disabled,html.theme--catppuccin-mocha .pagination-link[disabled],html.theme--catppuccin-mocha .pagination-link.is-disabled{background-color:#585b70;border-color:#585b70;box-shadow:none;color:#f7f8fd;opacity:0.5}html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}html.theme--catppuccin-mocha .pagination-link.is-current{background-color:#89b4fa;border-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .pagination-ellipsis{color:#6c7086;pointer-events:none}html.theme--catppuccin-mocha .pagination-list{flex-wrap:wrap}html.theme--catppuccin-mocha .pagination-list li{list-style:none}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .pagination{flex-wrap:wrap}html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha .pagination-ellipsis{margin-bottom:0;margin-top:0}html.theme--catppuccin-mocha .pagination-previous{order:2}html.theme--catppuccin-mocha .pagination-next{order:3}html.theme--catppuccin-mocha .pagination{justify-content:space-between;margin-bottom:0;margin-top:0}html.theme--catppuccin-mocha .pagination.is-centered .pagination-previous{order:1}html.theme--catppuccin-mocha .pagination.is-centered .pagination-list{justify-content:center;order:2}html.theme--catppuccin-mocha .pagination.is-centered .pagination-next{order:3}html.theme--catppuccin-mocha .pagination.is-right .pagination-previous{order:1}html.theme--catppuccin-mocha .pagination.is-right .pagination-next{order:2}html.theme--catppuccin-mocha .pagination.is-right .pagination-list{justify-content:flex-end;order:3}}html.theme--catppuccin-mocha .panel{border-radius:8px;box-shadow:#171717;font-size:1rem}html.theme--catppuccin-mocha .panel:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-mocha .panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}html.theme--catppuccin-mocha .panel.is-white .panel-block.is-active .panel-icon{color:#fff}html.theme--catppuccin-mocha .panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}html.theme--catppuccin-mocha .panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}html.theme--catppuccin-mocha .panel.is-light .panel-heading{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .panel.is-light .panel-tabs a.is-active{border-bottom-color:#f5f5f5}html.theme--catppuccin-mocha .panel.is-light .panel-block.is-active .panel-icon{color:#f5f5f5}html.theme--catppuccin-mocha .panel.is-dark .panel-heading,html.theme--catppuccin-mocha .content kbd.panel .panel-heading{background-color:#313244;color:#fff}html.theme--catppuccin-mocha .panel.is-dark .panel-tabs a.is-active,html.theme--catppuccin-mocha .content kbd.panel .panel-tabs a.is-active{border-bottom-color:#313244}html.theme--catppuccin-mocha .panel.is-dark .panel-block.is-active .panel-icon,html.theme--catppuccin-mocha .content kbd.panel .panel-block.is-active .panel-icon{color:#313244}html.theme--catppuccin-mocha .panel.is-primary .panel-heading,html.theme--catppuccin-mocha .docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .panel.is-primary .panel-tabs a.is-active,html.theme--catppuccin-mocha .docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#89b4fa}html.theme--catppuccin-mocha .panel.is-primary .panel-block.is-active .panel-icon,html.theme--catppuccin-mocha .docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#89b4fa}html.theme--catppuccin-mocha .panel.is-link .panel-heading{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .panel.is-link .panel-tabs a.is-active{border-bottom-color:#89b4fa}html.theme--catppuccin-mocha .panel.is-link .panel-block.is-active .panel-icon{color:#89b4fa}html.theme--catppuccin-mocha .panel.is-info .panel-heading{background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .panel.is-info .panel-tabs a.is-active{border-bottom-color:#94e2d5}html.theme--catppuccin-mocha .panel.is-info .panel-block.is-active .panel-icon{color:#94e2d5}html.theme--catppuccin-mocha .panel.is-success .panel-heading{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .panel.is-success .panel-tabs a.is-active{border-bottom-color:#a6e3a1}html.theme--catppuccin-mocha .panel.is-success .panel-block.is-active .panel-icon{color:#a6e3a1}html.theme--catppuccin-mocha .panel.is-warning .panel-heading{background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .panel.is-warning .panel-tabs a.is-active{border-bottom-color:#f9e2af}html.theme--catppuccin-mocha .panel.is-warning .panel-block.is-active .panel-icon{color:#f9e2af}html.theme--catppuccin-mocha .panel.is-danger .panel-heading{background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .panel.is-danger .panel-tabs a.is-active{border-bottom-color:#f38ba8}html.theme--catppuccin-mocha .panel.is-danger .panel-block.is-active .panel-icon{color:#f38ba8}html.theme--catppuccin-mocha .panel-tabs:not(:last-child),html.theme--catppuccin-mocha .panel-block:not(:last-child){border-bottom:1px solid #ededed}html.theme--catppuccin-mocha .panel-heading{background-color:#45475a;border-radius:8px 8px 0 0;color:#b8c5ef;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}html.theme--catppuccin-mocha .panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}html.theme--catppuccin-mocha .panel-tabs a{border-bottom:1px solid #585b70;margin-bottom:-1px;padding:0.5em}html.theme--catppuccin-mocha .panel-tabs a.is-active{border-bottom-color:#45475a;color:#71a4f9}html.theme--catppuccin-mocha .panel-list a{color:#cdd6f4}html.theme--catppuccin-mocha .panel-list a:hover{color:#89b4fa}html.theme--catppuccin-mocha .panel-block{align-items:center;color:#b8c5ef;display:flex;justify-content:flex-start;padding:0.5em 0.75em}html.theme--catppuccin-mocha .panel-block input[type="checkbox"]{margin-right:.75em}html.theme--catppuccin-mocha .panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}html.theme--catppuccin-mocha .panel-block.is-wrapped{flex-wrap:wrap}html.theme--catppuccin-mocha .panel-block.is-active{border-left-color:#89b4fa;color:#71a4f9}html.theme--catppuccin-mocha .panel-block.is-active .panel-icon{color:#89b4fa}html.theme--catppuccin-mocha .panel-block:last-child{border-bottom-left-radius:8px;border-bottom-right-radius:8px}html.theme--catppuccin-mocha a.panel-block,html.theme--catppuccin-mocha label.panel-block{cursor:pointer}html.theme--catppuccin-mocha a.panel-block:hover,html.theme--catppuccin-mocha label.panel-block:hover{background-color:#181825}html.theme--catppuccin-mocha .panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#f7f8fd;margin-right:.75em}html.theme--catppuccin-mocha .panel-icon .fa{font-size:inherit;line-height:inherit}html.theme--catppuccin-mocha .tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}html.theme--catppuccin-mocha .tabs a{align-items:center;border-bottom-color:#585b70;border-bottom-style:solid;border-bottom-width:1px;color:#cdd6f4;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}html.theme--catppuccin-mocha .tabs a:hover{border-bottom-color:#b8c5ef;color:#b8c5ef}html.theme--catppuccin-mocha .tabs li{display:block}html.theme--catppuccin-mocha .tabs li.is-active a{border-bottom-color:#89b4fa;color:#89b4fa}html.theme--catppuccin-mocha .tabs ul{align-items:center;border-bottom-color:#585b70;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}html.theme--catppuccin-mocha .tabs ul.is-left{padding-right:0.75em}html.theme--catppuccin-mocha .tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}html.theme--catppuccin-mocha .tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}html.theme--catppuccin-mocha .tabs .icon:first-child{margin-right:.5em}html.theme--catppuccin-mocha .tabs .icon:last-child{margin-left:.5em}html.theme--catppuccin-mocha .tabs.is-centered ul{justify-content:center}html.theme--catppuccin-mocha .tabs.is-right ul{justify-content:flex-end}html.theme--catppuccin-mocha .tabs.is-boxed a{border:1px solid transparent;border-radius:.4em .4em 0 0}html.theme--catppuccin-mocha .tabs.is-boxed a:hover{background-color:#181825;border-bottom-color:#585b70}html.theme--catppuccin-mocha .tabs.is-boxed li.is-active a{background-color:#fff;border-color:#585b70;border-bottom-color:rgba(0,0,0,0) !important}html.theme--catppuccin-mocha .tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}html.theme--catppuccin-mocha .tabs.is-toggle a{border-color:#585b70;border-style:solid;border-width:1px;margin-bottom:0;position:relative}html.theme--catppuccin-mocha .tabs.is-toggle a:hover{background-color:#181825;border-color:#6c7086;z-index:2}html.theme--catppuccin-mocha .tabs.is-toggle li+li{margin-left:-1px}html.theme--catppuccin-mocha .tabs.is-toggle li:first-child a{border-top-left-radius:.4em;border-bottom-left-radius:.4em}html.theme--catppuccin-mocha .tabs.is-toggle li:last-child a{border-top-right-radius:.4em;border-bottom-right-radius:.4em}html.theme--catppuccin-mocha .tabs.is-toggle li.is-active a{background-color:#89b4fa;border-color:#89b4fa;color:#fff;z-index:1}html.theme--catppuccin-mocha .tabs.is-toggle ul{border-bottom:none}html.theme--catppuccin-mocha .tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}html.theme--catppuccin-mocha .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}html.theme--catppuccin-mocha .tabs.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}html.theme--catppuccin-mocha .tabs.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .tabs.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-narrow{flex:none;width:unset}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-full{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-half{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-half{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-0{flex:none;width:0%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-0{margin-left:0%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-3{flex:none;width:25%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-3{margin-left:25%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-6{flex:none;width:50%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-6{margin-left:50%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-9{flex:none;width:75%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-9{margin-left:75%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-12{flex:none;width:100%}.columns.is-mobile>html.theme--catppuccin-mocha .column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .column.is-narrow-mobile{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full-mobile{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters-mobile{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds-mobile{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half-mobile{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third-mobile{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter-mobile{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth-mobile{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths-mobile{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths-mobile{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths-mobile{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters-mobile{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds-mobile{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half-mobile{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third-mobile{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter-mobile{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth-mobile{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths-mobile{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths-mobile{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths-mobile{margin-left:80%}html.theme--catppuccin-mocha .column.is-0-mobile{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0-mobile{margin-left:0%}html.theme--catppuccin-mocha .column.is-1-mobile{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1-mobile{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2-mobile{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2-mobile{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3-mobile{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3-mobile{margin-left:25%}html.theme--catppuccin-mocha .column.is-4-mobile{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4-mobile{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5-mobile{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5-mobile{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6-mobile{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6-mobile{margin-left:50%}html.theme--catppuccin-mocha .column.is-7-mobile{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7-mobile{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8-mobile{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8-mobile{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9-mobile{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9-mobile{margin-left:75%}html.theme--catppuccin-mocha .column.is-10-mobile{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10-mobile{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11-mobile{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11-mobile{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12-mobile{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .column.is-narrow,html.theme--catppuccin-mocha .column.is-narrow-tablet{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full,html.theme--catppuccin-mocha .column.is-full-tablet{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters,html.theme--catppuccin-mocha .column.is-three-quarters-tablet{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds,html.theme--catppuccin-mocha .column.is-two-thirds-tablet{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half,html.theme--catppuccin-mocha .column.is-half-tablet{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third,html.theme--catppuccin-mocha .column.is-one-third-tablet{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter,html.theme--catppuccin-mocha .column.is-one-quarter-tablet{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth,html.theme--catppuccin-mocha .column.is-one-fifth-tablet{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths,html.theme--catppuccin-mocha .column.is-two-fifths-tablet{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths,html.theme--catppuccin-mocha .column.is-three-fifths-tablet{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths,html.theme--catppuccin-mocha .column.is-four-fifths-tablet{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters,html.theme--catppuccin-mocha .column.is-offset-three-quarters-tablet{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds,html.theme--catppuccin-mocha .column.is-offset-two-thirds-tablet{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half,html.theme--catppuccin-mocha .column.is-offset-half-tablet{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third,html.theme--catppuccin-mocha .column.is-offset-one-third-tablet{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter,html.theme--catppuccin-mocha .column.is-offset-one-quarter-tablet{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth,html.theme--catppuccin-mocha .column.is-offset-one-fifth-tablet{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths,html.theme--catppuccin-mocha .column.is-offset-two-fifths-tablet{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths,html.theme--catppuccin-mocha .column.is-offset-three-fifths-tablet{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths,html.theme--catppuccin-mocha .column.is-offset-four-fifths-tablet{margin-left:80%}html.theme--catppuccin-mocha .column.is-0,html.theme--catppuccin-mocha .column.is-0-tablet{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0,html.theme--catppuccin-mocha .column.is-offset-0-tablet{margin-left:0%}html.theme--catppuccin-mocha .column.is-1,html.theme--catppuccin-mocha .column.is-1-tablet{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1,html.theme--catppuccin-mocha .column.is-offset-1-tablet{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2,html.theme--catppuccin-mocha .column.is-2-tablet{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2,html.theme--catppuccin-mocha .column.is-offset-2-tablet{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3,html.theme--catppuccin-mocha .column.is-3-tablet{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3,html.theme--catppuccin-mocha .column.is-offset-3-tablet{margin-left:25%}html.theme--catppuccin-mocha .column.is-4,html.theme--catppuccin-mocha .column.is-4-tablet{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4,html.theme--catppuccin-mocha .column.is-offset-4-tablet{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5,html.theme--catppuccin-mocha .column.is-5-tablet{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5,html.theme--catppuccin-mocha .column.is-offset-5-tablet{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6,html.theme--catppuccin-mocha .column.is-6-tablet{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6,html.theme--catppuccin-mocha .column.is-offset-6-tablet{margin-left:50%}html.theme--catppuccin-mocha .column.is-7,html.theme--catppuccin-mocha .column.is-7-tablet{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7,html.theme--catppuccin-mocha .column.is-offset-7-tablet{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8,html.theme--catppuccin-mocha .column.is-8-tablet{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8,html.theme--catppuccin-mocha .column.is-offset-8-tablet{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9,html.theme--catppuccin-mocha .column.is-9-tablet{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9,html.theme--catppuccin-mocha .column.is-offset-9-tablet{margin-left:75%}html.theme--catppuccin-mocha .column.is-10,html.theme--catppuccin-mocha .column.is-10-tablet{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10,html.theme--catppuccin-mocha .column.is-offset-10-tablet{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11,html.theme--catppuccin-mocha .column.is-11-tablet{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11,html.theme--catppuccin-mocha .column.is-offset-11-tablet{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12,html.theme--catppuccin-mocha .column.is-12-tablet{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12,html.theme--catppuccin-mocha .column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .column.is-narrow-touch{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full-touch{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters-touch{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds-touch{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half-touch{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third-touch{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter-touch{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth-touch{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths-touch{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths-touch{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths-touch{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters-touch{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds-touch{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half-touch{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third-touch{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter-touch{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth-touch{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths-touch{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths-touch{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths-touch{margin-left:80%}html.theme--catppuccin-mocha .column.is-0-touch{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0-touch{margin-left:0%}html.theme--catppuccin-mocha .column.is-1-touch{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1-touch{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2-touch{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2-touch{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3-touch{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3-touch{margin-left:25%}html.theme--catppuccin-mocha .column.is-4-touch{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4-touch{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5-touch{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5-touch{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6-touch{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6-touch{margin-left:50%}html.theme--catppuccin-mocha .column.is-7-touch{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7-touch{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8-touch{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8-touch{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9-touch{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9-touch{margin-left:75%}html.theme--catppuccin-mocha .column.is-10-touch{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10-touch{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11-touch{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11-touch{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12-touch{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .column.is-narrow-desktop{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full-desktop{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters-desktop{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds-desktop{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half-desktop{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third-desktop{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter-desktop{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth-desktop{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths-desktop{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths-desktop{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths-desktop{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters-desktop{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds-desktop{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half-desktop{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third-desktop{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter-desktop{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth-desktop{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths-desktop{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths-desktop{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths-desktop{margin-left:80%}html.theme--catppuccin-mocha .column.is-0-desktop{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0-desktop{margin-left:0%}html.theme--catppuccin-mocha .column.is-1-desktop{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1-desktop{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2-desktop{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2-desktop{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3-desktop{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3-desktop{margin-left:25%}html.theme--catppuccin-mocha .column.is-4-desktop{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4-desktop{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5-desktop{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5-desktop{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6-desktop{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6-desktop{margin-left:50%}html.theme--catppuccin-mocha .column.is-7-desktop{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7-desktop{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8-desktop{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8-desktop{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9-desktop{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9-desktop{margin-left:75%}html.theme--catppuccin-mocha .column.is-10-desktop{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10-desktop{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11-desktop{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11-desktop{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12-desktop{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .column.is-narrow-widescreen{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full-widescreen{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters-widescreen{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds-widescreen{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half-widescreen{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third-widescreen{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter-widescreen{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth-widescreen{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths-widescreen{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths-widescreen{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths-widescreen{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters-widescreen{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds-widescreen{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half-widescreen{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third-widescreen{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter-widescreen{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth-widescreen{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths-widescreen{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths-widescreen{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths-widescreen{margin-left:80%}html.theme--catppuccin-mocha .column.is-0-widescreen{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0-widescreen{margin-left:0%}html.theme--catppuccin-mocha .column.is-1-widescreen{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1-widescreen{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2-widescreen{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2-widescreen{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3-widescreen{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3-widescreen{margin-left:25%}html.theme--catppuccin-mocha .column.is-4-widescreen{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4-widescreen{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5-widescreen{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5-widescreen{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6-widescreen{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6-widescreen{margin-left:50%}html.theme--catppuccin-mocha .column.is-7-widescreen{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7-widescreen{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8-widescreen{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8-widescreen{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9-widescreen{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9-widescreen{margin-left:75%}html.theme--catppuccin-mocha .column.is-10-widescreen{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10-widescreen{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11-widescreen{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11-widescreen{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12-widescreen{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .column.is-narrow-fullhd{flex:none;width:unset}html.theme--catppuccin-mocha .column.is-full-fullhd{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-three-quarters-fullhd{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-two-thirds-fullhd{flex:none;width:66.6666%}html.theme--catppuccin-mocha .column.is-half-fullhd{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-one-third-fullhd{flex:none;width:33.3333%}html.theme--catppuccin-mocha .column.is-one-quarter-fullhd{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-one-fifth-fullhd{flex:none;width:20%}html.theme--catppuccin-mocha .column.is-two-fifths-fullhd{flex:none;width:40%}html.theme--catppuccin-mocha .column.is-three-fifths-fullhd{flex:none;width:60%}html.theme--catppuccin-mocha .column.is-four-fifths-fullhd{flex:none;width:80%}html.theme--catppuccin-mocha .column.is-offset-three-quarters-fullhd{margin-left:75%}html.theme--catppuccin-mocha .column.is-offset-two-thirds-fullhd{margin-left:66.6666%}html.theme--catppuccin-mocha .column.is-offset-half-fullhd{margin-left:50%}html.theme--catppuccin-mocha .column.is-offset-one-third-fullhd{margin-left:33.3333%}html.theme--catppuccin-mocha .column.is-offset-one-quarter-fullhd{margin-left:25%}html.theme--catppuccin-mocha .column.is-offset-one-fifth-fullhd{margin-left:20%}html.theme--catppuccin-mocha .column.is-offset-two-fifths-fullhd{margin-left:40%}html.theme--catppuccin-mocha .column.is-offset-three-fifths-fullhd{margin-left:60%}html.theme--catppuccin-mocha .column.is-offset-four-fifths-fullhd{margin-left:80%}html.theme--catppuccin-mocha .column.is-0-fullhd{flex:none;width:0%}html.theme--catppuccin-mocha .column.is-offset-0-fullhd{margin-left:0%}html.theme--catppuccin-mocha .column.is-1-fullhd{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .column.is-offset-1-fullhd{margin-left:8.33333337%}html.theme--catppuccin-mocha .column.is-2-fullhd{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .column.is-offset-2-fullhd{margin-left:16.66666674%}html.theme--catppuccin-mocha .column.is-3-fullhd{flex:none;width:25%}html.theme--catppuccin-mocha .column.is-offset-3-fullhd{margin-left:25%}html.theme--catppuccin-mocha .column.is-4-fullhd{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .column.is-offset-4-fullhd{margin-left:33.33333337%}html.theme--catppuccin-mocha .column.is-5-fullhd{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .column.is-offset-5-fullhd{margin-left:41.66666674%}html.theme--catppuccin-mocha .column.is-6-fullhd{flex:none;width:50%}html.theme--catppuccin-mocha .column.is-offset-6-fullhd{margin-left:50%}html.theme--catppuccin-mocha .column.is-7-fullhd{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .column.is-offset-7-fullhd{margin-left:58.33333337%}html.theme--catppuccin-mocha .column.is-8-fullhd{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .column.is-offset-8-fullhd{margin-left:66.66666674%}html.theme--catppuccin-mocha .column.is-9-fullhd{flex:none;width:75%}html.theme--catppuccin-mocha .column.is-offset-9-fullhd{margin-left:75%}html.theme--catppuccin-mocha .column.is-10-fullhd{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .column.is-offset-10-fullhd{margin-left:83.33333337%}html.theme--catppuccin-mocha .column.is-11-fullhd{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .column.is-offset-11-fullhd{margin-left:91.66666674%}html.theme--catppuccin-mocha .column.is-12-fullhd{flex:none;width:100%}html.theme--catppuccin-mocha .column.is-offset-12-fullhd{margin-left:100%}}html.theme--catppuccin-mocha .columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-mocha .columns:last-child{margin-bottom:-.75rem}html.theme--catppuccin-mocha .columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}html.theme--catppuccin-mocha .columns.is-centered{justify-content:center}html.theme--catppuccin-mocha .columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}html.theme--catppuccin-mocha .columns.is-gapless>.column{margin:0;padding:0 !important}html.theme--catppuccin-mocha .columns.is-gapless:not(:last-child){margin-bottom:1.5rem}html.theme--catppuccin-mocha .columns.is-gapless:last-child{margin-bottom:0}html.theme--catppuccin-mocha .columns.is-mobile{display:flex}html.theme--catppuccin-mocha .columns.is-multiline{flex-wrap:wrap}html.theme--catppuccin-mocha .columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-desktop{display:flex}}html.theme--catppuccin-mocha .columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}html.theme--catppuccin-mocha .columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}html.theme--catppuccin-mocha .columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-0-fullhd{--columnGap: 0rem}}html.theme--catppuccin-mocha .columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-1-fullhd{--columnGap: .25rem}}html.theme--catppuccin-mocha .columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-2-fullhd{--columnGap: .5rem}}html.theme--catppuccin-mocha .columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-3-fullhd{--columnGap: .75rem}}html.theme--catppuccin-mocha .columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-4-fullhd{--columnGap: 1rem}}html.theme--catppuccin-mocha .columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}html.theme--catppuccin-mocha .columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}html.theme--catppuccin-mocha .columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}html.theme--catppuccin-mocha .columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--catppuccin-mocha .columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){html.theme--catppuccin-mocha .columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--catppuccin-mocha .columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){html.theme--catppuccin-mocha .columns.is-variable.is-8-fullhd{--columnGap: 2rem}}html.theme--catppuccin-mocha .tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}html.theme--catppuccin-mocha .tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--catppuccin-mocha .tile.is-ancestor:last-child{margin-bottom:-.75rem}html.theme--catppuccin-mocha .tile.is-ancestor:not(:last-child){margin-bottom:.75rem}html.theme--catppuccin-mocha .tile.is-child{margin:0 !important}html.theme--catppuccin-mocha .tile.is-parent{padding:.75rem}html.theme--catppuccin-mocha .tile.is-vertical{flex-direction:column}html.theme--catppuccin-mocha .tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .tile:not(.is-child){display:flex}html.theme--catppuccin-mocha .tile.is-1{flex:none;width:8.33333337%}html.theme--catppuccin-mocha .tile.is-2{flex:none;width:16.66666674%}html.theme--catppuccin-mocha .tile.is-3{flex:none;width:25%}html.theme--catppuccin-mocha .tile.is-4{flex:none;width:33.33333337%}html.theme--catppuccin-mocha .tile.is-5{flex:none;width:41.66666674%}html.theme--catppuccin-mocha .tile.is-6{flex:none;width:50%}html.theme--catppuccin-mocha .tile.is-7{flex:none;width:58.33333337%}html.theme--catppuccin-mocha .tile.is-8{flex:none;width:66.66666674%}html.theme--catppuccin-mocha .tile.is-9{flex:none;width:75%}html.theme--catppuccin-mocha .tile.is-10{flex:none;width:83.33333337%}html.theme--catppuccin-mocha .tile.is-11{flex:none;width:91.66666674%}html.theme--catppuccin-mocha .tile.is-12{flex:none;width:100%}}html.theme--catppuccin-mocha .hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}html.theme--catppuccin-mocha .hero .navbar{background:none}html.theme--catppuccin-mocha .hero .tabs ul{border-bottom:none}html.theme--catppuccin-mocha .hero.is-white{background-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-white strong{color:inherit}html.theme--catppuccin-mocha .hero.is-white .title{color:#0a0a0a}html.theme--catppuccin-mocha .hero.is-white .subtitle{color:rgba(10,10,10,0.9)}html.theme--catppuccin-mocha .hero.is-white .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-white .navbar-menu{background-color:#fff}}html.theme--catppuccin-mocha .hero.is-white .navbar-item,html.theme--catppuccin-mocha .hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}html.theme--catppuccin-mocha .hero.is-white a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-white a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-white .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--catppuccin-mocha .hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}html.theme--catppuccin-mocha .hero.is-white .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}html.theme--catppuccin-mocha .hero.is-white .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-white .tabs.is-toggle a{color:#0a0a0a}html.theme--catppuccin-mocha .hero.is-white .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-white .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-white .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-white .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}html.theme--catppuccin-mocha .hero.is-black{background-color:#0a0a0a;color:#fff}html.theme--catppuccin-mocha .hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-black strong{color:inherit}html.theme--catppuccin-mocha .hero.is-black .title{color:#fff}html.theme--catppuccin-mocha .hero.is-black .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-mocha .hero.is-black .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-black .navbar-menu{background-color:#0a0a0a}}html.theme--catppuccin-mocha .hero.is-black .navbar-item,html.theme--catppuccin-mocha .hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-mocha .hero.is-black a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-black a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-black .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}html.theme--catppuccin-mocha .hero.is-black .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-mocha .hero.is-black .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}html.theme--catppuccin-mocha .hero.is-black .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-black .tabs.is-toggle a{color:#fff}html.theme--catppuccin-mocha .hero.is-black .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-black .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-black .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-black .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--catppuccin-mocha .hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}html.theme--catppuccin-mocha .hero.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-light strong{color:inherit}html.theme--catppuccin-mocha .hero.is-light .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-light .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-mocha .hero.is-light .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-light .navbar-menu{background-color:#f5f5f5}}html.theme--catppuccin-mocha .hero.is-light .navbar-item,html.theme--catppuccin-mocha .hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-light a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-light a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-light .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-light .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-mocha .hero.is-light .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-light .tabs li.is-active a{color:#f5f5f5 !important;opacity:1}html.theme--catppuccin-mocha .hero.is-light .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-light .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-light .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-light .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-light .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f5f5f5}html.theme--catppuccin-mocha .hero.is-light.is-bold{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}}html.theme--catppuccin-mocha .hero.is-dark,html.theme--catppuccin-mocha .content kbd.hero{background-color:#313244;color:#fff}html.theme--catppuccin-mocha .hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-dark strong,html.theme--catppuccin-mocha .content kbd.hero strong{color:inherit}html.theme--catppuccin-mocha .hero.is-dark .title,html.theme--catppuccin-mocha .content kbd.hero .title{color:#fff}html.theme--catppuccin-mocha .hero.is-dark .subtitle,html.theme--catppuccin-mocha .content kbd.hero .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-mocha .hero.is-dark .subtitle a:not(.button),html.theme--catppuccin-mocha .content kbd.hero .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-dark .subtitle strong,html.theme--catppuccin-mocha .content kbd.hero .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-dark .navbar-menu,html.theme--catppuccin-mocha .content kbd.hero .navbar-menu{background-color:#313244}}html.theme--catppuccin-mocha .hero.is-dark .navbar-item,html.theme--catppuccin-mocha .content kbd.hero .navbar-item,html.theme--catppuccin-mocha .hero.is-dark .navbar-link,html.theme--catppuccin-mocha .content kbd.hero .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-mocha .hero.is-dark a.navbar-item:hover,html.theme--catppuccin-mocha .content kbd.hero a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-dark a.navbar-item.is-active,html.theme--catppuccin-mocha .content kbd.hero a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-dark .navbar-link:hover,html.theme--catppuccin-mocha .content kbd.hero .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-dark .navbar-link.is-active,html.theme--catppuccin-mocha .content kbd.hero .navbar-link.is-active{background-color:#262735;color:#fff}html.theme--catppuccin-mocha .hero.is-dark .tabs a,html.theme--catppuccin-mocha .content kbd.hero .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-mocha .hero.is-dark .tabs a:hover,html.theme--catppuccin-mocha .content kbd.hero .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-dark .tabs li.is-active a,html.theme--catppuccin-mocha .content kbd.hero .tabs li.is-active a{color:#313244 !important;opacity:1}html.theme--catppuccin-mocha .hero.is-dark .tabs.is-boxed a,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-dark .tabs.is-toggle a,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-toggle a{color:#fff}html.theme--catppuccin-mocha .hero.is-dark .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-dark .tabs.is-toggle a:hover,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-dark .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-dark .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-dark .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .content kbd.hero .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#313244}html.theme--catppuccin-mocha .hero.is-dark.is-bold,html.theme--catppuccin-mocha .content kbd.hero.is-bold{background-image:linear-gradient(141deg, #181c2a 0%, #313244 71%, #3c3856 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-dark.is-bold .navbar-menu,html.theme--catppuccin-mocha .content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #181c2a 0%, #313244 71%, #3c3856 100%)}}html.theme--catppuccin-mocha .hero.is-primary,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-primary strong,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink strong{color:inherit}html.theme--catppuccin-mocha .hero.is-primary .title,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .title{color:#fff}html.theme--catppuccin-mocha .hero.is-primary .subtitle,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-mocha .hero.is-primary .subtitle a:not(.button),html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-primary .subtitle strong,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-primary .navbar-menu,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#89b4fa}}html.theme--catppuccin-mocha .hero.is-primary .navbar-item,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .navbar-item,html.theme--catppuccin-mocha .hero.is-primary .navbar-link,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-mocha .hero.is-primary a.navbar-item:hover,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-primary a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-primary .navbar-link:hover,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-primary .navbar-link.is-active,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .hero.is-primary .tabs a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-mocha .hero.is-primary .tabs a:hover,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-primary .tabs li.is-active a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#89b4fa !important;opacity:1}html.theme--catppuccin-mocha .hero.is-primary .tabs.is-boxed a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-primary .tabs.is-toggle a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}html.theme--catppuccin-mocha .hero.is-primary .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-primary .tabs.is-toggle a:hover,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-primary .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-primary .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-primary .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .hero.is-primary.is-bold,html.theme--catppuccin-mocha .docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #51b0ff 0%, #89b4fa 71%, #9fb3fd 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-primary.is-bold .navbar-menu,html.theme--catppuccin-mocha .docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #51b0ff 0%, #89b4fa 71%, #9fb3fd 100%)}}html.theme--catppuccin-mocha .hero.is-link{background-color:#89b4fa;color:#fff}html.theme--catppuccin-mocha .hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-link strong{color:inherit}html.theme--catppuccin-mocha .hero.is-link .title{color:#fff}html.theme--catppuccin-mocha .hero.is-link .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-mocha .hero.is-link .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-link .navbar-menu{background-color:#89b4fa}}html.theme--catppuccin-mocha .hero.is-link .navbar-item,html.theme--catppuccin-mocha .hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-mocha .hero.is-link a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-link a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-link .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-link .navbar-link.is-active{background-color:#71a4f9;color:#fff}html.theme--catppuccin-mocha .hero.is-link .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-mocha .hero.is-link .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-link .tabs li.is-active a{color:#89b4fa !important;opacity:1}html.theme--catppuccin-mocha .hero.is-link .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-link .tabs.is-toggle a{color:#fff}html.theme--catppuccin-mocha .hero.is-link .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-link .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-link .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-link .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#89b4fa}html.theme--catppuccin-mocha .hero.is-link.is-bold{background-image:linear-gradient(141deg, #51b0ff 0%, #89b4fa 71%, #9fb3fd 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #51b0ff 0%, #89b4fa 71%, #9fb3fd 100%)}}html.theme--catppuccin-mocha .hero.is-info{background-color:#94e2d5;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-info strong{color:inherit}html.theme--catppuccin-mocha .hero.is-info .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-info .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-mocha .hero.is-info .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-info .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-info .navbar-menu{background-color:#94e2d5}}html.theme--catppuccin-mocha .hero.is-info .navbar-item,html.theme--catppuccin-mocha .hero.is-info .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-info a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-info a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-info .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-info .navbar-link.is-active{background-color:#80ddcd;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-info .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-mocha .hero.is-info .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-info .tabs li.is-active a{color:#94e2d5 !important;opacity:1}html.theme--catppuccin-mocha .hero.is-info .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-info .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-info .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-info .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-info .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-info .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#94e2d5}html.theme--catppuccin-mocha .hero.is-info.is-bold{background-image:linear-gradient(141deg, #63e0b6 0%, #94e2d5 71%, #a5eaea 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #63e0b6 0%, #94e2d5 71%, #a5eaea 100%)}}html.theme--catppuccin-mocha .hero.is-success{background-color:#a6e3a1;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-success strong{color:inherit}html.theme--catppuccin-mocha .hero.is-success .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-success .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-mocha .hero.is-success .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-success .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-success .navbar-menu{background-color:#a6e3a1}}html.theme--catppuccin-mocha .hero.is-success .navbar-item,html.theme--catppuccin-mocha .hero.is-success .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-success a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-success a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-success .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-success .navbar-link.is-active{background-color:#93dd8d;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-success .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-mocha .hero.is-success .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-success .tabs li.is-active a{color:#a6e3a1 !important;opacity:1}html.theme--catppuccin-mocha .hero.is-success .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-success .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-success .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-success .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-success .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-success .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#a6e3a1}html.theme--catppuccin-mocha .hero.is-success.is-bold{background-image:linear-gradient(141deg, #8ce071 0%, #a6e3a1 71%, #b2ebb7 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #8ce071 0%, #a6e3a1 71%, #b2ebb7 100%)}}html.theme--catppuccin-mocha .hero.is-warning{background-color:#f9e2af;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-warning strong{color:inherit}html.theme--catppuccin-mocha .hero.is-warning .title{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-warning .subtitle{color:rgba(0,0,0,0.9)}html.theme--catppuccin-mocha .hero.is-warning .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-warning .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-warning .navbar-menu{background-color:#f9e2af}}html.theme--catppuccin-mocha .hero.is-warning .navbar-item,html.theme--catppuccin-mocha .hero.is-warning .navbar-link{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-warning a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-warning a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-warning .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-warning .navbar-link.is-active{background-color:#f7d997;color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-warning .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--catppuccin-mocha .hero.is-warning .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-warning .tabs li.is-active a{color:#f9e2af !important;opacity:1}html.theme--catppuccin-mocha .hero.is-warning .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-warning .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--catppuccin-mocha .hero.is-warning .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-warning .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-warning .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-warning .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f9e2af}html.theme--catppuccin-mocha .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #fcbd79 0%, #f9e2af 71%, #fcf4c5 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #fcbd79 0%, #f9e2af 71%, #fcf4c5 100%)}}html.theme--catppuccin-mocha .hero.is-danger{background-color:#f38ba8;color:#fff}html.theme--catppuccin-mocha .hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--catppuccin-mocha .hero.is-danger strong{color:inherit}html.theme--catppuccin-mocha .hero.is-danger .title{color:#fff}html.theme--catppuccin-mocha .hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}html.theme--catppuccin-mocha .hero.is-danger .subtitle a:not(.button),html.theme--catppuccin-mocha .hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .hero.is-danger .navbar-menu{background-color:#f38ba8}}html.theme--catppuccin-mocha .hero.is-danger .navbar-item,html.theme--catppuccin-mocha .hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}html.theme--catppuccin-mocha .hero.is-danger a.navbar-item:hover,html.theme--catppuccin-mocha .hero.is-danger a.navbar-item.is-active,html.theme--catppuccin-mocha .hero.is-danger .navbar-link:hover,html.theme--catppuccin-mocha .hero.is-danger .navbar-link.is-active{background-color:#f17497;color:#fff}html.theme--catppuccin-mocha .hero.is-danger .tabs a{color:#fff;opacity:0.9}html.theme--catppuccin-mocha .hero.is-danger .tabs a:hover{opacity:1}html.theme--catppuccin-mocha .hero.is-danger .tabs li.is-active a{color:#f38ba8 !important;opacity:1}html.theme--catppuccin-mocha .hero.is-danger .tabs.is-boxed a,html.theme--catppuccin-mocha .hero.is-danger .tabs.is-toggle a{color:#fff}html.theme--catppuccin-mocha .hero.is-danger .tabs.is-boxed a:hover,html.theme--catppuccin-mocha .hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--catppuccin-mocha .hero.is-danger .tabs.is-boxed li.is-active a,html.theme--catppuccin-mocha .hero.is-danger .tabs.is-boxed li.is-active a:hover,html.theme--catppuccin-mocha .hero.is-danger .tabs.is-toggle li.is-active a,html.theme--catppuccin-mocha .hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#f38ba8}html.theme--catppuccin-mocha .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #f7549d 0%, #f38ba8 71%, #f8a0a9 100%)}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #f7549d 0%, #f38ba8 71%, #f8a0a9 100%)}}html.theme--catppuccin-mocha .hero.is-small .hero-body,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .hero.is-large .hero-body{padding:18rem 6rem}}html.theme--catppuccin-mocha .hero.is-halfheight .hero-body,html.theme--catppuccin-mocha .hero.is-fullheight .hero-body,html.theme--catppuccin-mocha .hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}html.theme--catppuccin-mocha .hero.is-halfheight .hero-body>.container,html.theme--catppuccin-mocha .hero.is-fullheight .hero-body>.container,html.theme--catppuccin-mocha .hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}html.theme--catppuccin-mocha .hero.is-halfheight{min-height:50vh}html.theme--catppuccin-mocha .hero.is-fullheight{min-height:100vh}html.theme--catppuccin-mocha .hero-video{overflow:hidden}html.theme--catppuccin-mocha .hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}html.theme--catppuccin-mocha .hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero-video{display:none}}html.theme--catppuccin-mocha .hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){html.theme--catppuccin-mocha .hero-buttons .button{display:flex}html.theme--catppuccin-mocha .hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .hero-buttons{display:flex;justify-content:center}html.theme--catppuccin-mocha .hero-buttons .button:not(:last-child){margin-right:1.5rem}}html.theme--catppuccin-mocha .hero-head,html.theme--catppuccin-mocha .hero-foot{flex-grow:0;flex-shrink:0}html.theme--catppuccin-mocha .hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{html.theme--catppuccin-mocha .hero-body{padding:3rem 3rem}}html.theme--catppuccin-mocha .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha .section{padding:3rem 3rem}html.theme--catppuccin-mocha .section.is-medium{padding:9rem 4.5rem}html.theme--catppuccin-mocha .section.is-large{padding:18rem 6rem}}html.theme--catppuccin-mocha .footer{background-color:#181825;padding:3rem 1.5rem 6rem}html.theme--catppuccin-mocha h1 .docs-heading-anchor,html.theme--catppuccin-mocha h1 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h1 .docs-heading-anchor:visited,html.theme--catppuccin-mocha h2 .docs-heading-anchor,html.theme--catppuccin-mocha h2 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h2 .docs-heading-anchor:visited,html.theme--catppuccin-mocha h3 .docs-heading-anchor,html.theme--catppuccin-mocha h3 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h3 .docs-heading-anchor:visited,html.theme--catppuccin-mocha h4 .docs-heading-anchor,html.theme--catppuccin-mocha h4 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h4 .docs-heading-anchor:visited,html.theme--catppuccin-mocha h5 .docs-heading-anchor,html.theme--catppuccin-mocha h5 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h5 .docs-heading-anchor:visited,html.theme--catppuccin-mocha h6 .docs-heading-anchor,html.theme--catppuccin-mocha h6 .docs-heading-anchor:hover,html.theme--catppuccin-mocha h6 .docs-heading-anchor:visited{color:#cdd6f4}html.theme--catppuccin-mocha h1 .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h2 .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h3 .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h4 .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h5 .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}html.theme--catppuccin-mocha h1 .docs-heading-anchor-permalink::before,html.theme--catppuccin-mocha h2 .docs-heading-anchor-permalink::before,html.theme--catppuccin-mocha h3 .docs-heading-anchor-permalink::before,html.theme--catppuccin-mocha h4 .docs-heading-anchor-permalink::before,html.theme--catppuccin-mocha h5 .docs-heading-anchor-permalink::before,html.theme--catppuccin-mocha h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}html.theme--catppuccin-mocha h1:hover .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h2:hover .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h3:hover .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h4:hover .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h5:hover .docs-heading-anchor-permalink,html.theme--catppuccin-mocha h6:hover .docs-heading-anchor-permalink{visibility:visible}html.theme--catppuccin-mocha .docs-light-only{display:none !important}html.theme--catppuccin-mocha pre{position:relative;overflow:hidden}html.theme--catppuccin-mocha pre code,html.theme--catppuccin-mocha pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}html.theme--catppuccin-mocha pre code:first-of-type,html.theme--catppuccin-mocha pre code.hljs:first-of-type{padding-top:0.5rem !important}html.theme--catppuccin-mocha pre code:last-of-type,html.theme--catppuccin-mocha pre code.hljs:last-of-type{padding-bottom:0.5rem !important}html.theme--catppuccin-mocha pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#cdd6f4;cursor:pointer;text-align:center}html.theme--catppuccin-mocha pre .copy-button:focus,html.theme--catppuccin-mocha pre .copy-button:hover{opacity:1;background:rgba(205,214,244,0.1);color:#89b4fa}html.theme--catppuccin-mocha pre .copy-button.success{color:#a6e3a1;opacity:1}html.theme--catppuccin-mocha pre .copy-button.error{color:#f38ba8;opacity:1}html.theme--catppuccin-mocha pre:hover .copy-button{opacity:1}html.theme--catppuccin-mocha .admonition{background-color:#181825;border-style:solid;border-width:2px;border-color:#bac2de;border-radius:4px;font-size:1rem}html.theme--catppuccin-mocha .admonition strong{color:currentColor}html.theme--catppuccin-mocha .admonition.is-small,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}html.theme--catppuccin-mocha .admonition.is-medium{font-size:1.25rem}html.theme--catppuccin-mocha .admonition.is-large{font-size:1.5rem}html.theme--catppuccin-mocha .admonition.is-default{background-color:#181825;border-color:#bac2de}html.theme--catppuccin-mocha .admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#bac2de}html.theme--catppuccin-mocha .admonition.is-default>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition.is-info{background-color:#181825;border-color:#94e2d5}html.theme--catppuccin-mocha .admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#94e2d5}html.theme--catppuccin-mocha .admonition.is-info>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition.is-success{background-color:#181825;border-color:#a6e3a1}html.theme--catppuccin-mocha .admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#a6e3a1}html.theme--catppuccin-mocha .admonition.is-success>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition.is-warning{background-color:#181825;border-color:#f9e2af}html.theme--catppuccin-mocha .admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#f9e2af}html.theme--catppuccin-mocha .admonition.is-warning>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition.is-danger{background-color:#181825;border-color:#f38ba8}html.theme--catppuccin-mocha .admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#f38ba8}html.theme--catppuccin-mocha .admonition.is-danger>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition.is-compat{background-color:#181825;border-color:#89dceb}html.theme--catppuccin-mocha .admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#89dceb}html.theme--catppuccin-mocha .admonition.is-compat>.admonition-body{color:#cdd6f4}html.theme--catppuccin-mocha .admonition-header{color:#bac2de;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}html.theme--catppuccin-mocha .admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}html.theme--catppuccin-mocha details.admonition.is-details>.admonition-header{list-style:none}html.theme--catppuccin-mocha details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}html.theme--catppuccin-mocha details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}html.theme--catppuccin-mocha .admonition-body{color:#cdd6f4;padding:0.5rem .75rem}html.theme--catppuccin-mocha .admonition-body pre{background-color:#181825}html.theme--catppuccin-mocha .admonition-body code{background-color:#181825}html.theme--catppuccin-mocha .docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #585b70;border-radius:4px;box-shadow:none;max-width:100%}html.theme--catppuccin-mocha .docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#181825;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #585b70;overflow:auto}html.theme--catppuccin-mocha .docstring>header code{background-color:transparent}html.theme--catppuccin-mocha .docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}html.theme--catppuccin-mocha .docstring>header .docstring-binding{margin-right:0.3em}html.theme--catppuccin-mocha .docstring>header .docstring-category{margin-left:0.3em}html.theme--catppuccin-mocha .docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #585b70}html.theme--catppuccin-mocha .docstring>section:last-child{border-bottom:none}html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:focus{opacity:1 !important}html.theme--catppuccin-mocha .docstring:hover>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-mocha .docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}html.theme--catppuccin-mocha .docstring>section:hover a.docs-sourcelink{opacity:1}html.theme--catppuccin-mocha .documenter-example-output{background-color:#1e1e2e}html.theme--catppuccin-mocha .outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#181825;color:#cdd6f4;border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}html.theme--catppuccin-mocha .outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}html.theme--catppuccin-mocha .outdated-warning-overlay a{color:#89b4fa}html.theme--catppuccin-mocha .outdated-warning-overlay a:hover{color:#89dceb}html.theme--catppuccin-mocha .content pre{border:2px solid #585b70;border-radius:4px}html.theme--catppuccin-mocha .content code{font-weight:inherit}html.theme--catppuccin-mocha .content a code{color:#89b4fa}html.theme--catppuccin-mocha .content a:hover code{color:#89dceb}html.theme--catppuccin-mocha .content h1 code,html.theme--catppuccin-mocha .content h2 code,html.theme--catppuccin-mocha .content h3 code,html.theme--catppuccin-mocha .content h4 code,html.theme--catppuccin-mocha .content h5 code,html.theme--catppuccin-mocha .content h6 code{color:#cdd6f4}html.theme--catppuccin-mocha .content table{display:block;width:initial;max-width:100%;overflow-x:auto}html.theme--catppuccin-mocha .content blockquote>ul:first-child,html.theme--catppuccin-mocha .content blockquote>ol:first-child,html.theme--catppuccin-mocha .content .admonition-body>ul:first-child,html.theme--catppuccin-mocha .content .admonition-body>ol:first-child{margin-top:0}html.theme--catppuccin-mocha pre,html.theme--catppuccin-mocha code{font-variant-ligatures:no-contextual}html.theme--catppuccin-mocha .breadcrumb a.is-disabled{cursor:default;pointer-events:none}html.theme--catppuccin-mocha .breadcrumb a.is-disabled,html.theme--catppuccin-mocha .breadcrumb a.is-disabled:hover{color:#b8c5ef}html.theme--catppuccin-mocha .hljs{background:initial !important}html.theme--catppuccin-mocha .katex .katex-mathml{top:0;right:0}html.theme--catppuccin-mocha .katex-display,html.theme--catppuccin-mocha mjx-container,html.theme--catppuccin-mocha .MathJax_Display{margin:0.5em 0 !important}html.theme--catppuccin-mocha html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}html.theme--catppuccin-mocha li.no-marker{list-style:none}html.theme--catppuccin-mocha #documenter .docs-main>article{overflow-wrap:break-word}html.theme--catppuccin-mocha #documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha #documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha #documenter .docs-main{width:100%}html.theme--catppuccin-mocha #documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}html.theme--catppuccin-mocha #documenter .docs-main>header,html.theme--catppuccin-mocha #documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar{background-color:#1e1e2e;border-bottom:1px solid #585b70;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-right .docs-icon,html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #171717;transition-duration:0.7s;-webkit-transition-duration:0.7s}html.theme--catppuccin-mocha #documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}html.theme--catppuccin-mocha #documenter .docs-main section.footnotes{border-top:1px solid #585b70}html.theme--catppuccin-mocha #documenter .docs-main section.footnotes li .tag:first-child,html.theme--catppuccin-mocha #documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,html.theme--catppuccin-mocha #documenter .docs-main section.footnotes li .content kbd:first-child,html.theme--catppuccin-mocha .content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}html.theme--catppuccin-mocha #documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #585b70;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha #documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}html.theme--catppuccin-mocha #documenter .docs-main .docs-footer .docs-footer-nextpage,html.theme--catppuccin-mocha #documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}html.theme--catppuccin-mocha #documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}html.theme--catppuccin-mocha #documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}html.theme--catppuccin-mocha #documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}html.theme--catppuccin-mocha #documenter .docs-sidebar{display:flex;flex-direction:column;color:#cdd6f4;background-color:#181825;border-right:1px solid #585b70;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}html.theme--catppuccin-mocha #documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #171717}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha #documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha #documenter .docs-sidebar{left:0;top:0}}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-package-name a,html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-package-name a:hover{color:#cdd6f4}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-version-selector{border-top:1px solid #585b70;display:none;padding:0.5rem}html.theme--catppuccin-mocha #documenter .docs-sidebar .docs-version-selector.visible{display:flex}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #585b70;padding-bottom:1.5rem}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #585b70}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu .tocitem,html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#cdd6f4;background:#181825}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu a.tocitem:hover,html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#cdd6f4;background-color:#202031}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #585b70;border-bottom:1px solid #585b70;background-color:#11111b}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#11111b;color:#cdd6f4}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#202031;color:#cdd6f4}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #585b70}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input{width:14.4rem}html.theme--catppuccin-mocha #documenter .docs-sidebar #documenter-search-query{color:#868c98;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#28283e}html.theme--catppuccin-mocha #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#383856}}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha #documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--catppuccin-mocha #documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}html.theme--catppuccin-mocha #documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#28283e}html.theme--catppuccin-mocha #documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#383856}}html.theme--catppuccin-mocha kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(245,245,245,0.6);box-shadow:0 2px 0 1px rgba(245,245,245,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}html.theme--catppuccin-mocha .search-min-width-50{min-width:50%}html.theme--catppuccin-mocha .search-min-height-100{min-height:100%}html.theme--catppuccin-mocha .search-modal-card-body{max-height:calc(100vh - 15rem)}html.theme--catppuccin-mocha .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-mocha .search-result-link:hover,html.theme--catppuccin-mocha .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--catppuccin-mocha .search-result-link .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-mocha .property-search-result-badge,html.theme--catppuccin-mocha .search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}html.theme--catppuccin-mocha .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link:hover .search-filter,html.theme--catppuccin-mocha .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link:focus .search-filter{color:#333;background-color:#f1f5f9}html.theme--catppuccin-mocha .search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}html.theme--catppuccin-mocha .search-filter:hover,html.theme--catppuccin-mocha .search-filter:focus{color:#333}html.theme--catppuccin-mocha .search-filter-selected{color:#313244;background-color:#b4befe}html.theme--catppuccin-mocha .search-filter-selected:hover,html.theme--catppuccin-mocha .search-filter-selected:focus{color:#313244}html.theme--catppuccin-mocha .search-result-highlight{background-color:#ffdd57;color:black}html.theme--catppuccin-mocha .search-divider{border-bottom:1px solid #585b70}html.theme--catppuccin-mocha .search-result-title{width:85%;color:#f5f5f5}html.theme--catppuccin-mocha .search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--catppuccin-mocha #search-modal .modal-card-body::-webkit-scrollbar,html.theme--catppuccin-mocha #search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}html.theme--catppuccin-mocha #search-modal .modal-card-body::-webkit-scrollbar-thumb,html.theme--catppuccin-mocha #search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}html.theme--catppuccin-mocha #search-modal .modal-card-body::-webkit-scrollbar-track,html.theme--catppuccin-mocha #search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}html.theme--catppuccin-mocha .w-100{width:100%}html.theme--catppuccin-mocha .gap-2{gap:0.5rem}html.theme--catppuccin-mocha .gap-4{gap:1rem}html.theme--catppuccin-mocha .gap-8{gap:2rem}html.theme--catppuccin-mocha{background-color:#1e1e2e;font-size:16px;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--catppuccin-mocha a{transition:all 200ms ease}html.theme--catppuccin-mocha .label{color:#cdd6f4}html.theme--catppuccin-mocha .button,html.theme--catppuccin-mocha .control.has-icons-left .icon,html.theme--catppuccin-mocha .control.has-icons-right .icon,html.theme--catppuccin-mocha .input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha .pagination-ellipsis,html.theme--catppuccin-mocha .pagination-link,html.theme--catppuccin-mocha .pagination-next,html.theme--catppuccin-mocha .pagination-previous,html.theme--catppuccin-mocha .select,html.theme--catppuccin-mocha .select select,html.theme--catppuccin-mocha .textarea{height:2.5em;color:#cdd6f4}html.theme--catppuccin-mocha .input,html.theme--catppuccin-mocha #documenter .docs-sidebar form.docs-search>input,html.theme--catppuccin-mocha .textarea{transition:all 200ms ease;box-shadow:none;border-width:1px;padding-left:1em;padding-right:1em;color:#cdd6f4}html.theme--catppuccin-mocha .select:after,html.theme--catppuccin-mocha .select select{border-width:1px}html.theme--catppuccin-mocha .menu-list a{transition:all 300ms ease}html.theme--catppuccin-mocha .modal-card-foot,html.theme--catppuccin-mocha .modal-card-head{border-color:#585b70}html.theme--catppuccin-mocha .navbar{border-radius:.4em}html.theme--catppuccin-mocha .navbar.is-transparent{background:none}html.theme--catppuccin-mocha .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--catppuccin-mocha .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#89b4fa}@media screen and (max-width: 1055px){html.theme--catppuccin-mocha .navbar .navbar-menu{background-color:#89b4fa;border-radius:0 0 .4em .4em}}html.theme--catppuccin-mocha .docstring>section>a.docs-sourcelink:not(body){color:#313244}html.theme--catppuccin-mocha .tag.is-link:not(body),html.theme--catppuccin-mocha .docstring>section>a.is-link.docs-sourcelink:not(body),html.theme--catppuccin-mocha .content kbd.is-link:not(body){color:#313244}html.theme--catppuccin-mocha .ansi span.sgr1{font-weight:bolder}html.theme--catppuccin-mocha .ansi span.sgr2{font-weight:lighter}html.theme--catppuccin-mocha .ansi span.sgr3{font-style:italic}html.theme--catppuccin-mocha .ansi span.sgr4{text-decoration:underline}html.theme--catppuccin-mocha .ansi span.sgr7{color:#1e1e2e;background-color:#cdd6f4}html.theme--catppuccin-mocha .ansi span.sgr8{color:transparent}html.theme--catppuccin-mocha .ansi span.sgr8 span{color:transparent}html.theme--catppuccin-mocha .ansi span.sgr9{text-decoration:line-through}html.theme--catppuccin-mocha .ansi span.sgr30{color:#45475a}html.theme--catppuccin-mocha .ansi span.sgr31{color:#f38ba8}html.theme--catppuccin-mocha .ansi span.sgr32{color:#a6e3a1}html.theme--catppuccin-mocha .ansi span.sgr33{color:#f9e2af}html.theme--catppuccin-mocha .ansi span.sgr34{color:#89b4fa}html.theme--catppuccin-mocha .ansi span.sgr35{color:#f5c2e7}html.theme--catppuccin-mocha .ansi span.sgr36{color:#94e2d5}html.theme--catppuccin-mocha .ansi span.sgr37{color:#bac2de}html.theme--catppuccin-mocha .ansi span.sgr40{background-color:#45475a}html.theme--catppuccin-mocha .ansi span.sgr41{background-color:#f38ba8}html.theme--catppuccin-mocha .ansi span.sgr42{background-color:#a6e3a1}html.theme--catppuccin-mocha .ansi span.sgr43{background-color:#f9e2af}html.theme--catppuccin-mocha .ansi span.sgr44{background-color:#89b4fa}html.theme--catppuccin-mocha .ansi span.sgr45{background-color:#f5c2e7}html.theme--catppuccin-mocha .ansi span.sgr46{background-color:#94e2d5}html.theme--catppuccin-mocha .ansi span.sgr47{background-color:#bac2de}html.theme--catppuccin-mocha .ansi span.sgr90{color:#585b70}html.theme--catppuccin-mocha .ansi span.sgr91{color:#f38ba8}html.theme--catppuccin-mocha .ansi span.sgr92{color:#a6e3a1}html.theme--catppuccin-mocha .ansi span.sgr93{color:#f9e2af}html.theme--catppuccin-mocha .ansi span.sgr94{color:#89b4fa}html.theme--catppuccin-mocha .ansi span.sgr95{color:#f5c2e7}html.theme--catppuccin-mocha .ansi span.sgr96{color:#94e2d5}html.theme--catppuccin-mocha .ansi span.sgr97{color:#a6adc8}html.theme--catppuccin-mocha .ansi span.sgr100{background-color:#585b70}html.theme--catppuccin-mocha .ansi span.sgr101{background-color:#f38ba8}html.theme--catppuccin-mocha .ansi span.sgr102{background-color:#a6e3a1}html.theme--catppuccin-mocha .ansi span.sgr103{background-color:#f9e2af}html.theme--catppuccin-mocha .ansi span.sgr104{background-color:#89b4fa}html.theme--catppuccin-mocha .ansi span.sgr105{background-color:#f5c2e7}html.theme--catppuccin-mocha .ansi span.sgr106{background-color:#94e2d5}html.theme--catppuccin-mocha .ansi span.sgr107{background-color:#a6adc8}html.theme--catppuccin-mocha code.language-julia-repl>span.hljs-meta{color:#a6e3a1;font-weight:bolder}html.theme--catppuccin-mocha code .hljs{color:#cdd6f4;background:#1e1e2e}html.theme--catppuccin-mocha code .hljs-keyword{color:#cba6f7}html.theme--catppuccin-mocha code .hljs-built_in{color:#f38ba8}html.theme--catppuccin-mocha code .hljs-type{color:#f9e2af}html.theme--catppuccin-mocha code .hljs-literal{color:#fab387}html.theme--catppuccin-mocha code .hljs-number{color:#fab387}html.theme--catppuccin-mocha code .hljs-operator{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-punctuation{color:#bac2de}html.theme--catppuccin-mocha code .hljs-property{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-regexp{color:#f5c2e7}html.theme--catppuccin-mocha code .hljs-string{color:#a6e3a1}html.theme--catppuccin-mocha code .hljs-char.escape_{color:#a6e3a1}html.theme--catppuccin-mocha code .hljs-subst{color:#a6adc8}html.theme--catppuccin-mocha code .hljs-symbol{color:#f2cdcd}html.theme--catppuccin-mocha code .hljs-variable{color:#cba6f7}html.theme--catppuccin-mocha code .hljs-variable.language_{color:#cba6f7}html.theme--catppuccin-mocha code .hljs-variable.constant_{color:#fab387}html.theme--catppuccin-mocha code .hljs-title{color:#89b4fa}html.theme--catppuccin-mocha code .hljs-title.class_{color:#f9e2af}html.theme--catppuccin-mocha code .hljs-title.function_{color:#89b4fa}html.theme--catppuccin-mocha code .hljs-params{color:#cdd6f4}html.theme--catppuccin-mocha code .hljs-comment{color:#585b70}html.theme--catppuccin-mocha code .hljs-doctag{color:#f38ba8}html.theme--catppuccin-mocha code .hljs-meta{color:#fab387}html.theme--catppuccin-mocha code .hljs-section{color:#89b4fa}html.theme--catppuccin-mocha code .hljs-tag{color:#a6adc8}html.theme--catppuccin-mocha code .hljs-name{color:#cba6f7}html.theme--catppuccin-mocha code .hljs-attr{color:#89b4fa}html.theme--catppuccin-mocha code .hljs-attribute{color:#a6e3a1}html.theme--catppuccin-mocha code .hljs-bullet{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-code{color:#a6e3a1}html.theme--catppuccin-mocha code .hljs-emphasis{color:#f38ba8;font-style:italic}html.theme--catppuccin-mocha code .hljs-strong{color:#f38ba8;font-weight:bold}html.theme--catppuccin-mocha code .hljs-formula{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-link{color:#74c7ec;font-style:italic}html.theme--catppuccin-mocha code .hljs-quote{color:#a6e3a1;font-style:italic}html.theme--catppuccin-mocha code .hljs-selector-tag{color:#f9e2af}html.theme--catppuccin-mocha code .hljs-selector-id{color:#89b4fa}html.theme--catppuccin-mocha code .hljs-selector-class{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-selector-attr{color:#cba6f7}html.theme--catppuccin-mocha code .hljs-selector-pseudo{color:#94e2d5}html.theme--catppuccin-mocha code .hljs-template-tag{color:#f2cdcd}html.theme--catppuccin-mocha code .hljs-template-variable{color:#f2cdcd}html.theme--catppuccin-mocha code .hljs-addition{color:#a6e3a1;background:rgba(166,227,161,0.15)}html.theme--catppuccin-mocha code .hljs-deletion{color:#f38ba8;background:rgba(243,139,168,0.15)}html.theme--catppuccin-mocha .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--catppuccin-mocha .search-result-link:hover,html.theme--catppuccin-mocha .search-result-link:focus{background-color:#313244}html.theme--catppuccin-mocha .search-result-link .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link .search-filter{transition:all 300ms}html.theme--catppuccin-mocha .search-result-link:hover .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link:hover .search-filter,html.theme--catppuccin-mocha .search-result-link:focus .property-search-result-badge,html.theme--catppuccin-mocha .search-result-link:focus .search-filter{color:#313244 !important;background-color:#b4befe !important}html.theme--catppuccin-mocha .search-result-title{color:#cdd6f4}html.theme--catppuccin-mocha .search-result-highlight{background-color:#f38ba8;color:#181825}html.theme--catppuccin-mocha .search-divider{border-bottom:1px solid #5e6d6f50}html.theme--catppuccin-mocha .w-100{width:100%}html.theme--catppuccin-mocha .gap-2{gap:0.5rem}html.theme--catppuccin-mocha .gap-4{gap:1rem} diff --git a/v0.16.1/assets/themes/documenter-dark.css b/v0.16.1/assets/themes/documenter-dark.css new file mode 100644 index 000000000..2892b385e --- /dev/null +++ b/v0.16.1/assets/themes/documenter-dark.css @@ -0,0 +1,7 @@ +html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-ellipsis,html.theme--documenter-dark .file-cta,html.theme--documenter-dark .file-name,html.theme--documenter-dark .select select,html.theme--documenter-dark .textarea,html.theme--documenter-dark .input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark .button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:.4em;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}html.theme--documenter-dark .pagination-previous:focus,html.theme--documenter-dark .pagination-next:focus,html.theme--documenter-dark .pagination-link:focus,html.theme--documenter-dark .pagination-ellipsis:focus,html.theme--documenter-dark .file-cta:focus,html.theme--documenter-dark .file-name:focus,html.theme--documenter-dark .select select:focus,html.theme--documenter-dark .textarea:focus,html.theme--documenter-dark .input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:focus,html.theme--documenter-dark .button:focus,html.theme--documenter-dark .is-focused.pagination-previous,html.theme--documenter-dark .is-focused.pagination-next,html.theme--documenter-dark .is-focused.pagination-link,html.theme--documenter-dark .is-focused.pagination-ellipsis,html.theme--documenter-dark .is-focused.file-cta,html.theme--documenter-dark .is-focused.file-name,html.theme--documenter-dark .select select.is-focused,html.theme--documenter-dark .is-focused.textarea,html.theme--documenter-dark .is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-focused.button,html.theme--documenter-dark .pagination-previous:active,html.theme--documenter-dark .pagination-next:active,html.theme--documenter-dark .pagination-link:active,html.theme--documenter-dark .pagination-ellipsis:active,html.theme--documenter-dark .file-cta:active,html.theme--documenter-dark .file-name:active,html.theme--documenter-dark .select select:active,html.theme--documenter-dark .textarea:active,html.theme--documenter-dark .input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:active,html.theme--documenter-dark .button:active,html.theme--documenter-dark .is-active.pagination-previous,html.theme--documenter-dark .is-active.pagination-next,html.theme--documenter-dark .is-active.pagination-link,html.theme--documenter-dark .is-active.pagination-ellipsis,html.theme--documenter-dark .is-active.file-cta,html.theme--documenter-dark .is-active.file-name,html.theme--documenter-dark .select select.is-active,html.theme--documenter-dark .is-active.textarea,html.theme--documenter-dark .is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--documenter-dark .is-active.button{outline:none}html.theme--documenter-dark .pagination-previous[disabled],html.theme--documenter-dark .pagination-next[disabled],html.theme--documenter-dark .pagination-link[disabled],html.theme--documenter-dark .pagination-ellipsis[disabled],html.theme--documenter-dark .file-cta[disabled],html.theme--documenter-dark .file-name[disabled],html.theme--documenter-dark .select select[disabled],html.theme--documenter-dark .textarea[disabled],html.theme--documenter-dark .input[disabled],html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled],html.theme--documenter-dark .button[disabled],fieldset[disabled] html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark fieldset[disabled] .pagination-previous,fieldset[disabled] html.theme--documenter-dark .pagination-next,html.theme--documenter-dark fieldset[disabled] .pagination-next,fieldset[disabled] html.theme--documenter-dark .pagination-link,html.theme--documenter-dark fieldset[disabled] .pagination-link,fieldset[disabled] html.theme--documenter-dark .pagination-ellipsis,html.theme--documenter-dark fieldset[disabled] .pagination-ellipsis,fieldset[disabled] html.theme--documenter-dark .file-cta,html.theme--documenter-dark fieldset[disabled] .file-cta,fieldset[disabled] html.theme--documenter-dark .file-name,html.theme--documenter-dark fieldset[disabled] .file-name,fieldset[disabled] html.theme--documenter-dark .select select,fieldset[disabled] html.theme--documenter-dark .textarea,fieldset[disabled] html.theme--documenter-dark .input,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark fieldset[disabled] .select select,html.theme--documenter-dark .select fieldset[disabled] select,html.theme--documenter-dark fieldset[disabled] .textarea,html.theme--documenter-dark fieldset[disabled] .input,html.theme--documenter-dark fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] html.theme--documenter-dark .button,html.theme--documenter-dark fieldset[disabled] .button{cursor:not-allowed}html.theme--documenter-dark .tabs,html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-ellipsis,html.theme--documenter-dark .breadcrumb,html.theme--documenter-dark .file,html.theme--documenter-dark .button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}html.theme--documenter-dark .navbar-link:not(.is-arrowless)::after,html.theme--documenter-dark .select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}html.theme--documenter-dark .admonition:not(:last-child),html.theme--documenter-dark .tabs:not(:last-child),html.theme--documenter-dark .pagination:not(:last-child),html.theme--documenter-dark .message:not(:last-child),html.theme--documenter-dark .level:not(:last-child),html.theme--documenter-dark .breadcrumb:not(:last-child),html.theme--documenter-dark .block:not(:last-child),html.theme--documenter-dark .title:not(:last-child),html.theme--documenter-dark .subtitle:not(:last-child),html.theme--documenter-dark .table-container:not(:last-child),html.theme--documenter-dark .table:not(:last-child),html.theme--documenter-dark .progress:not(:last-child),html.theme--documenter-dark .notification:not(:last-child),html.theme--documenter-dark .content:not(:last-child),html.theme--documenter-dark .box:not(:last-child){margin-bottom:1.5rem}html.theme--documenter-dark .modal-close,html.theme--documenter-dark .delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}html.theme--documenter-dark .modal-close::before,html.theme--documenter-dark .delete::before,html.theme--documenter-dark .modal-close::after,html.theme--documenter-dark .delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--documenter-dark .modal-close::before,html.theme--documenter-dark .delete::before{height:2px;width:50%}html.theme--documenter-dark .modal-close::after,html.theme--documenter-dark .delete::after{height:50%;width:2px}html.theme--documenter-dark .modal-close:hover,html.theme--documenter-dark .delete:hover,html.theme--documenter-dark .modal-close:focus,html.theme--documenter-dark .delete:focus{background-color:rgba(10,10,10,0.3)}html.theme--documenter-dark .modal-close:active,html.theme--documenter-dark .delete:active{background-color:rgba(10,10,10,0.4)}html.theme--documenter-dark .is-small.modal-close,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.modal-close,html.theme--documenter-dark .is-small.delete,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}html.theme--documenter-dark .is-medium.modal-close,html.theme--documenter-dark .is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}html.theme--documenter-dark .is-large.modal-close,html.theme--documenter-dark .is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}html.theme--documenter-dark .control.is-loading::after,html.theme--documenter-dark .select.is-loading::after,html.theme--documenter-dark .loader,html.theme--documenter-dark .button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #dbdee0;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}html.theme--documenter-dark .hero-video,html.theme--documenter-dark .modal-background,html.theme--documenter-dark .modal,html.theme--documenter-dark .image.is-square img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--documenter-dark .image.is-square .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--documenter-dark .image.is-1by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--documenter-dark .image.is-1by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--documenter-dark .image.is-5by4 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--documenter-dark .image.is-5by4 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--documenter-dark .image.is-4by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--documenter-dark .image.is-4by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--documenter-dark .image.is-3by2 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--documenter-dark .image.is-3by2 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--documenter-dark .image.is-5by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--documenter-dark .image.is-5by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--documenter-dark .image.is-16by9 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--documenter-dark .image.is-16by9 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--documenter-dark .image.is-2by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--documenter-dark .image.is-2by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--documenter-dark .image.is-3by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--documenter-dark .image.is-3by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--documenter-dark .image.is-4by5 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--documenter-dark .image.is-4by5 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--documenter-dark .image.is-3by4 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--documenter-dark .image.is-3by4 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--documenter-dark .image.is-2by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--documenter-dark .image.is-2by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--documenter-dark .image.is-3by5 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--documenter-dark .image.is-3by5 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--documenter-dark .image.is-9by16 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--documenter-dark .image.is-9by16 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--documenter-dark .image.is-1by2 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--documenter-dark .image.is-1by2 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--documenter-dark .image.is-1by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--documenter-dark .image.is-1by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}html.theme--documenter-dark .navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#ecf0f1 !important}a.has-text-light:hover,a.has-text-light:focus{color:#cfd9db !important}.has-background-light{background-color:#ecf0f1 !important}.has-text-dark{color:#282f2f !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#111414 !important}.has-background-dark{background-color:#282f2f !important}.has-text-primary{color:#375a7f !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#28415b !important}.has-background-primary{background-color:#375a7f !important}.has-text-primary-light{color:#f1f5f9 !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#cddbe9 !important}.has-background-primary-light{background-color:#f1f5f9 !important}.has-text-primary-dark{color:#4d7eb2 !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#7198c1 !important}.has-background-primary-dark{background-color:#4d7eb2 !important}.has-text-link{color:#1abc9c !important}a.has-text-link:hover,a.has-text-link:focus{color:#148f77 !important}.has-background-link{background-color:#1abc9c !important}.has-text-link-light{color:#edfdf9 !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#c0f6ec !important}.has-background-link-light{background-color:#edfdf9 !important}.has-text-link-dark{color:#15987e !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#1bc5a4 !important}.has-background-link-dark{background-color:#15987e !important}.has-text-info{color:#3c5dcd !important}a.has-text-info:hover,a.has-text-info:focus{color:#2c48aa !important}.has-background-info{background-color:#3c5dcd !important}.has-text-info-light{color:#eff2fb !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#c6d0f0 !important}.has-background-info-light{background-color:#eff2fb !important}.has-text-info-dark{color:#3253c3 !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#5571d3 !important}.has-background-info-dark{background-color:#3253c3 !important}.has-text-success{color:#259a12 !important}a.has-text-success:hover,a.has-text-success:focus{color:#1a6c0d !important}.has-background-success{background-color:#259a12 !important}.has-text-success-light{color:#effded !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#c7f8bf !important}.has-background-success-light{background-color:#effded !important}.has-text-success-dark{color:#2ec016 !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#3fe524 !important}.has-background-success-dark{background-color:#2ec016 !important}.has-text-warning{color:#f4c72f !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#e4b30c !important}.has-background-warning{background-color:#f4c72f !important}.has-text-warning-light{color:#fefaec !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#fbedbb !important}.has-background-warning-light{background-color:#fefaec !important}.has-text-warning-dark{color:#8c6e07 !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#bd940a !important}.has-background-warning-dark{background-color:#8c6e07 !important}.has-text-danger{color:#cb3c33 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#a23029 !important}.has-background-danger{background-color:#cb3c33 !important}.has-text-danger-light{color:#fbefef !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#f1c8c6 !important}.has-background-danger-light{background-color:#fbefef !important}.has-text-danger-dark{color:#c03930 !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#d35850 !important}.has-background-danger-dark{background-color:#c03930 !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#282f2f !important}.has-background-grey-darker{background-color:#282f2f !important}.has-text-grey-dark{color:#343c3d !important}.has-background-grey-dark{background-color:#343c3d !important}.has-text-grey{color:#5e6d6f !important}.has-background-grey{background-color:#5e6d6f !important}.has-text-grey-light{color:#8c9b9d !important}.has-background-grey-light{background-color:#8c9b9d !important}.has-text-grey-lighter{color:#dbdee0 !important}.has-background-grey-lighter{background-color:#dbdee0 !important}.has-text-white-ter{color:#ecf0f1 !important}.has-background-white-ter{background-color:#ecf0f1 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,html.theme--documenter-dark .docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}html.theme--documenter-dark{/*! + Theme: a11y-dark + Author: @ericwbailey + Maintainer: @ericwbailey + + Based on the Tomorrow Night Eighties theme: https://github.com/isagalaev/highlight.js/blob/master/src/styles/tomorrow-night-eighties.css +*/}html.theme--documenter-dark html{background-color:#1f2424;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--documenter-dark article,html.theme--documenter-dark aside,html.theme--documenter-dark figure,html.theme--documenter-dark footer,html.theme--documenter-dark header,html.theme--documenter-dark hgroup,html.theme--documenter-dark section{display:block}html.theme--documenter-dark body,html.theme--documenter-dark button,html.theme--documenter-dark input,html.theme--documenter-dark optgroup,html.theme--documenter-dark select,html.theme--documenter-dark textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}html.theme--documenter-dark code,html.theme--documenter-dark pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--documenter-dark body{color:#fff;font-size:1em;font-weight:400;line-height:1.5}html.theme--documenter-dark a{color:#1abc9c;cursor:pointer;text-decoration:none}html.theme--documenter-dark a strong{color:currentColor}html.theme--documenter-dark a:hover{color:#1dd2af}html.theme--documenter-dark code{background-color:rgba(255,255,255,0.05);color:#ececec;font-size:.875em;font-weight:normal;padding:.1em}html.theme--documenter-dark hr{background-color:#282f2f;border:none;display:block;height:2px;margin:1.5rem 0}html.theme--documenter-dark img{height:auto;max-width:100%}html.theme--documenter-dark input[type="checkbox"],html.theme--documenter-dark input[type="radio"]{vertical-align:baseline}html.theme--documenter-dark small{font-size:.875em}html.theme--documenter-dark span{font-style:inherit;font-weight:inherit}html.theme--documenter-dark strong{color:#f2f2f2;font-weight:700}html.theme--documenter-dark fieldset{border:none}html.theme--documenter-dark pre{-webkit-overflow-scrolling:touch;background-color:#282f2f;color:#fff;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}html.theme--documenter-dark pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}html.theme--documenter-dark table td,html.theme--documenter-dark table th{vertical-align:top}html.theme--documenter-dark table td:not([align]),html.theme--documenter-dark table th:not([align]){text-align:inherit}html.theme--documenter-dark table th{color:#f2f2f2}html.theme--documenter-dark .box{background-color:#343c3d;border-radius:8px;box-shadow:none;color:#fff;display:block;padding:1.25rem}html.theme--documenter-dark a.box:hover,html.theme--documenter-dark a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #1abc9c}html.theme--documenter-dark a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #1abc9c}html.theme--documenter-dark .button{background-color:#282f2f;border-color:#4c5759;border-width:1px;color:#375a7f;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}html.theme--documenter-dark .button strong{color:inherit}html.theme--documenter-dark .button .icon,html.theme--documenter-dark .button .icon.is-small,html.theme--documenter-dark .button #documenter .docs-sidebar form.docs-search>input.icon,html.theme--documenter-dark #documenter .docs-sidebar .button form.docs-search>input.icon,html.theme--documenter-dark .button .icon.is-medium,html.theme--documenter-dark .button .icon.is-large{height:1.5em;width:1.5em}html.theme--documenter-dark .button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}html.theme--documenter-dark .button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}html.theme--documenter-dark .button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}html.theme--documenter-dark .button:hover,html.theme--documenter-dark .button.is-hovered{border-color:#8c9b9d;color:#f2f2f2}html.theme--documenter-dark .button:focus,html.theme--documenter-dark .button.is-focused{border-color:#8c9b9d;color:#17a689}html.theme--documenter-dark .button:focus:not(:active),html.theme--documenter-dark .button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(26,188,156,0.25)}html.theme--documenter-dark .button:active,html.theme--documenter-dark .button.is-active{border-color:#343c3d;color:#f2f2f2}html.theme--documenter-dark .button.is-text{background-color:transparent;border-color:transparent;color:#fff;text-decoration:underline}html.theme--documenter-dark .button.is-text:hover,html.theme--documenter-dark .button.is-text.is-hovered,html.theme--documenter-dark .button.is-text:focus,html.theme--documenter-dark .button.is-text.is-focused{background-color:#282f2f;color:#f2f2f2}html.theme--documenter-dark .button.is-text:active,html.theme--documenter-dark .button.is-text.is-active{background-color:#1d2122;color:#f2f2f2}html.theme--documenter-dark .button.is-text[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#1abc9c;text-decoration:none}html.theme--documenter-dark .button.is-ghost:hover,html.theme--documenter-dark .button.is-ghost.is-hovered{color:#1abc9c;text-decoration:underline}html.theme--documenter-dark .button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .button.is-white:hover,html.theme--documenter-dark .button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .button.is-white:focus,html.theme--documenter-dark .button.is-white.is-focused{border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .button.is-white:focus:not(:active),html.theme--documenter-dark .button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--documenter-dark .button.is-white:active,html.theme--documenter-dark .button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .button.is-white[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}html.theme--documenter-dark .button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .button.is-white.is-inverted:hover,html.theme--documenter-dark .button.is-white.is-inverted.is-hovered{background-color:#000}html.theme--documenter-dark .button.is-white.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--documenter-dark .button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-white.is-outlined:hover,html.theme--documenter-dark .button.is-white.is-outlined.is-hovered,html.theme--documenter-dark .button.is-white.is-outlined:focus,html.theme--documenter-dark .button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--documenter-dark .button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-white.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-white.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-white.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--documenter-dark .button.is-white.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--documenter-dark .button.is-white.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--documenter-dark .button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-black:hover,html.theme--documenter-dark .button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-black:focus,html.theme--documenter-dark .button.is-black.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-black:focus:not(:active),html.theme--documenter-dark .button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--documenter-dark .button.is-black:active,html.theme--documenter-dark .button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-black[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}html.theme--documenter-dark .button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .button.is-black.is-inverted:hover,html.theme--documenter-dark .button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-black.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}html.theme--documenter-dark .button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}html.theme--documenter-dark .button.is-black.is-outlined:hover,html.theme--documenter-dark .button.is-black.is-outlined.is-hovered,html.theme--documenter-dark .button.is-black.is-outlined:focus,html.theme--documenter-dark .button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--documenter-dark .button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--documenter-dark .button.is-black.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-black.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-black.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-black.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}html.theme--documenter-dark .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-black.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}html.theme--documenter-dark .button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-light{background-color:#ecf0f1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light:hover,html.theme--documenter-dark .button.is-light.is-hovered{background-color:#e5eaec;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light:focus,html.theme--documenter-dark .button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light:focus:not(:active),html.theme--documenter-dark .button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(236,240,241,0.25)}html.theme--documenter-dark .button.is-light:active,html.theme--documenter-dark .button.is-light.is-active{background-color:#dde4e6;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light{background-color:#ecf0f1;border-color:#ecf0f1;box-shadow:none}html.theme--documenter-dark .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-inverted:hover,html.theme--documenter-dark .button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--documenter-dark .button.is-light.is-outlined{background-color:transparent;border-color:#ecf0f1;color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-outlined:hover,html.theme--documenter-dark .button.is-light.is-outlined.is-hovered,html.theme--documenter-dark .button.is-light.is-outlined:focus,html.theme--documenter-dark .button.is-light.is-outlined.is-focused{background-color:#ecf0f1;border-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #ecf0f1 #ecf0f1 !important}html.theme--documenter-dark .button.is-light.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-light.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-light.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--documenter-dark .button.is-light.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light.is-outlined{background-color:transparent;border-color:#ecf0f1;box-shadow:none;color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-light.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #ecf0f1 #ecf0f1 !important}html.theme--documenter-dark .button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-dark,html.theme--documenter-dark .content kbd.button{background-color:#282f2f;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-dark:hover,html.theme--documenter-dark .content kbd.button:hover,html.theme--documenter-dark .button.is-dark.is-hovered,html.theme--documenter-dark .content kbd.button.is-hovered{background-color:#232829;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-dark:focus,html.theme--documenter-dark .content kbd.button:focus,html.theme--documenter-dark .button.is-dark.is-focused,html.theme--documenter-dark .content kbd.button.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-dark:focus:not(:active),html.theme--documenter-dark .content kbd.button:focus:not(:active),html.theme--documenter-dark .button.is-dark.is-focused:not(:active),html.theme--documenter-dark .content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(40,47,47,0.25)}html.theme--documenter-dark .button.is-dark:active,html.theme--documenter-dark .content kbd.button:active,html.theme--documenter-dark .button.is-dark.is-active,html.theme--documenter-dark .content kbd.button.is-active{background-color:#1d2122;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-dark[disabled],html.theme--documenter-dark .content kbd.button[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-dark,fieldset[disabled] html.theme--documenter-dark .content kbd.button{background-color:#282f2f;border-color:#282f2f;box-shadow:none}html.theme--documenter-dark .button.is-dark.is-inverted,html.theme--documenter-dark .content kbd.button.is-inverted{background-color:#fff;color:#282f2f}html.theme--documenter-dark .button.is-dark.is-inverted:hover,html.theme--documenter-dark .content kbd.button.is-inverted:hover,html.theme--documenter-dark .button.is-dark.is-inverted.is-hovered,html.theme--documenter-dark .content kbd.button.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-dark.is-inverted[disabled],html.theme--documenter-dark .content kbd.button.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-dark.is-inverted,fieldset[disabled] html.theme--documenter-dark .content kbd.button.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#282f2f}html.theme--documenter-dark .button.is-dark.is-loading::after,html.theme--documenter-dark .content kbd.button.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-dark.is-outlined,html.theme--documenter-dark .content kbd.button.is-outlined{background-color:transparent;border-color:#282f2f;color:#282f2f}html.theme--documenter-dark .button.is-dark.is-outlined:hover,html.theme--documenter-dark .content kbd.button.is-outlined:hover,html.theme--documenter-dark .button.is-dark.is-outlined.is-hovered,html.theme--documenter-dark .content kbd.button.is-outlined.is-hovered,html.theme--documenter-dark .button.is-dark.is-outlined:focus,html.theme--documenter-dark .content kbd.button.is-outlined:focus,html.theme--documenter-dark .button.is-dark.is-outlined.is-focused,html.theme--documenter-dark .content kbd.button.is-outlined.is-focused{background-color:#282f2f;border-color:#282f2f;color:#fff}html.theme--documenter-dark .button.is-dark.is-outlined.is-loading::after,html.theme--documenter-dark .content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #282f2f #282f2f !important}html.theme--documenter-dark .button.is-dark.is-outlined.is-loading:hover::after,html.theme--documenter-dark .content kbd.button.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-dark.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .content kbd.button.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-dark.is-outlined.is-loading:focus::after,html.theme--documenter-dark .content kbd.button.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-dark.is-outlined.is-loading.is-focused::after,html.theme--documenter-dark .content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-dark.is-outlined[disabled],html.theme--documenter-dark .content kbd.button.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-dark.is-outlined,fieldset[disabled] html.theme--documenter-dark .content kbd.button.is-outlined{background-color:transparent;border-color:#282f2f;box-shadow:none;color:#282f2f}html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined:hover,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined:focus,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-focused,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-focused{background-color:#fff;color:#282f2f}html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #282f2f #282f2f !important}html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined[disabled],html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-dark.is-inverted.is-outlined,fieldset[disabled] html.theme--documenter-dark .content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-primary,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink{background-color:#375a7f;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-primary:hover,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:hover,html.theme--documenter-dark .button.is-primary.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#335476;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-primary:focus,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:focus,html.theme--documenter-dark .button.is-primary.is-focused,html.theme--documenter-dark .docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-primary:focus:not(:active),html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:focus:not(:active),html.theme--documenter-dark .button.is-primary.is-focused:not(:active),html.theme--documenter-dark .docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(55,90,127,0.25)}html.theme--documenter-dark .button.is-primary:active,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:active,html.theme--documenter-dark .button.is-primary.is-active,html.theme--documenter-dark .docstring>section>a.button.is-active.docs-sourcelink{background-color:#2f4d6d;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-primary[disabled],html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-primary,fieldset[disabled] html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink{background-color:#375a7f;border-color:#375a7f;box-shadow:none}html.theme--documenter-dark .button.is-primary.is-inverted,html.theme--documenter-dark .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#375a7f}html.theme--documenter-dark .button.is-primary.is-inverted:hover,html.theme--documenter-dark .docstring>section>a.button.is-inverted.docs-sourcelink:hover,html.theme--documenter-dark .button.is-primary.is-inverted.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}html.theme--documenter-dark .button.is-primary.is-inverted[disabled],html.theme--documenter-dark .docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-primary.is-inverted,fieldset[disabled] html.theme--documenter-dark .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#375a7f}html.theme--documenter-dark .button.is-primary.is-loading::after,html.theme--documenter-dark .docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-primary.is-outlined,html.theme--documenter-dark .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#375a7f;color:#375a7f}html.theme--documenter-dark .button.is-primary.is-outlined:hover,html.theme--documenter-dark .docstring>section>a.button.is-outlined.docs-sourcelink:hover,html.theme--documenter-dark .button.is-primary.is-outlined.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,html.theme--documenter-dark .button.is-primary.is-outlined:focus,html.theme--documenter-dark .docstring>section>a.button.is-outlined.docs-sourcelink:focus,html.theme--documenter-dark .button.is-primary.is-outlined.is-focused,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#375a7f;border-color:#375a7f;color:#fff}html.theme--documenter-dark .button.is-primary.is-outlined.is-loading::after,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #375a7f #375a7f !important}html.theme--documenter-dark .button.is-primary.is-outlined.is-loading:hover::after,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--documenter-dark .button.is-primary.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--documenter-dark .button.is-primary.is-outlined.is-loading:focus::after,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--documenter-dark .button.is-primary.is-outlined.is-loading.is-focused::after,html.theme--documenter-dark .docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-primary.is-outlined[disabled],html.theme--documenter-dark .docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-primary.is-outlined,fieldset[disabled] html.theme--documenter-dark .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#375a7f;box-shadow:none;color:#375a7f}html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined:hover,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined:focus,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-focused,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#375a7f}html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #375a7f #375a7f !important}html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined[disabled],html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-primary.is-inverted.is-outlined,fieldset[disabled] html.theme--documenter-dark .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-primary.is-light,html.theme--documenter-dark .docstring>section>a.button.is-light.docs-sourcelink{background-color:#f1f5f9;color:#4d7eb2}html.theme--documenter-dark .button.is-primary.is-light:hover,html.theme--documenter-dark .docstring>section>a.button.is-light.docs-sourcelink:hover,html.theme--documenter-dark .button.is-primary.is-light.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#e8eef5;border-color:transparent;color:#4d7eb2}html.theme--documenter-dark .button.is-primary.is-light:active,html.theme--documenter-dark .docstring>section>a.button.is-light.docs-sourcelink:active,html.theme--documenter-dark .button.is-primary.is-light.is-active,html.theme--documenter-dark .docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#dfe8f1;border-color:transparent;color:#4d7eb2}html.theme--documenter-dark .button.is-link{background-color:#1abc9c;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-link:hover,html.theme--documenter-dark .button.is-link.is-hovered{background-color:#18b193;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-link:focus,html.theme--documenter-dark .button.is-link.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-link:focus:not(:active),html.theme--documenter-dark .button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(26,188,156,0.25)}html.theme--documenter-dark .button.is-link:active,html.theme--documenter-dark .button.is-link.is-active{background-color:#17a689;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-link[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-link{background-color:#1abc9c;border-color:#1abc9c;box-shadow:none}html.theme--documenter-dark .button.is-link.is-inverted{background-color:#fff;color:#1abc9c}html.theme--documenter-dark .button.is-link.is-inverted:hover,html.theme--documenter-dark .button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-link.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#1abc9c}html.theme--documenter-dark .button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-link.is-outlined{background-color:transparent;border-color:#1abc9c;color:#1abc9c}html.theme--documenter-dark .button.is-link.is-outlined:hover,html.theme--documenter-dark .button.is-link.is-outlined.is-hovered,html.theme--documenter-dark .button.is-link.is-outlined:focus,html.theme--documenter-dark .button.is-link.is-outlined.is-focused{background-color:#1abc9c;border-color:#1abc9c;color:#fff}html.theme--documenter-dark .button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #1abc9c #1abc9c !important}html.theme--documenter-dark .button.is-link.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-link.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-link.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-link.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-link.is-outlined{background-color:transparent;border-color:#1abc9c;box-shadow:none;color:#1abc9c}html.theme--documenter-dark .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-link.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#1abc9c}html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #1abc9c #1abc9c !important}html.theme--documenter-dark .button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-link.is-light{background-color:#edfdf9;color:#15987e}html.theme--documenter-dark .button.is-link.is-light:hover,html.theme--documenter-dark .button.is-link.is-light.is-hovered{background-color:#e2fbf6;border-color:transparent;color:#15987e}html.theme--documenter-dark .button.is-link.is-light:active,html.theme--documenter-dark .button.is-link.is-light.is-active{background-color:#d7f9f3;border-color:transparent;color:#15987e}html.theme--documenter-dark .button.is-info{background-color:#3c5dcd;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info:hover,html.theme--documenter-dark .button.is-info.is-hovered{background-color:#3355c9;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info:focus,html.theme--documenter-dark .button.is-info.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info:focus:not(:active),html.theme--documenter-dark .button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}html.theme--documenter-dark .button.is-info:active,html.theme--documenter-dark .button.is-info.is-active{background-color:#3151bf;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-info{background-color:#3c5dcd;border-color:#3c5dcd;box-shadow:none}html.theme--documenter-dark .button.is-info.is-inverted{background-color:#fff;color:#3c5dcd}html.theme--documenter-dark .button.is-info.is-inverted:hover,html.theme--documenter-dark .button.is-info.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-info.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-info.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#3c5dcd}html.theme--documenter-dark .button.is-info.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-info.is-outlined{background-color:transparent;border-color:#3c5dcd;color:#3c5dcd}html.theme--documenter-dark .button.is-info.is-outlined:hover,html.theme--documenter-dark .button.is-info.is-outlined.is-hovered,html.theme--documenter-dark .button.is-info.is-outlined:focus,html.theme--documenter-dark .button.is-info.is-outlined.is-focused{background-color:#3c5dcd;border-color:#3c5dcd;color:#fff}html.theme--documenter-dark .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #3c5dcd #3c5dcd !important}html.theme--documenter-dark .button.is-info.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-info.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-info.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-info.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-info.is-outlined{background-color:transparent;border-color:#3c5dcd;box-shadow:none;color:#3c5dcd}html.theme--documenter-dark .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-info.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-focused{background-color:#fff;color:#3c5dcd}html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #3c5dcd #3c5dcd !important}html.theme--documenter-dark .button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-info.is-light{background-color:#eff2fb;color:#3253c3}html.theme--documenter-dark .button.is-info.is-light:hover,html.theme--documenter-dark .button.is-info.is-light.is-hovered{background-color:#e5e9f8;border-color:transparent;color:#3253c3}html.theme--documenter-dark .button.is-info.is-light:active,html.theme--documenter-dark .button.is-info.is-light.is-active{background-color:#dae1f6;border-color:transparent;color:#3253c3}html.theme--documenter-dark .button.is-success{background-color:#259a12;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success:hover,html.theme--documenter-dark .button.is-success.is-hovered{background-color:#228f11;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success:focus,html.theme--documenter-dark .button.is-success.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success:focus:not(:active),html.theme--documenter-dark .button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}html.theme--documenter-dark .button.is-success:active,html.theme--documenter-dark .button.is-success.is-active{background-color:#20830f;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-success{background-color:#259a12;border-color:#259a12;box-shadow:none}html.theme--documenter-dark .button.is-success.is-inverted{background-color:#fff;color:#259a12}html.theme--documenter-dark .button.is-success.is-inverted:hover,html.theme--documenter-dark .button.is-success.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-success.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-success.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#259a12}html.theme--documenter-dark .button.is-success.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-success.is-outlined{background-color:transparent;border-color:#259a12;color:#259a12}html.theme--documenter-dark .button.is-success.is-outlined:hover,html.theme--documenter-dark .button.is-success.is-outlined.is-hovered,html.theme--documenter-dark .button.is-success.is-outlined:focus,html.theme--documenter-dark .button.is-success.is-outlined.is-focused{background-color:#259a12;border-color:#259a12;color:#fff}html.theme--documenter-dark .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #259a12 #259a12 !important}html.theme--documenter-dark .button.is-success.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-success.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-success.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-success.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-success.is-outlined{background-color:transparent;border-color:#259a12;box-shadow:none;color:#259a12}html.theme--documenter-dark .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-success.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-focused{background-color:#fff;color:#259a12}html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #259a12 #259a12 !important}html.theme--documenter-dark .button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-success.is-light{background-color:#effded;color:#2ec016}html.theme--documenter-dark .button.is-success.is-light:hover,html.theme--documenter-dark .button.is-success.is-light.is-hovered{background-color:#e5fce1;border-color:transparent;color:#2ec016}html.theme--documenter-dark .button.is-success.is-light:active,html.theme--documenter-dark .button.is-success.is-light.is-active{background-color:#dbfad6;border-color:transparent;color:#2ec016}html.theme--documenter-dark .button.is-warning{background-color:#f4c72f;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning:hover,html.theme--documenter-dark .button.is-warning.is-hovered{background-color:#f3c423;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning:focus,html.theme--documenter-dark .button.is-warning.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning:focus:not(:active),html.theme--documenter-dark .button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(244,199,47,0.25)}html.theme--documenter-dark .button.is-warning:active,html.theme--documenter-dark .button.is-warning.is-active{background-color:#f3c017;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning{background-color:#f4c72f;border-color:#f4c72f;box-shadow:none}html.theme--documenter-dark .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);color:#f4c72f}html.theme--documenter-dark .button.is-warning.is-inverted:hover,html.theme--documenter-dark .button.is-warning.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f4c72f}html.theme--documenter-dark .button.is-warning.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--documenter-dark .button.is-warning.is-outlined{background-color:transparent;border-color:#f4c72f;color:#f4c72f}html.theme--documenter-dark .button.is-warning.is-outlined:hover,html.theme--documenter-dark .button.is-warning.is-outlined.is-hovered,html.theme--documenter-dark .button.is-warning.is-outlined:focus,html.theme--documenter-dark .button.is-warning.is-outlined.is-focused{background-color:#f4c72f;border-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #f4c72f #f4c72f !important}html.theme--documenter-dark .button.is-warning.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-warning.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-warning.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}html.theme--documenter-dark .button.is-warning.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning.is-outlined{background-color:transparent;border-color:#f4c72f;box-shadow:none;color:#f4c72f}html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f4c72f}html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f4c72f #f4c72f !important}html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .button.is-warning.is-light{background-color:#fefaec;color:#8c6e07}html.theme--documenter-dark .button.is-warning.is-light:hover,html.theme--documenter-dark .button.is-warning.is-light.is-hovered{background-color:#fdf7e0;border-color:transparent;color:#8c6e07}html.theme--documenter-dark .button.is-warning.is-light:active,html.theme--documenter-dark .button.is-warning.is-light.is-active{background-color:#fdf3d3;border-color:transparent;color:#8c6e07}html.theme--documenter-dark .button.is-danger{background-color:#cb3c33;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger:hover,html.theme--documenter-dark .button.is-danger.is-hovered{background-color:#c13930;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger:focus,html.theme--documenter-dark .button.is-danger.is-focused{border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger:focus:not(:active),html.theme--documenter-dark .button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}html.theme--documenter-dark .button.is-danger:active,html.theme--documenter-dark .button.is-danger.is-active{background-color:#b7362e;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-danger{background-color:#cb3c33;border-color:#cb3c33;box-shadow:none}html.theme--documenter-dark .button.is-danger.is-inverted{background-color:#fff;color:#cb3c33}html.theme--documenter-dark .button.is-danger.is-inverted:hover,html.theme--documenter-dark .button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-danger.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#cb3c33}html.theme--documenter-dark .button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-danger.is-outlined{background-color:transparent;border-color:#cb3c33;color:#cb3c33}html.theme--documenter-dark .button.is-danger.is-outlined:hover,html.theme--documenter-dark .button.is-danger.is-outlined.is-hovered,html.theme--documenter-dark .button.is-danger.is-outlined:focus,html.theme--documenter-dark .button.is-danger.is-outlined.is-focused{background-color:#cb3c33;border-color:#cb3c33;color:#fff}html.theme--documenter-dark .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #cb3c33 #cb3c33 !important}html.theme--documenter-dark .button.is-danger.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-danger.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-danger.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-danger.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-danger.is-outlined{background-color:transparent;border-color:#cb3c33;box-shadow:none;color:#cb3c33}html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined:hover,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-hovered,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined:focus,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#cb3c33}html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-loading:hover::after,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-loading:focus::after,html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #cb3c33 #cb3c33 !important}html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-danger.is-light{background-color:#fbefef;color:#c03930}html.theme--documenter-dark .button.is-danger.is-light:hover,html.theme--documenter-dark .button.is-danger.is-light.is-hovered{background-color:#f8e6e5;border-color:transparent;color:#c03930}html.theme--documenter-dark .button.is-danger.is-light:active,html.theme--documenter-dark .button.is-danger.is-light.is-active{background-color:#f6dcda;border-color:transparent;color:#c03930}html.theme--documenter-dark .button.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}html.theme--documenter-dark .button.is-small:not(.is-rounded),html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:3px}html.theme--documenter-dark .button.is-normal{font-size:1rem}html.theme--documenter-dark .button.is-medium{font-size:1.25rem}html.theme--documenter-dark .button.is-large{font-size:1.5rem}html.theme--documenter-dark .button[disabled],fieldset[disabled] html.theme--documenter-dark .button{background-color:#8c9b9d;border-color:#5e6d6f;box-shadow:none;opacity:.5}html.theme--documenter-dark .button.is-fullwidth{display:flex;width:100%}html.theme--documenter-dark .button.is-loading{color:transparent !important;pointer-events:none}html.theme--documenter-dark .button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}html.theme--documenter-dark .button.is-static{background-color:#282f2f;border-color:#5e6d6f;color:#dbdee0;box-shadow:none;pointer-events:none}html.theme--documenter-dark .button.is-rounded,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}html.theme--documenter-dark .buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--documenter-dark .buttons .button{margin-bottom:0.5rem}html.theme--documenter-dark .buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}html.theme--documenter-dark .buttons:last-child{margin-bottom:-0.5rem}html.theme--documenter-dark .buttons:not(:last-child){margin-bottom:1rem}html.theme--documenter-dark .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}html.theme--documenter-dark .buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:3px}html.theme--documenter-dark .buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}html.theme--documenter-dark .buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}html.theme--documenter-dark .buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}html.theme--documenter-dark .buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}html.theme--documenter-dark .buttons.has-addons .button:last-child{margin-right:0}html.theme--documenter-dark .buttons.has-addons .button:hover,html.theme--documenter-dark .buttons.has-addons .button.is-hovered{z-index:2}html.theme--documenter-dark .buttons.has-addons .button:focus,html.theme--documenter-dark .buttons.has-addons .button.is-focused,html.theme--documenter-dark .buttons.has-addons .button:active,html.theme--documenter-dark .buttons.has-addons .button.is-active,html.theme--documenter-dark .buttons.has-addons .button.is-selected{z-index:3}html.theme--documenter-dark .buttons.has-addons .button:focus:hover,html.theme--documenter-dark .buttons.has-addons .button.is-focused:hover,html.theme--documenter-dark .buttons.has-addons .button:active:hover,html.theme--documenter-dark .buttons.has-addons .button.is-active:hover,html.theme--documenter-dark .buttons.has-addons .button.is-selected:hover{z-index:4}html.theme--documenter-dark .buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .buttons.is-centered{justify-content:center}html.theme--documenter-dark .buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}html.theme--documenter-dark .buttons.is-right{justify-content:flex-end}html.theme--documenter-dark .buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){html.theme--documenter-dark .button.is-responsive.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}html.theme--documenter-dark .button.is-responsive,html.theme--documenter-dark .button.is-responsive.is-normal{font-size:.65625rem}html.theme--documenter-dark .button.is-responsive.is-medium{font-size:.75rem}html.theme--documenter-dark .button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .button.is-responsive.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}html.theme--documenter-dark .button.is-responsive,html.theme--documenter-dark .button.is-responsive.is-normal{font-size:.75rem}html.theme--documenter-dark .button.is-responsive.is-medium{font-size:1rem}html.theme--documenter-dark .button.is-responsive.is-large{font-size:1.25rem}}html.theme--documenter-dark .container{flex-grow:1;margin:0 auto;position:relative;width:auto}html.theme--documenter-dark .container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){html.theme--documenter-dark .container{max-width:992px}}@media screen and (max-width: 1215px){html.theme--documenter-dark .container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){html.theme--documenter-dark .container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){html.theme--documenter-dark .container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){html.theme--documenter-dark .container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}html.theme--documenter-dark .content li+li{margin-top:0.25em}html.theme--documenter-dark .content p:not(:last-child),html.theme--documenter-dark .content dl:not(:last-child),html.theme--documenter-dark .content ol:not(:last-child),html.theme--documenter-dark .content ul:not(:last-child),html.theme--documenter-dark .content blockquote:not(:last-child),html.theme--documenter-dark .content pre:not(:last-child),html.theme--documenter-dark .content table:not(:last-child){margin-bottom:1em}html.theme--documenter-dark .content h1,html.theme--documenter-dark .content h2,html.theme--documenter-dark .content h3,html.theme--documenter-dark .content h4,html.theme--documenter-dark .content h5,html.theme--documenter-dark .content h6{color:#f2f2f2;font-weight:600;line-height:1.125}html.theme--documenter-dark .content h1{font-size:2em;margin-bottom:0.5em}html.theme--documenter-dark .content h1:not(:first-child){margin-top:1em}html.theme--documenter-dark .content h2{font-size:1.75em;margin-bottom:0.5714em}html.theme--documenter-dark .content h2:not(:first-child){margin-top:1.1428em}html.theme--documenter-dark .content h3{font-size:1.5em;margin-bottom:0.6666em}html.theme--documenter-dark .content h3:not(:first-child){margin-top:1.3333em}html.theme--documenter-dark .content h4{font-size:1.25em;margin-bottom:0.8em}html.theme--documenter-dark .content h5{font-size:1.125em;margin-bottom:0.8888em}html.theme--documenter-dark .content h6{font-size:1em;margin-bottom:1em}html.theme--documenter-dark .content blockquote{background-color:#282f2f;border-left:5px solid #5e6d6f;padding:1.25em 1.5em}html.theme--documenter-dark .content ol{list-style-position:outside;margin-left:2em;margin-top:1em}html.theme--documenter-dark .content ol:not([type]){list-style-type:decimal}html.theme--documenter-dark .content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}html.theme--documenter-dark .content ol.is-lower-roman:not([type]){list-style-type:lower-roman}html.theme--documenter-dark .content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}html.theme--documenter-dark .content ol.is-upper-roman:not([type]){list-style-type:upper-roman}html.theme--documenter-dark .content ul{list-style:disc outside;margin-left:2em;margin-top:1em}html.theme--documenter-dark .content ul ul{list-style-type:circle;margin-top:0.5em}html.theme--documenter-dark .content ul ul ul{list-style-type:square}html.theme--documenter-dark .content dd{margin-left:2em}html.theme--documenter-dark .content figure{margin-left:2em;margin-right:2em;text-align:center}html.theme--documenter-dark .content figure:not(:first-child){margin-top:2em}html.theme--documenter-dark .content figure:not(:last-child){margin-bottom:2em}html.theme--documenter-dark .content figure img{display:inline-block}html.theme--documenter-dark .content figure figcaption{font-style:italic}html.theme--documenter-dark .content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}html.theme--documenter-dark .content sup,html.theme--documenter-dark .content sub{font-size:75%}html.theme--documenter-dark .content table{width:100%}html.theme--documenter-dark .content table td,html.theme--documenter-dark .content table th{border:1px solid #5e6d6f;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--documenter-dark .content table th{color:#f2f2f2}html.theme--documenter-dark .content table th:not([align]){text-align:inherit}html.theme--documenter-dark .content table thead td,html.theme--documenter-dark .content table thead th{border-width:0 0 2px;color:#f2f2f2}html.theme--documenter-dark .content table tfoot td,html.theme--documenter-dark .content table tfoot th{border-width:2px 0 0;color:#f2f2f2}html.theme--documenter-dark .content table tbody tr:last-child td,html.theme--documenter-dark .content table tbody tr:last-child th{border-bottom-width:0}html.theme--documenter-dark .content .tabs li+li{margin-top:0}html.theme--documenter-dark .content.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}html.theme--documenter-dark .content.is-normal{font-size:1rem}html.theme--documenter-dark .content.is-medium{font-size:1.25rem}html.theme--documenter-dark .content.is-large{font-size:1.5rem}html.theme--documenter-dark .icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}html.theme--documenter-dark .icon.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}html.theme--documenter-dark .icon.is-medium{height:2rem;width:2rem}html.theme--documenter-dark .icon.is-large{height:3rem;width:3rem}html.theme--documenter-dark .icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}html.theme--documenter-dark .icon-text .icon{flex-grow:0;flex-shrink:0}html.theme--documenter-dark .icon-text .icon:not(:last-child){margin-right:.25em}html.theme--documenter-dark .icon-text .icon:not(:first-child){margin-left:.25em}html.theme--documenter-dark div.icon-text{display:flex}html.theme--documenter-dark .image,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img{display:block;position:relative}html.theme--documenter-dark .image img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}html.theme--documenter-dark .image img.is-rounded,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}html.theme--documenter-dark .image.is-fullwidth,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}html.theme--documenter-dark .image.is-square img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-square img,html.theme--documenter-dark .image.is-square .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,html.theme--documenter-dark .image.is-1by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by1 img,html.theme--documenter-dark .image.is-1by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,html.theme--documenter-dark .image.is-5by4 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by4 img,html.theme--documenter-dark .image.is-5by4 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,html.theme--documenter-dark .image.is-4by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by3 img,html.theme--documenter-dark .image.is-4by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,html.theme--documenter-dark .image.is-3by2 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by2 img,html.theme--documenter-dark .image.is-3by2 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,html.theme--documenter-dark .image.is-5by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by3 img,html.theme--documenter-dark .image.is-5by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,html.theme--documenter-dark .image.is-16by9 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16by9 img,html.theme--documenter-dark .image.is-16by9 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,html.theme--documenter-dark .image.is-2by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by1 img,html.theme--documenter-dark .image.is-2by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,html.theme--documenter-dark .image.is-3by1 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by1 img,html.theme--documenter-dark .image.is-3by1 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,html.theme--documenter-dark .image.is-4by5 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by5 img,html.theme--documenter-dark .image.is-4by5 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,html.theme--documenter-dark .image.is-3by4 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by4 img,html.theme--documenter-dark .image.is-3by4 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,html.theme--documenter-dark .image.is-2by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by3 img,html.theme--documenter-dark .image.is-2by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,html.theme--documenter-dark .image.is-3by5 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by5 img,html.theme--documenter-dark .image.is-3by5 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,html.theme--documenter-dark .image.is-9by16 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-9by16 img,html.theme--documenter-dark .image.is-9by16 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,html.theme--documenter-dark .image.is-1by2 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by2 img,html.theme--documenter-dark .image.is-1by2 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,html.theme--documenter-dark .image.is-1by3 img,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by3 img,html.theme--documenter-dark .image.is-1by3 .has-ratio,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}html.theme--documenter-dark .image.is-square,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-square,html.theme--documenter-dark .image.is-1by1,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}html.theme--documenter-dark .image.is-5by4,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}html.theme--documenter-dark .image.is-4by3,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}html.theme--documenter-dark .image.is-3by2,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}html.theme--documenter-dark .image.is-5by3,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}html.theme--documenter-dark .image.is-16by9,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}html.theme--documenter-dark .image.is-2by1,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}html.theme--documenter-dark .image.is-3by1,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}html.theme--documenter-dark .image.is-4by5,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}html.theme--documenter-dark .image.is-3by4,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}html.theme--documenter-dark .image.is-2by3,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}html.theme--documenter-dark .image.is-3by5,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}html.theme--documenter-dark .image.is-9by16,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}html.theme--documenter-dark .image.is-1by2,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}html.theme--documenter-dark .image.is-1by3,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}html.theme--documenter-dark .image.is-16x16,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}html.theme--documenter-dark .image.is-24x24,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}html.theme--documenter-dark .image.is-32x32,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}html.theme--documenter-dark .image.is-48x48,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}html.theme--documenter-dark .image.is-64x64,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}html.theme--documenter-dark .image.is-96x96,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}html.theme--documenter-dark .image.is-128x128,html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}html.theme--documenter-dark .notification{background-color:#282f2f;border-radius:.4em;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}html.theme--documenter-dark .notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--documenter-dark .notification strong{color:currentColor}html.theme--documenter-dark .notification code,html.theme--documenter-dark .notification pre{background:#fff}html.theme--documenter-dark .notification pre code{background:transparent}html.theme--documenter-dark .notification>.delete{right:.5rem;position:absolute;top:0.5rem}html.theme--documenter-dark .notification .title,html.theme--documenter-dark .notification .subtitle,html.theme--documenter-dark .notification .content{color:currentColor}html.theme--documenter-dark .notification.is-white{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .notification.is-black{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .notification.is-light{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .notification.is-dark,html.theme--documenter-dark .content kbd.notification{background-color:#282f2f;color:#fff}html.theme--documenter-dark .notification.is-primary,html.theme--documenter-dark .docstring>section>a.notification.docs-sourcelink{background-color:#375a7f;color:#fff}html.theme--documenter-dark .notification.is-primary.is-light,html.theme--documenter-dark .docstring>section>a.notification.is-light.docs-sourcelink{background-color:#f1f5f9;color:#4d7eb2}html.theme--documenter-dark .notification.is-link{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .notification.is-link.is-light{background-color:#edfdf9;color:#15987e}html.theme--documenter-dark .notification.is-info{background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .notification.is-info.is-light{background-color:#eff2fb;color:#3253c3}html.theme--documenter-dark .notification.is-success{background-color:#259a12;color:#fff}html.theme--documenter-dark .notification.is-success.is-light{background-color:#effded;color:#2ec016}html.theme--documenter-dark .notification.is-warning{background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .notification.is-warning.is-light{background-color:#fefaec;color:#8c6e07}html.theme--documenter-dark .notification.is-danger{background-color:#cb3c33;color:#fff}html.theme--documenter-dark .notification.is-danger.is-light{background-color:#fbefef;color:#c03930}html.theme--documenter-dark .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}html.theme--documenter-dark .progress::-webkit-progress-bar{background-color:#343c3d}html.theme--documenter-dark .progress::-webkit-progress-value{background-color:#dbdee0}html.theme--documenter-dark .progress::-moz-progress-bar{background-color:#dbdee0}html.theme--documenter-dark .progress::-ms-fill{background-color:#dbdee0;border:none}html.theme--documenter-dark .progress.is-white::-webkit-progress-value{background-color:#fff}html.theme--documenter-dark .progress.is-white::-moz-progress-bar{background-color:#fff}html.theme--documenter-dark .progress.is-white::-ms-fill{background-color:#fff}html.theme--documenter-dark .progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-black::-webkit-progress-value{background-color:#0a0a0a}html.theme--documenter-dark .progress.is-black::-moz-progress-bar{background-color:#0a0a0a}html.theme--documenter-dark .progress.is-black::-ms-fill{background-color:#0a0a0a}html.theme--documenter-dark .progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-light::-webkit-progress-value{background-color:#ecf0f1}html.theme--documenter-dark .progress.is-light::-moz-progress-bar{background-color:#ecf0f1}html.theme--documenter-dark .progress.is-light::-ms-fill{background-color:#ecf0f1}html.theme--documenter-dark .progress.is-light:indeterminate{background-image:linear-gradient(to right, #ecf0f1 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-dark::-webkit-progress-value,html.theme--documenter-dark .content kbd.progress::-webkit-progress-value{background-color:#282f2f}html.theme--documenter-dark .progress.is-dark::-moz-progress-bar,html.theme--documenter-dark .content kbd.progress::-moz-progress-bar{background-color:#282f2f}html.theme--documenter-dark .progress.is-dark::-ms-fill,html.theme--documenter-dark .content kbd.progress::-ms-fill{background-color:#282f2f}html.theme--documenter-dark .progress.is-dark:indeterminate,html.theme--documenter-dark .content kbd.progress:indeterminate{background-image:linear-gradient(to right, #282f2f 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-primary::-webkit-progress-value,html.theme--documenter-dark .docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#375a7f}html.theme--documenter-dark .progress.is-primary::-moz-progress-bar,html.theme--documenter-dark .docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#375a7f}html.theme--documenter-dark .progress.is-primary::-ms-fill,html.theme--documenter-dark .docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#375a7f}html.theme--documenter-dark .progress.is-primary:indeterminate,html.theme--documenter-dark .docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #375a7f 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-link::-webkit-progress-value{background-color:#1abc9c}html.theme--documenter-dark .progress.is-link::-moz-progress-bar{background-color:#1abc9c}html.theme--documenter-dark .progress.is-link::-ms-fill{background-color:#1abc9c}html.theme--documenter-dark .progress.is-link:indeterminate{background-image:linear-gradient(to right, #1abc9c 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-info::-webkit-progress-value{background-color:#3c5dcd}html.theme--documenter-dark .progress.is-info::-moz-progress-bar{background-color:#3c5dcd}html.theme--documenter-dark .progress.is-info::-ms-fill{background-color:#3c5dcd}html.theme--documenter-dark .progress.is-info:indeterminate{background-image:linear-gradient(to right, #3c5dcd 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-success::-webkit-progress-value{background-color:#259a12}html.theme--documenter-dark .progress.is-success::-moz-progress-bar{background-color:#259a12}html.theme--documenter-dark .progress.is-success::-ms-fill{background-color:#259a12}html.theme--documenter-dark .progress.is-success:indeterminate{background-image:linear-gradient(to right, #259a12 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-warning::-webkit-progress-value{background-color:#f4c72f}html.theme--documenter-dark .progress.is-warning::-moz-progress-bar{background-color:#f4c72f}html.theme--documenter-dark .progress.is-warning::-ms-fill{background-color:#f4c72f}html.theme--documenter-dark .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #f4c72f 30%, #343c3d 30%)}html.theme--documenter-dark .progress.is-danger::-webkit-progress-value{background-color:#cb3c33}html.theme--documenter-dark .progress.is-danger::-moz-progress-bar{background-color:#cb3c33}html.theme--documenter-dark .progress.is-danger::-ms-fill{background-color:#cb3c33}html.theme--documenter-dark .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #cb3c33 30%, #343c3d 30%)}html.theme--documenter-dark .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#343c3d;background-image:linear-gradient(to right, #fff 30%, #343c3d 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}html.theme--documenter-dark .progress:indeterminate::-webkit-progress-bar{background-color:transparent}html.theme--documenter-dark .progress:indeterminate::-moz-progress-bar{background-color:transparent}html.theme--documenter-dark .progress:indeterminate::-ms-fill{animation-name:none}html.theme--documenter-dark .progress.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}html.theme--documenter-dark .progress.is-medium{height:1.25rem}html.theme--documenter-dark .progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}html.theme--documenter-dark .table{background-color:#343c3d;color:#fff}html.theme--documenter-dark .table td,html.theme--documenter-dark .table th{border:1px solid #5e6d6f;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}html.theme--documenter-dark .table td.is-white,html.theme--documenter-dark .table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--documenter-dark .table td.is-black,html.theme--documenter-dark .table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--documenter-dark .table td.is-light,html.theme--documenter-dark .table th.is-light{background-color:#ecf0f1;border-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .table td.is-dark,html.theme--documenter-dark .table th.is-dark{background-color:#282f2f;border-color:#282f2f;color:#fff}html.theme--documenter-dark .table td.is-primary,html.theme--documenter-dark .table th.is-primary{background-color:#375a7f;border-color:#375a7f;color:#fff}html.theme--documenter-dark .table td.is-link,html.theme--documenter-dark .table th.is-link{background-color:#1abc9c;border-color:#1abc9c;color:#fff}html.theme--documenter-dark .table td.is-info,html.theme--documenter-dark .table th.is-info{background-color:#3c5dcd;border-color:#3c5dcd;color:#fff}html.theme--documenter-dark .table td.is-success,html.theme--documenter-dark .table th.is-success{background-color:#259a12;border-color:#259a12;color:#fff}html.theme--documenter-dark .table td.is-warning,html.theme--documenter-dark .table th.is-warning{background-color:#f4c72f;border-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .table td.is-danger,html.theme--documenter-dark .table th.is-danger{background-color:#cb3c33;border-color:#cb3c33;color:#fff}html.theme--documenter-dark .table td.is-narrow,html.theme--documenter-dark .table th.is-narrow{white-space:nowrap;width:1%}html.theme--documenter-dark .table td.is-selected,html.theme--documenter-dark .table th.is-selected{background-color:#375a7f;color:#fff}html.theme--documenter-dark .table td.is-selected a,html.theme--documenter-dark .table td.is-selected strong,html.theme--documenter-dark .table th.is-selected a,html.theme--documenter-dark .table th.is-selected strong{color:currentColor}html.theme--documenter-dark .table td.is-vcentered,html.theme--documenter-dark .table th.is-vcentered{vertical-align:middle}html.theme--documenter-dark .table th{color:#f2f2f2}html.theme--documenter-dark .table th:not([align]){text-align:left}html.theme--documenter-dark .table tr.is-selected{background-color:#375a7f;color:#fff}html.theme--documenter-dark .table tr.is-selected a,html.theme--documenter-dark .table tr.is-selected strong{color:currentColor}html.theme--documenter-dark .table tr.is-selected td,html.theme--documenter-dark .table tr.is-selected th{border-color:#fff;color:currentColor}html.theme--documenter-dark .table thead{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .table thead td,html.theme--documenter-dark .table thead th{border-width:0 0 2px;color:#f2f2f2}html.theme--documenter-dark .table tfoot{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .table tfoot td,html.theme--documenter-dark .table tfoot th{border-width:2px 0 0;color:#f2f2f2}html.theme--documenter-dark .table tbody{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .table tbody tr:last-child td,html.theme--documenter-dark .table tbody tr:last-child th{border-bottom-width:0}html.theme--documenter-dark .table.is-bordered td,html.theme--documenter-dark .table.is-bordered th{border-width:1px}html.theme--documenter-dark .table.is-bordered tr:last-child td,html.theme--documenter-dark .table.is-bordered tr:last-child th{border-bottom-width:1px}html.theme--documenter-dark .table.is-fullwidth{width:100%}html.theme--documenter-dark .table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#282f2f}html.theme--documenter-dark .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#282f2f}html.theme--documenter-dark .table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#2d3435}html.theme--documenter-dark .table.is-narrow td,html.theme--documenter-dark .table.is-narrow th{padding:0.25em 0.5em}html.theme--documenter-dark .table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#282f2f}html.theme--documenter-dark .table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}html.theme--documenter-dark .tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--documenter-dark .tags .tag,html.theme--documenter-dark .tags .content kbd,html.theme--documenter-dark .content .tags kbd,html.theme--documenter-dark .tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}html.theme--documenter-dark .tags .tag:not(:last-child),html.theme--documenter-dark .tags .content kbd:not(:last-child),html.theme--documenter-dark .content .tags kbd:not(:last-child),html.theme--documenter-dark .tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}html.theme--documenter-dark .tags:last-child{margin-bottom:-0.5rem}html.theme--documenter-dark .tags:not(:last-child){margin-bottom:1rem}html.theme--documenter-dark .tags.are-medium .tag:not(.is-normal):not(.is-large),html.theme--documenter-dark .tags.are-medium .content kbd:not(.is-normal):not(.is-large),html.theme--documenter-dark .content .tags.are-medium kbd:not(.is-normal):not(.is-large),html.theme--documenter-dark .tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}html.theme--documenter-dark .tags.are-large .tag:not(.is-normal):not(.is-medium),html.theme--documenter-dark .tags.are-large .content kbd:not(.is-normal):not(.is-medium),html.theme--documenter-dark .content .tags.are-large kbd:not(.is-normal):not(.is-medium),html.theme--documenter-dark .tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}html.theme--documenter-dark .tags.is-centered{justify-content:center}html.theme--documenter-dark .tags.is-centered .tag,html.theme--documenter-dark .tags.is-centered .content kbd,html.theme--documenter-dark .content .tags.is-centered kbd,html.theme--documenter-dark .tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}html.theme--documenter-dark .tags.is-right{justify-content:flex-end}html.theme--documenter-dark .tags.is-right .tag:not(:first-child),html.theme--documenter-dark .tags.is-right .content kbd:not(:first-child),html.theme--documenter-dark .content .tags.is-right kbd:not(:first-child),html.theme--documenter-dark .tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}html.theme--documenter-dark .tags.is-right .tag:not(:last-child),html.theme--documenter-dark .tags.is-right .content kbd:not(:last-child),html.theme--documenter-dark .content .tags.is-right kbd:not(:last-child),html.theme--documenter-dark .tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}html.theme--documenter-dark .tags.has-addons .tag,html.theme--documenter-dark .tags.has-addons .content kbd,html.theme--documenter-dark .content .tags.has-addons kbd,html.theme--documenter-dark .tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}html.theme--documenter-dark .tags.has-addons .tag:not(:first-child),html.theme--documenter-dark .tags.has-addons .content kbd:not(:first-child),html.theme--documenter-dark .content .tags.has-addons kbd:not(:first-child),html.theme--documenter-dark .tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}html.theme--documenter-dark .tags.has-addons .tag:not(:last-child),html.theme--documenter-dark .tags.has-addons .content kbd:not(:last-child),html.theme--documenter-dark .content .tags.has-addons kbd:not(:last-child),html.theme--documenter-dark .tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}html.theme--documenter-dark .tag:not(body),html.theme--documenter-dark .content kbd:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#282f2f;border-radius:.4em;color:#fff;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}html.theme--documenter-dark .tag:not(body) .delete,html.theme--documenter-dark .content kbd:not(body) .delete,html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}html.theme--documenter-dark .tag.is-white:not(body),html.theme--documenter-dark .content kbd.is-white:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .tag.is-black:not(body),html.theme--documenter-dark .content kbd.is-black:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .tag.is-light:not(body),html.theme--documenter-dark .content kbd.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .tag.is-dark:not(body),html.theme--documenter-dark .content kbd:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-dark:not(body),html.theme--documenter-dark .content .docstring>section>kbd:not(body){background-color:#282f2f;color:#fff}html.theme--documenter-dark .tag.is-primary:not(body),html.theme--documenter-dark .content kbd.is-primary:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body){background-color:#375a7f;color:#fff}html.theme--documenter-dark .tag.is-primary.is-light:not(body),html.theme--documenter-dark .content kbd.is-primary.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f1f5f9;color:#4d7eb2}html.theme--documenter-dark .tag.is-link:not(body),html.theme--documenter-dark .content kbd.is-link:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#1abc9c;color:#fff}html.theme--documenter-dark .tag.is-link.is-light:not(body),html.theme--documenter-dark .content kbd.is-link.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#edfdf9;color:#15987e}html.theme--documenter-dark .tag.is-info:not(body),html.theme--documenter-dark .content kbd.is-info:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .tag.is-info.is-light:not(body),html.theme--documenter-dark .content kbd.is-info.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#eff2fb;color:#3253c3}html.theme--documenter-dark .tag.is-success:not(body),html.theme--documenter-dark .content kbd.is-success:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#259a12;color:#fff}html.theme--documenter-dark .tag.is-success.is-light:not(body),html.theme--documenter-dark .content kbd.is-success.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#effded;color:#2ec016}html.theme--documenter-dark .tag.is-warning:not(body),html.theme--documenter-dark .content kbd.is-warning:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .tag.is-warning.is-light:not(body),html.theme--documenter-dark .content kbd.is-warning.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fefaec;color:#8c6e07}html.theme--documenter-dark .tag.is-danger:not(body),html.theme--documenter-dark .content kbd.is-danger:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#cb3c33;color:#fff}html.theme--documenter-dark .tag.is-danger.is-light:not(body),html.theme--documenter-dark .content kbd.is-danger.is-light:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#fbefef;color:#c03930}html.theme--documenter-dark .tag.is-normal:not(body),html.theme--documenter-dark .content kbd.is-normal:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}html.theme--documenter-dark .tag.is-medium:not(body),html.theme--documenter-dark .content kbd.is-medium:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}html.theme--documenter-dark .tag.is-large:not(body),html.theme--documenter-dark .content kbd.is-large:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}html.theme--documenter-dark .tag:not(body) .icon:first-child:not(:last-child),html.theme--documenter-dark .content kbd:not(body) .icon:first-child:not(:last-child),html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}html.theme--documenter-dark .tag:not(body) .icon:last-child:not(:first-child),html.theme--documenter-dark .content kbd:not(body) .icon:last-child:not(:first-child),html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}html.theme--documenter-dark .tag:not(body) .icon:first-child:last-child,html.theme--documenter-dark .content kbd:not(body) .icon:first-child:last-child,html.theme--documenter-dark .docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}html.theme--documenter-dark .tag.is-delete:not(body),html.theme--documenter-dark .content kbd.is-delete:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}html.theme--documenter-dark .tag.is-delete:not(body)::before,html.theme--documenter-dark .content kbd.is-delete:not(body)::before,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body)::before,html.theme--documenter-dark .tag.is-delete:not(body)::after,html.theme--documenter-dark .content kbd.is-delete:not(body)::after,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}html.theme--documenter-dark .tag.is-delete:not(body)::before,html.theme--documenter-dark .content kbd.is-delete:not(body)::before,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}html.theme--documenter-dark .tag.is-delete:not(body)::after,html.theme--documenter-dark .content kbd.is-delete:not(body)::after,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}html.theme--documenter-dark .tag.is-delete:not(body):hover,html.theme--documenter-dark .content kbd.is-delete:not(body):hover,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body):hover,html.theme--documenter-dark .tag.is-delete:not(body):focus,html.theme--documenter-dark .content kbd.is-delete:not(body):focus,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#1d2122}html.theme--documenter-dark .tag.is-delete:not(body):active,html.theme--documenter-dark .content kbd.is-delete:not(body):active,html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#111414}html.theme--documenter-dark .tag.is-rounded:not(body),html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:not(body),html.theme--documenter-dark .content kbd.is-rounded:not(body),html.theme--documenter-dark #documenter .docs-sidebar .content form.docs-search>input:not(body),html.theme--documenter-dark .docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}html.theme--documenter-dark a.tag:hover,html.theme--documenter-dark .docstring>section>a.docs-sourcelink:hover{text-decoration:underline}html.theme--documenter-dark .title,html.theme--documenter-dark .subtitle{word-break:break-word}html.theme--documenter-dark .title em,html.theme--documenter-dark .title span,html.theme--documenter-dark .subtitle em,html.theme--documenter-dark .subtitle span{font-weight:inherit}html.theme--documenter-dark .title sub,html.theme--documenter-dark .subtitle sub{font-size:.75em}html.theme--documenter-dark .title sup,html.theme--documenter-dark .subtitle sup{font-size:.75em}html.theme--documenter-dark .title .tag,html.theme--documenter-dark .title .content kbd,html.theme--documenter-dark .content .title kbd,html.theme--documenter-dark .title .docstring>section>a.docs-sourcelink,html.theme--documenter-dark .subtitle .tag,html.theme--documenter-dark .subtitle .content kbd,html.theme--documenter-dark .content .subtitle kbd,html.theme--documenter-dark .subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}html.theme--documenter-dark .title{color:#fff;font-size:2rem;font-weight:500;line-height:1.125}html.theme--documenter-dark .title strong{color:inherit;font-weight:inherit}html.theme--documenter-dark .title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}html.theme--documenter-dark .title.is-1{font-size:3rem}html.theme--documenter-dark .title.is-2{font-size:2.5rem}html.theme--documenter-dark .title.is-3{font-size:2rem}html.theme--documenter-dark .title.is-4{font-size:1.5rem}html.theme--documenter-dark .title.is-5{font-size:1.25rem}html.theme--documenter-dark .title.is-6{font-size:1rem}html.theme--documenter-dark .title.is-7{font-size:.75rem}html.theme--documenter-dark .subtitle{color:#8c9b9d;font-size:1.25rem;font-weight:400;line-height:1.25}html.theme--documenter-dark .subtitle strong{color:#8c9b9d;font-weight:600}html.theme--documenter-dark .subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}html.theme--documenter-dark .subtitle.is-1{font-size:3rem}html.theme--documenter-dark .subtitle.is-2{font-size:2.5rem}html.theme--documenter-dark .subtitle.is-3{font-size:2rem}html.theme--documenter-dark .subtitle.is-4{font-size:1.5rem}html.theme--documenter-dark .subtitle.is-5{font-size:1.25rem}html.theme--documenter-dark .subtitle.is-6{font-size:1rem}html.theme--documenter-dark .subtitle.is-7{font-size:.75rem}html.theme--documenter-dark .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--documenter-dark .number{align-items:center;background-color:#282f2f;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}html.theme--documenter-dark .select select,html.theme--documenter-dark .textarea,html.theme--documenter-dark .input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{background-color:#1f2424;border-color:#5e6d6f;border-radius:.4em;color:#dbdee0}html.theme--documenter-dark .select select::-moz-placeholder,html.theme--documenter-dark .textarea::-moz-placeholder,html.theme--documenter-dark .input::-moz-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#868c98}html.theme--documenter-dark .select select::-webkit-input-placeholder,html.theme--documenter-dark .textarea::-webkit-input-placeholder,html.theme--documenter-dark .input::-webkit-input-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#868c98}html.theme--documenter-dark .select select:-moz-placeholder,html.theme--documenter-dark .textarea:-moz-placeholder,html.theme--documenter-dark .input:-moz-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#868c98}html.theme--documenter-dark .select select:-ms-input-placeholder,html.theme--documenter-dark .textarea:-ms-input-placeholder,html.theme--documenter-dark .input:-ms-input-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#868c98}html.theme--documenter-dark .select select:hover,html.theme--documenter-dark .textarea:hover,html.theme--documenter-dark .input:hover,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:hover,html.theme--documenter-dark .select select.is-hovered,html.theme--documenter-dark .is-hovered.textarea,html.theme--documenter-dark .is-hovered.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#8c9b9d}html.theme--documenter-dark .select select:focus,html.theme--documenter-dark .textarea:focus,html.theme--documenter-dark .input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:focus,html.theme--documenter-dark .select select.is-focused,html.theme--documenter-dark .is-focused.textarea,html.theme--documenter-dark .is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .select select:active,html.theme--documenter-dark .textarea:active,html.theme--documenter-dark .input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:active,html.theme--documenter-dark .select select.is-active,html.theme--documenter-dark .is-active.textarea,html.theme--documenter-dark .is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{border-color:#1abc9c;box-shadow:0 0 0 0.125em rgba(26,188,156,0.25)}html.theme--documenter-dark .select select[disabled],html.theme--documenter-dark .textarea[disabled],html.theme--documenter-dark .input[disabled],html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] html.theme--documenter-dark .select select,fieldset[disabled] html.theme--documenter-dark .textarea,fieldset[disabled] html.theme--documenter-dark .input,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{background-color:#8c9b9d;border-color:#282f2f;box-shadow:none;color:#fff}html.theme--documenter-dark .select select[disabled]::-moz-placeholder,html.theme--documenter-dark .textarea[disabled]::-moz-placeholder,html.theme--documenter-dark .input[disabled]::-moz-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .select select::-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .textarea::-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .input::-moz-placeholder,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(255,255,255,0.3)}html.theme--documenter-dark .select select[disabled]::-webkit-input-placeholder,html.theme--documenter-dark .textarea[disabled]::-webkit-input-placeholder,html.theme--documenter-dark .input[disabled]::-webkit-input-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] html.theme--documenter-dark .select select::-webkit-input-placeholder,fieldset[disabled] html.theme--documenter-dark .textarea::-webkit-input-placeholder,fieldset[disabled] html.theme--documenter-dark .input::-webkit-input-placeholder,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(255,255,255,0.3)}html.theme--documenter-dark .select select[disabled]:-moz-placeholder,html.theme--documenter-dark .textarea[disabled]:-moz-placeholder,html.theme--documenter-dark .input[disabled]:-moz-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .select select:-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .textarea:-moz-placeholder,fieldset[disabled] html.theme--documenter-dark .input:-moz-placeholder,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(255,255,255,0.3)}html.theme--documenter-dark .select select[disabled]:-ms-input-placeholder,html.theme--documenter-dark .textarea[disabled]:-ms-input-placeholder,html.theme--documenter-dark .input[disabled]:-ms-input-placeholder,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] html.theme--documenter-dark .select select:-ms-input-placeholder,fieldset[disabled] html.theme--documenter-dark .textarea:-ms-input-placeholder,fieldset[disabled] html.theme--documenter-dark .input:-ms-input-placeholder,fieldset[disabled] html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(255,255,255,0.3)}html.theme--documenter-dark .textarea,html.theme--documenter-dark .input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}html.theme--documenter-dark .textarea[readonly],html.theme--documenter-dark .input[readonly],html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}html.theme--documenter-dark .is-white.textarea,html.theme--documenter-dark .is-white.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}html.theme--documenter-dark .is-white.textarea:focus,html.theme--documenter-dark .is-white.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-white:focus,html.theme--documenter-dark .is-white.is-focused.textarea,html.theme--documenter-dark .is-white.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-white.textarea:active,html.theme--documenter-dark .is-white.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-white:active,html.theme--documenter-dark .is-white.is-active.textarea,html.theme--documenter-dark .is-white.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--documenter-dark .is-black.textarea,html.theme--documenter-dark .is-black.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}html.theme--documenter-dark .is-black.textarea:focus,html.theme--documenter-dark .is-black.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-black:focus,html.theme--documenter-dark .is-black.is-focused.textarea,html.theme--documenter-dark .is-black.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-black.textarea:active,html.theme--documenter-dark .is-black.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-black:active,html.theme--documenter-dark .is-black.is-active.textarea,html.theme--documenter-dark .is-black.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--documenter-dark .is-light.textarea,html.theme--documenter-dark .is-light.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-light{border-color:#ecf0f1}html.theme--documenter-dark .is-light.textarea:focus,html.theme--documenter-dark .is-light.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-light:focus,html.theme--documenter-dark .is-light.is-focused.textarea,html.theme--documenter-dark .is-light.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-light.textarea:active,html.theme--documenter-dark .is-light.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-light:active,html.theme--documenter-dark .is-light.is-active.textarea,html.theme--documenter-dark .is-light.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(236,240,241,0.25)}html.theme--documenter-dark .is-dark.textarea,html.theme--documenter-dark .content kbd.textarea,html.theme--documenter-dark .is-dark.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-dark,html.theme--documenter-dark .content kbd.input{border-color:#282f2f}html.theme--documenter-dark .is-dark.textarea:focus,html.theme--documenter-dark .content kbd.textarea:focus,html.theme--documenter-dark .is-dark.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-dark:focus,html.theme--documenter-dark .content kbd.input:focus,html.theme--documenter-dark .is-dark.is-focused.textarea,html.theme--documenter-dark .content kbd.is-focused.textarea,html.theme--documenter-dark .is-dark.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .content kbd.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar .content form.docs-search>input.is-focused,html.theme--documenter-dark .is-dark.textarea:active,html.theme--documenter-dark .content kbd.textarea:active,html.theme--documenter-dark .is-dark.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-dark:active,html.theme--documenter-dark .content kbd.input:active,html.theme--documenter-dark .is-dark.is-active.textarea,html.theme--documenter-dark .content kbd.is-active.textarea,html.theme--documenter-dark .is-dark.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--documenter-dark .content kbd.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(40,47,47,0.25)}html.theme--documenter-dark .is-primary.textarea,html.theme--documenter-dark .docstring>section>a.textarea.docs-sourcelink,html.theme--documenter-dark .is-primary.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-primary,html.theme--documenter-dark .docstring>section>a.input.docs-sourcelink{border-color:#375a7f}html.theme--documenter-dark .is-primary.textarea:focus,html.theme--documenter-dark .docstring>section>a.textarea.docs-sourcelink:focus,html.theme--documenter-dark .is-primary.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-primary:focus,html.theme--documenter-dark .docstring>section>a.input.docs-sourcelink:focus,html.theme--documenter-dark .is-primary.is-focused.textarea,html.theme--documenter-dark .docstring>section>a.is-focused.textarea.docs-sourcelink,html.theme--documenter-dark .is-primary.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .docstring>section>a.is-focused.input.docs-sourcelink,html.theme--documenter-dark .is-primary.textarea:active,html.theme--documenter-dark .docstring>section>a.textarea.docs-sourcelink:active,html.theme--documenter-dark .is-primary.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-primary:active,html.theme--documenter-dark .docstring>section>a.input.docs-sourcelink:active,html.theme--documenter-dark .is-primary.is-active.textarea,html.theme--documenter-dark .docstring>section>a.is-active.textarea.docs-sourcelink,html.theme--documenter-dark .is-primary.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active,html.theme--documenter-dark .docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(55,90,127,0.25)}html.theme--documenter-dark .is-link.textarea,html.theme--documenter-dark .is-link.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-link{border-color:#1abc9c}html.theme--documenter-dark .is-link.textarea:focus,html.theme--documenter-dark .is-link.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-link:focus,html.theme--documenter-dark .is-link.is-focused.textarea,html.theme--documenter-dark .is-link.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-link.textarea:active,html.theme--documenter-dark .is-link.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-link:active,html.theme--documenter-dark .is-link.is-active.textarea,html.theme--documenter-dark .is-link.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(26,188,156,0.25)}html.theme--documenter-dark .is-info.textarea,html.theme--documenter-dark .is-info.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-info{border-color:#3c5dcd}html.theme--documenter-dark .is-info.textarea:focus,html.theme--documenter-dark .is-info.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-info:focus,html.theme--documenter-dark .is-info.is-focused.textarea,html.theme--documenter-dark .is-info.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-info.textarea:active,html.theme--documenter-dark .is-info.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-info:active,html.theme--documenter-dark .is-info.is-active.textarea,html.theme--documenter-dark .is-info.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}html.theme--documenter-dark .is-success.textarea,html.theme--documenter-dark .is-success.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-success{border-color:#259a12}html.theme--documenter-dark .is-success.textarea:focus,html.theme--documenter-dark .is-success.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-success:focus,html.theme--documenter-dark .is-success.is-focused.textarea,html.theme--documenter-dark .is-success.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-success.textarea:active,html.theme--documenter-dark .is-success.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-success:active,html.theme--documenter-dark .is-success.is-active.textarea,html.theme--documenter-dark .is-success.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}html.theme--documenter-dark .is-warning.textarea,html.theme--documenter-dark .is-warning.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#f4c72f}html.theme--documenter-dark .is-warning.textarea:focus,html.theme--documenter-dark .is-warning.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-warning:focus,html.theme--documenter-dark .is-warning.is-focused.textarea,html.theme--documenter-dark .is-warning.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-warning.textarea:active,html.theme--documenter-dark .is-warning.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-warning:active,html.theme--documenter-dark .is-warning.is-active.textarea,html.theme--documenter-dark .is-warning.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(244,199,47,0.25)}html.theme--documenter-dark .is-danger.textarea,html.theme--documenter-dark .is-danger.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#cb3c33}html.theme--documenter-dark .is-danger.textarea:focus,html.theme--documenter-dark .is-danger.input:focus,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-danger:focus,html.theme--documenter-dark .is-danger.is-focused.textarea,html.theme--documenter-dark .is-danger.is-focused.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-focused,html.theme--documenter-dark .is-danger.textarea:active,html.theme--documenter-dark .is-danger.input:active,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-danger:active,html.theme--documenter-dark .is-danger.is-active.textarea,html.theme--documenter-dark .is-danger.is-active.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}html.theme--documenter-dark .is-small.textarea,html.theme--documenter-dark .is-small.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{border-radius:3px;font-size:.75rem}html.theme--documenter-dark .is-medium.textarea,html.theme--documenter-dark .is-medium.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}html.theme--documenter-dark .is-large.textarea,html.theme--documenter-dark .is-large.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}html.theme--documenter-dark .is-fullwidth.textarea,html.theme--documenter-dark .is-fullwidth.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}html.theme--documenter-dark .is-inline.textarea,html.theme--documenter-dark .is-inline.input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}html.theme--documenter-dark .input.is-rounded,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}html.theme--documenter-dark .input.is-static,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}html.theme--documenter-dark .textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}html.theme--documenter-dark .textarea:not([rows]){max-height:40em;min-height:8em}html.theme--documenter-dark .textarea[rows]{height:initial}html.theme--documenter-dark .textarea.has-fixed-size{resize:none}html.theme--documenter-dark .radio,html.theme--documenter-dark .checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}html.theme--documenter-dark .radio input,html.theme--documenter-dark .checkbox input{cursor:pointer}html.theme--documenter-dark .radio:hover,html.theme--documenter-dark .checkbox:hover{color:#8c9b9d}html.theme--documenter-dark .radio[disabled],html.theme--documenter-dark .checkbox[disabled],fieldset[disabled] html.theme--documenter-dark .radio,fieldset[disabled] html.theme--documenter-dark .checkbox,html.theme--documenter-dark .radio input[disabled],html.theme--documenter-dark .checkbox input[disabled]{color:#fff;cursor:not-allowed}html.theme--documenter-dark .radio+.radio{margin-left:.5em}html.theme--documenter-dark .select{display:inline-block;max-width:100%;position:relative;vertical-align:top}html.theme--documenter-dark .select:not(.is-multiple){height:2.5em}html.theme--documenter-dark .select:not(.is-multiple):not(.is-loading)::after{border-color:#1abc9c;right:1.125em;z-index:4}html.theme--documenter-dark .select.is-rounded select,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}html.theme--documenter-dark .select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}html.theme--documenter-dark .select select::-ms-expand{display:none}html.theme--documenter-dark .select select[disabled]:hover,fieldset[disabled] html.theme--documenter-dark .select select:hover{border-color:#282f2f}html.theme--documenter-dark .select select:not([multiple]){padding-right:2.5em}html.theme--documenter-dark .select select[multiple]{height:auto;padding:0}html.theme--documenter-dark .select select[multiple] option{padding:0.5em 1em}html.theme--documenter-dark .select:not(.is-multiple):not(.is-loading):hover::after{border-color:#8c9b9d}html.theme--documenter-dark .select.is-white:not(:hover)::after{border-color:#fff}html.theme--documenter-dark .select.is-white select{border-color:#fff}html.theme--documenter-dark .select.is-white select:hover,html.theme--documenter-dark .select.is-white select.is-hovered{border-color:#f2f2f2}html.theme--documenter-dark .select.is-white select:focus,html.theme--documenter-dark .select.is-white select.is-focused,html.theme--documenter-dark .select.is-white select:active,html.theme--documenter-dark .select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}html.theme--documenter-dark .select.is-black:not(:hover)::after{border-color:#0a0a0a}html.theme--documenter-dark .select.is-black select{border-color:#0a0a0a}html.theme--documenter-dark .select.is-black select:hover,html.theme--documenter-dark .select.is-black select.is-hovered{border-color:#000}html.theme--documenter-dark .select.is-black select:focus,html.theme--documenter-dark .select.is-black select.is-focused,html.theme--documenter-dark .select.is-black select:active,html.theme--documenter-dark .select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}html.theme--documenter-dark .select.is-light:not(:hover)::after{border-color:#ecf0f1}html.theme--documenter-dark .select.is-light select{border-color:#ecf0f1}html.theme--documenter-dark .select.is-light select:hover,html.theme--documenter-dark .select.is-light select.is-hovered{border-color:#dde4e6}html.theme--documenter-dark .select.is-light select:focus,html.theme--documenter-dark .select.is-light select.is-focused,html.theme--documenter-dark .select.is-light select:active,html.theme--documenter-dark .select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(236,240,241,0.25)}html.theme--documenter-dark .select.is-dark:not(:hover)::after,html.theme--documenter-dark .content kbd.select:not(:hover)::after{border-color:#282f2f}html.theme--documenter-dark .select.is-dark select,html.theme--documenter-dark .content kbd.select select{border-color:#282f2f}html.theme--documenter-dark .select.is-dark select:hover,html.theme--documenter-dark .content kbd.select select:hover,html.theme--documenter-dark .select.is-dark select.is-hovered,html.theme--documenter-dark .content kbd.select select.is-hovered{border-color:#1d2122}html.theme--documenter-dark .select.is-dark select:focus,html.theme--documenter-dark .content kbd.select select:focus,html.theme--documenter-dark .select.is-dark select.is-focused,html.theme--documenter-dark .content kbd.select select.is-focused,html.theme--documenter-dark .select.is-dark select:active,html.theme--documenter-dark .content kbd.select select:active,html.theme--documenter-dark .select.is-dark select.is-active,html.theme--documenter-dark .content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(40,47,47,0.25)}html.theme--documenter-dark .select.is-primary:not(:hover)::after,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#375a7f}html.theme--documenter-dark .select.is-primary select,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select{border-color:#375a7f}html.theme--documenter-dark .select.is-primary select:hover,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select:hover,html.theme--documenter-dark .select.is-primary select.is-hovered,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#2f4d6d}html.theme--documenter-dark .select.is-primary select:focus,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select:focus,html.theme--documenter-dark .select.is-primary select.is-focused,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select.is-focused,html.theme--documenter-dark .select.is-primary select:active,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select:active,html.theme--documenter-dark .select.is-primary select.is-active,html.theme--documenter-dark .docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(55,90,127,0.25)}html.theme--documenter-dark .select.is-link:not(:hover)::after{border-color:#1abc9c}html.theme--documenter-dark .select.is-link select{border-color:#1abc9c}html.theme--documenter-dark .select.is-link select:hover,html.theme--documenter-dark .select.is-link select.is-hovered{border-color:#17a689}html.theme--documenter-dark .select.is-link select:focus,html.theme--documenter-dark .select.is-link select.is-focused,html.theme--documenter-dark .select.is-link select:active,html.theme--documenter-dark .select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(26,188,156,0.25)}html.theme--documenter-dark .select.is-info:not(:hover)::after{border-color:#3c5dcd}html.theme--documenter-dark .select.is-info select{border-color:#3c5dcd}html.theme--documenter-dark .select.is-info select:hover,html.theme--documenter-dark .select.is-info select.is-hovered{border-color:#3151bf}html.theme--documenter-dark .select.is-info select:focus,html.theme--documenter-dark .select.is-info select.is-focused,html.theme--documenter-dark .select.is-info select:active,html.theme--documenter-dark .select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}html.theme--documenter-dark .select.is-success:not(:hover)::after{border-color:#259a12}html.theme--documenter-dark .select.is-success select{border-color:#259a12}html.theme--documenter-dark .select.is-success select:hover,html.theme--documenter-dark .select.is-success select.is-hovered{border-color:#20830f}html.theme--documenter-dark .select.is-success select:focus,html.theme--documenter-dark .select.is-success select.is-focused,html.theme--documenter-dark .select.is-success select:active,html.theme--documenter-dark .select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}html.theme--documenter-dark .select.is-warning:not(:hover)::after{border-color:#f4c72f}html.theme--documenter-dark .select.is-warning select{border-color:#f4c72f}html.theme--documenter-dark .select.is-warning select:hover,html.theme--documenter-dark .select.is-warning select.is-hovered{border-color:#f3c017}html.theme--documenter-dark .select.is-warning select:focus,html.theme--documenter-dark .select.is-warning select.is-focused,html.theme--documenter-dark .select.is-warning select:active,html.theme--documenter-dark .select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(244,199,47,0.25)}html.theme--documenter-dark .select.is-danger:not(:hover)::after{border-color:#cb3c33}html.theme--documenter-dark .select.is-danger select{border-color:#cb3c33}html.theme--documenter-dark .select.is-danger select:hover,html.theme--documenter-dark .select.is-danger select.is-hovered{border-color:#b7362e}html.theme--documenter-dark .select.is-danger select:focus,html.theme--documenter-dark .select.is-danger select.is-focused,html.theme--documenter-dark .select.is-danger select:active,html.theme--documenter-dark .select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}html.theme--documenter-dark .select.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.select{border-radius:3px;font-size:.75rem}html.theme--documenter-dark .select.is-medium{font-size:1.25rem}html.theme--documenter-dark .select.is-large{font-size:1.5rem}html.theme--documenter-dark .select.is-disabled::after{border-color:#fff !important;opacity:0.5}html.theme--documenter-dark .select.is-fullwidth{width:100%}html.theme--documenter-dark .select.is-fullwidth select{width:100%}html.theme--documenter-dark .select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}html.theme--documenter-dark .select.is-loading.is-small:after,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--documenter-dark .select.is-loading.is-medium:after{font-size:1.25rem}html.theme--documenter-dark .select.is-loading.is-large:after{font-size:1.5rem}html.theme--documenter-dark .file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}html.theme--documenter-dark .file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .file.is-white:hover .file-cta,html.theme--documenter-dark .file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .file.is-white:focus .file-cta,html.theme--documenter-dark .file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}html.theme--documenter-dark .file.is-white:active .file-cta,html.theme--documenter-dark .file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}html.theme--documenter-dark .file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-black:hover .file-cta,html.theme--documenter-dark .file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-black:focus .file-cta,html.theme--documenter-dark .file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}html.theme--documenter-dark .file.is-black:active .file-cta,html.theme--documenter-dark .file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-light .file-cta{background-color:#ecf0f1;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-light:hover .file-cta,html.theme--documenter-dark .file.is-light.is-hovered .file-cta{background-color:#e5eaec;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-light:focus .file-cta,html.theme--documenter-dark .file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(236,240,241,0.25);color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-light:active .file-cta,html.theme--documenter-dark .file.is-light.is-active .file-cta{background-color:#dde4e6;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-dark .file-cta,html.theme--documenter-dark .content kbd.file .file-cta{background-color:#282f2f;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-dark:hover .file-cta,html.theme--documenter-dark .content kbd.file:hover .file-cta,html.theme--documenter-dark .file.is-dark.is-hovered .file-cta,html.theme--documenter-dark .content kbd.file.is-hovered .file-cta{background-color:#232829;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-dark:focus .file-cta,html.theme--documenter-dark .content kbd.file:focus .file-cta,html.theme--documenter-dark .file.is-dark.is-focused .file-cta,html.theme--documenter-dark .content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(40,47,47,0.25);color:#fff}html.theme--documenter-dark .file.is-dark:active .file-cta,html.theme--documenter-dark .content kbd.file:active .file-cta,html.theme--documenter-dark .file.is-dark.is-active .file-cta,html.theme--documenter-dark .content kbd.file.is-active .file-cta{background-color:#1d2122;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-primary .file-cta,html.theme--documenter-dark .docstring>section>a.file.docs-sourcelink .file-cta{background-color:#375a7f;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-primary:hover .file-cta,html.theme--documenter-dark .docstring>section>a.file.docs-sourcelink:hover .file-cta,html.theme--documenter-dark .file.is-primary.is-hovered .file-cta,html.theme--documenter-dark .docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#335476;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-primary:focus .file-cta,html.theme--documenter-dark .docstring>section>a.file.docs-sourcelink:focus .file-cta,html.theme--documenter-dark .file.is-primary.is-focused .file-cta,html.theme--documenter-dark .docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(55,90,127,0.25);color:#fff}html.theme--documenter-dark .file.is-primary:active .file-cta,html.theme--documenter-dark .docstring>section>a.file.docs-sourcelink:active .file-cta,html.theme--documenter-dark .file.is-primary.is-active .file-cta,html.theme--documenter-dark .docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#2f4d6d;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-link .file-cta{background-color:#1abc9c;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-link:hover .file-cta,html.theme--documenter-dark .file.is-link.is-hovered .file-cta{background-color:#18b193;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-link:focus .file-cta,html.theme--documenter-dark .file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(26,188,156,0.25);color:#fff}html.theme--documenter-dark .file.is-link:active .file-cta,html.theme--documenter-dark .file.is-link.is-active .file-cta{background-color:#17a689;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-info .file-cta{background-color:#3c5dcd;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-info:hover .file-cta,html.theme--documenter-dark .file.is-info.is-hovered .file-cta{background-color:#3355c9;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-info:focus .file-cta,html.theme--documenter-dark .file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(60,93,205,0.25);color:#fff}html.theme--documenter-dark .file.is-info:active .file-cta,html.theme--documenter-dark .file.is-info.is-active .file-cta{background-color:#3151bf;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-success .file-cta{background-color:#259a12;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-success:hover .file-cta,html.theme--documenter-dark .file.is-success.is-hovered .file-cta{background-color:#228f11;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-success:focus .file-cta,html.theme--documenter-dark .file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(37,154,18,0.25);color:#fff}html.theme--documenter-dark .file.is-success:active .file-cta,html.theme--documenter-dark .file.is-success.is-active .file-cta{background-color:#20830f;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-warning .file-cta{background-color:#f4c72f;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-warning:hover .file-cta,html.theme--documenter-dark .file.is-warning.is-hovered .file-cta{background-color:#f3c423;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-warning:focus .file-cta,html.theme--documenter-dark .file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(244,199,47,0.25);color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-warning:active .file-cta,html.theme--documenter-dark .file.is-warning.is-active .file-cta{background-color:#f3c017;border-color:transparent;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .file.is-danger .file-cta{background-color:#cb3c33;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-danger:hover .file-cta,html.theme--documenter-dark .file.is-danger.is-hovered .file-cta{background-color:#c13930;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-danger:focus .file-cta,html.theme--documenter-dark .file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(203,60,51,0.25);color:#fff}html.theme--documenter-dark .file.is-danger:active .file-cta,html.theme--documenter-dark .file.is-danger.is-active .file-cta{background-color:#b7362e;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}html.theme--documenter-dark .file.is-normal{font-size:1rem}html.theme--documenter-dark .file.is-medium{font-size:1.25rem}html.theme--documenter-dark .file.is-medium .file-icon .fa{font-size:21px}html.theme--documenter-dark .file.is-large{font-size:1.5rem}html.theme--documenter-dark .file.is-large .file-icon .fa{font-size:28px}html.theme--documenter-dark .file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--documenter-dark .file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--documenter-dark .file.has-name.is-empty .file-cta{border-radius:.4em}html.theme--documenter-dark .file.has-name.is-empty .file-name{display:none}html.theme--documenter-dark .file.is-boxed .file-label{flex-direction:column}html.theme--documenter-dark .file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}html.theme--documenter-dark .file.is-boxed .file-name{border-width:0 1px 1px}html.theme--documenter-dark .file.is-boxed .file-icon{height:1.5em;width:1.5em}html.theme--documenter-dark .file.is-boxed .file-icon .fa{font-size:21px}html.theme--documenter-dark .file.is-boxed.is-small .file-icon .fa,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}html.theme--documenter-dark .file.is-boxed.is-medium .file-icon .fa{font-size:28px}html.theme--documenter-dark .file.is-boxed.is-large .file-icon .fa{font-size:35px}html.theme--documenter-dark .file.is-boxed.has-name .file-cta{border-radius:.4em .4em 0 0}html.theme--documenter-dark .file.is-boxed.has-name .file-name{border-radius:0 0 .4em .4em;border-width:0 1px 1px}html.theme--documenter-dark .file.is-centered{justify-content:center}html.theme--documenter-dark .file.is-fullwidth .file-label{width:100%}html.theme--documenter-dark .file.is-fullwidth .file-name{flex-grow:1;max-width:none}html.theme--documenter-dark .file.is-right{justify-content:flex-end}html.theme--documenter-dark .file.is-right .file-cta{border-radius:0 .4em .4em 0}html.theme--documenter-dark .file.is-right .file-name{border-radius:.4em 0 0 .4em;border-width:1px 0 1px 1px;order:-1}html.theme--documenter-dark .file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}html.theme--documenter-dark .file-label:hover .file-cta{background-color:#232829;color:#f2f2f2}html.theme--documenter-dark .file-label:hover .file-name{border-color:#596668}html.theme--documenter-dark .file-label:active .file-cta{background-color:#1d2122;color:#f2f2f2}html.theme--documenter-dark .file-label:active .file-name{border-color:#535f61}html.theme--documenter-dark .file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}html.theme--documenter-dark .file-cta,html.theme--documenter-dark .file-name{border-color:#5e6d6f;border-radius:.4em;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}html.theme--documenter-dark .file-cta{background-color:#282f2f;color:#fff}html.theme--documenter-dark .file-name{border-color:#5e6d6f;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}html.theme--documenter-dark .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}html.theme--documenter-dark .file-icon .fa{font-size:14px}html.theme--documenter-dark .label{color:#f2f2f2;display:block;font-size:1rem;font-weight:700}html.theme--documenter-dark .label:not(:last-child){margin-bottom:0.5em}html.theme--documenter-dark .label.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}html.theme--documenter-dark .label.is-medium{font-size:1.25rem}html.theme--documenter-dark .label.is-large{font-size:1.5rem}html.theme--documenter-dark .help{display:block;font-size:.75rem;margin-top:0.25rem}html.theme--documenter-dark .help.is-white{color:#fff}html.theme--documenter-dark .help.is-black{color:#0a0a0a}html.theme--documenter-dark .help.is-light{color:#ecf0f1}html.theme--documenter-dark .help.is-dark,html.theme--documenter-dark .content kbd.help{color:#282f2f}html.theme--documenter-dark .help.is-primary,html.theme--documenter-dark .docstring>section>a.help.docs-sourcelink{color:#375a7f}html.theme--documenter-dark .help.is-link{color:#1abc9c}html.theme--documenter-dark .help.is-info{color:#3c5dcd}html.theme--documenter-dark .help.is-success{color:#259a12}html.theme--documenter-dark .help.is-warning{color:#f4c72f}html.theme--documenter-dark .help.is-danger{color:#cb3c33}html.theme--documenter-dark .field:not(:last-child){margin-bottom:0.75rem}html.theme--documenter-dark .field.has-addons{display:flex;justify-content:flex-start}html.theme--documenter-dark .field.has-addons .control:not(:last-child){margin-right:-1px}html.theme--documenter-dark .field.has-addons .control:not(:first-child):not(:last-child) .button,html.theme--documenter-dark .field.has-addons .control:not(:first-child):not(:last-child) .input,html.theme--documenter-dark .field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,html.theme--documenter-dark .field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}html.theme--documenter-dark .field.has-addons .control:first-child:not(:only-child) .button,html.theme--documenter-dark .field.has-addons .control:first-child:not(:only-child) .input,html.theme--documenter-dark .field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,html.theme--documenter-dark .field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}html.theme--documenter-dark .field.has-addons .control:last-child:not(:only-child) .button,html.theme--documenter-dark .field.has-addons .control:last-child:not(:only-child) .input,html.theme--documenter-dark .field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,html.theme--documenter-dark .field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}html.theme--documenter-dark .field.has-addons .control .button:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .button.is-hovered:not([disabled]),html.theme--documenter-dark .field.has-addons .control .input:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .input.is-hovered:not([disabled]),html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),html.theme--documenter-dark .field.has-addons .control .select select:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}html.theme--documenter-dark .field.has-addons .control .button:not([disabled]):focus,html.theme--documenter-dark .field.has-addons .control .button.is-focused:not([disabled]),html.theme--documenter-dark .field.has-addons .control .button:not([disabled]):active,html.theme--documenter-dark .field.has-addons .control .button.is-active:not([disabled]),html.theme--documenter-dark .field.has-addons .control .input:not([disabled]):focus,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,html.theme--documenter-dark .field.has-addons .control .input.is-focused:not([disabled]),html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),html.theme--documenter-dark .field.has-addons .control .input:not([disabled]):active,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,html.theme--documenter-dark .field.has-addons .control .input.is-active:not([disabled]),html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),html.theme--documenter-dark .field.has-addons .control .select select:not([disabled]):focus,html.theme--documenter-dark .field.has-addons .control .select select.is-focused:not([disabled]),html.theme--documenter-dark .field.has-addons .control .select select:not([disabled]):active,html.theme--documenter-dark .field.has-addons .control .select select.is-active:not([disabled]){z-index:3}html.theme--documenter-dark .field.has-addons .control .button:not([disabled]):focus:hover,html.theme--documenter-dark .field.has-addons .control .button.is-focused:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .button:not([disabled]):active:hover,html.theme--documenter-dark .field.has-addons .control .button.is-active:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .input:not([disabled]):focus:hover,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,html.theme--documenter-dark .field.has-addons .control .input.is-focused:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .input:not([disabled]):active:hover,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,html.theme--documenter-dark .field.has-addons .control .input.is-active:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,html.theme--documenter-dark #documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .select select:not([disabled]):focus:hover,html.theme--documenter-dark .field.has-addons .control .select select.is-focused:not([disabled]):hover,html.theme--documenter-dark .field.has-addons .control .select select:not([disabled]):active:hover,html.theme--documenter-dark .field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}html.theme--documenter-dark .field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .field.has-addons.has-addons-centered{justify-content:center}html.theme--documenter-dark .field.has-addons.has-addons-right{justify-content:flex-end}html.theme--documenter-dark .field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}html.theme--documenter-dark .field.is-grouped{display:flex;justify-content:flex-start}html.theme--documenter-dark .field.is-grouped>.control{flex-shrink:0}html.theme--documenter-dark .field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--documenter-dark .field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .field.is-grouped.is-grouped-centered{justify-content:center}html.theme--documenter-dark .field.is-grouped.is-grouped-right{justify-content:flex-end}html.theme--documenter-dark .field.is-grouped.is-grouped-multiline{flex-wrap:wrap}html.theme--documenter-dark .field.is-grouped.is-grouped-multiline>.control:last-child,html.theme--documenter-dark .field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}html.theme--documenter-dark .field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}html.theme--documenter-dark .field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--documenter-dark .field.is-horizontal{display:flex}}html.theme--documenter-dark .field-label .label{font-size:inherit}@media screen and (max-width: 768px){html.theme--documenter-dark .field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}html.theme--documenter-dark .field-label.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}html.theme--documenter-dark .field-label.is-normal{padding-top:0.375em}html.theme--documenter-dark .field-label.is-medium{font-size:1.25rem;padding-top:0.375em}html.theme--documenter-dark .field-label.is-large{font-size:1.5rem;padding-top:0.375em}}html.theme--documenter-dark .field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{html.theme--documenter-dark .field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}html.theme--documenter-dark .field-body .field{margin-bottom:0}html.theme--documenter-dark .field-body>.field{flex-shrink:1}html.theme--documenter-dark .field-body>.field:not(.is-narrow){flex-grow:1}html.theme--documenter-dark .field-body>.field:not(:last-child){margin-right:.75rem}}html.theme--documenter-dark .control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}html.theme--documenter-dark .control.has-icons-left .input:focus~.icon,html.theme--documenter-dark .control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,html.theme--documenter-dark .control.has-icons-left .select:focus~.icon,html.theme--documenter-dark .control.has-icons-right .input:focus~.icon,html.theme--documenter-dark .control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,html.theme--documenter-dark .control.has-icons-right .select:focus~.icon{color:#282f2f}html.theme--documenter-dark .control.has-icons-left .input.is-small~.icon,html.theme--documenter-dark .control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,html.theme--documenter-dark .control.has-icons-left .select.is-small~.icon,html.theme--documenter-dark .control.has-icons-right .input.is-small~.icon,html.theme--documenter-dark .control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,html.theme--documenter-dark .control.has-icons-right .select.is-small~.icon{font-size:.75rem}html.theme--documenter-dark .control.has-icons-left .input.is-medium~.icon,html.theme--documenter-dark .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,html.theme--documenter-dark .control.has-icons-left .select.is-medium~.icon,html.theme--documenter-dark .control.has-icons-right .input.is-medium~.icon,html.theme--documenter-dark .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,html.theme--documenter-dark .control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}html.theme--documenter-dark .control.has-icons-left .input.is-large~.icon,html.theme--documenter-dark .control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,html.theme--documenter-dark .control.has-icons-left .select.is-large~.icon,html.theme--documenter-dark .control.has-icons-right .input.is-large~.icon,html.theme--documenter-dark .control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,html.theme--documenter-dark .control.has-icons-right .select.is-large~.icon{font-size:1.5rem}html.theme--documenter-dark .control.has-icons-left .icon,html.theme--documenter-dark .control.has-icons-right .icon{color:#5e6d6f;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}html.theme--documenter-dark .control.has-icons-left .input,html.theme--documenter-dark .control.has-icons-left #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-left form.docs-search>input,html.theme--documenter-dark .control.has-icons-left .select select{padding-left:2.5em}html.theme--documenter-dark .control.has-icons-left .icon.is-left{left:0}html.theme--documenter-dark .control.has-icons-right .input,html.theme--documenter-dark .control.has-icons-right #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .control.has-icons-right form.docs-search>input,html.theme--documenter-dark .control.has-icons-right .select select{padding-right:2.5em}html.theme--documenter-dark .control.has-icons-right .icon.is-right{right:0}html.theme--documenter-dark .control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}html.theme--documenter-dark .control.is-loading.is-small:after,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}html.theme--documenter-dark .control.is-loading.is-medium:after{font-size:1.25rem}html.theme--documenter-dark .control.is-loading.is-large:after{font-size:1.5rem}html.theme--documenter-dark .breadcrumb{font-size:1rem;white-space:nowrap}html.theme--documenter-dark .breadcrumb a{align-items:center;color:#1abc9c;display:flex;justify-content:center;padding:0 .75em}html.theme--documenter-dark .breadcrumb a:hover{color:#1dd2af}html.theme--documenter-dark .breadcrumb li{align-items:center;display:flex}html.theme--documenter-dark .breadcrumb li:first-child a{padding-left:0}html.theme--documenter-dark .breadcrumb li.is-active a{color:#f2f2f2;cursor:default;pointer-events:none}html.theme--documenter-dark .breadcrumb li+li::before{color:#8c9b9d;content:"\0002f"}html.theme--documenter-dark .breadcrumb ul,html.theme--documenter-dark .breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}html.theme--documenter-dark .breadcrumb .icon:first-child{margin-right:.5em}html.theme--documenter-dark .breadcrumb .icon:last-child{margin-left:.5em}html.theme--documenter-dark .breadcrumb.is-centered ol,html.theme--documenter-dark .breadcrumb.is-centered ul{justify-content:center}html.theme--documenter-dark .breadcrumb.is-right ol,html.theme--documenter-dark .breadcrumb.is-right ul{justify-content:flex-end}html.theme--documenter-dark .breadcrumb.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}html.theme--documenter-dark .breadcrumb.is-medium{font-size:1.25rem}html.theme--documenter-dark .breadcrumb.is-large{font-size:1.5rem}html.theme--documenter-dark .breadcrumb.has-arrow-separator li+li::before{content:"\02192"}html.theme--documenter-dark .breadcrumb.has-bullet-separator li+li::before{content:"\02022"}html.theme--documenter-dark .breadcrumb.has-dot-separator li+li::before{content:"\000b7"}html.theme--documenter-dark .breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}html.theme--documenter-dark .card{background-color:#fff;border-radius:.25rem;box-shadow:#171717;color:#fff;max-width:100%;position:relative}html.theme--documenter-dark .card-footer:first-child,html.theme--documenter-dark .card-content:first-child,html.theme--documenter-dark .card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--documenter-dark .card-footer:last-child,html.theme--documenter-dark .card-content:last-child,html.theme--documenter-dark .card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--documenter-dark .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}html.theme--documenter-dark .card-header-title{align-items:center;color:#f2f2f2;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}html.theme--documenter-dark .card-header-title.is-centered{justify-content:center}html.theme--documenter-dark .card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}html.theme--documenter-dark .card-image{display:block;position:relative}html.theme--documenter-dark .card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}html.theme--documenter-dark .card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}html.theme--documenter-dark .card-content{background-color:rgba(0,0,0,0);padding:1.5rem}html.theme--documenter-dark .card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}html.theme--documenter-dark .card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}html.theme--documenter-dark .card-footer-item:not(:last-child){border-right:1px solid #ededed}html.theme--documenter-dark .card .media:not(:last-child){margin-bottom:1.5rem}html.theme--documenter-dark .dropdown{display:inline-flex;position:relative;vertical-align:top}html.theme--documenter-dark .dropdown.is-active .dropdown-menu,html.theme--documenter-dark .dropdown.is-hoverable:hover .dropdown-menu{display:block}html.theme--documenter-dark .dropdown.is-right .dropdown-menu{left:auto;right:0}html.theme--documenter-dark .dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}html.theme--documenter-dark .dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}html.theme--documenter-dark .dropdown-content{background-color:#282f2f;border-radius:.4em;box-shadow:#171717;padding-bottom:.5rem;padding-top:.5rem}html.theme--documenter-dark .dropdown-item{color:#fff;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}html.theme--documenter-dark a.dropdown-item,html.theme--documenter-dark button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}html.theme--documenter-dark a.dropdown-item:hover,html.theme--documenter-dark button.dropdown-item:hover{background-color:#282f2f;color:#0a0a0a}html.theme--documenter-dark a.dropdown-item.is-active,html.theme--documenter-dark button.dropdown-item.is-active{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}html.theme--documenter-dark .level{align-items:center;justify-content:space-between}html.theme--documenter-dark .level code{border-radius:.4em}html.theme--documenter-dark .level img{display:inline-block;vertical-align:top}html.theme--documenter-dark .level.is-mobile{display:flex}html.theme--documenter-dark .level.is-mobile .level-left,html.theme--documenter-dark .level.is-mobile .level-right{display:flex}html.theme--documenter-dark .level.is-mobile .level-left+.level-right{margin-top:0}html.theme--documenter-dark .level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}html.theme--documenter-dark .level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{html.theme--documenter-dark .level{display:flex}html.theme--documenter-dark .level>.level-item:not(.is-narrow){flex-grow:1}}html.theme--documenter-dark .level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}html.theme--documenter-dark .level-item .title,html.theme--documenter-dark .level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){html.theme--documenter-dark .level-item:not(:last-child){margin-bottom:.75rem}}html.theme--documenter-dark .level-left,html.theme--documenter-dark .level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--documenter-dark .level-left .level-item.is-flexible,html.theme--documenter-dark .level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{html.theme--documenter-dark .level-left .level-item:not(:last-child),html.theme--documenter-dark .level-right .level-item:not(:last-child){margin-right:.75rem}}html.theme--documenter-dark .level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){html.theme--documenter-dark .level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .level-left{display:flex}}html.theme--documenter-dark .level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{html.theme--documenter-dark .level-right{display:flex}}html.theme--documenter-dark .media{align-items:flex-start;display:flex;text-align:inherit}html.theme--documenter-dark .media .content:not(:last-child){margin-bottom:.75rem}html.theme--documenter-dark .media .media{border-top:1px solid rgba(94,109,111,0.5);display:flex;padding-top:.75rem}html.theme--documenter-dark .media .media .content:not(:last-child),html.theme--documenter-dark .media .media .control:not(:last-child){margin-bottom:.5rem}html.theme--documenter-dark .media .media .media{padding-top:.5rem}html.theme--documenter-dark .media .media .media+.media{margin-top:.5rem}html.theme--documenter-dark .media+.media{border-top:1px solid rgba(94,109,111,0.5);margin-top:1rem;padding-top:1rem}html.theme--documenter-dark .media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}html.theme--documenter-dark .media-left,html.theme--documenter-dark .media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}html.theme--documenter-dark .media-left{margin-right:1rem}html.theme--documenter-dark .media-right{margin-left:1rem}html.theme--documenter-dark .media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){html.theme--documenter-dark .media-content{overflow-x:auto}}html.theme--documenter-dark .menu{font-size:1rem}html.theme--documenter-dark .menu.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}html.theme--documenter-dark .menu.is-medium{font-size:1.25rem}html.theme--documenter-dark .menu.is-large{font-size:1.5rem}html.theme--documenter-dark .menu-list{line-height:1.25}html.theme--documenter-dark .menu-list a{border-radius:3px;color:#fff;display:block;padding:0.5em 0.75em}html.theme--documenter-dark .menu-list a:hover{background-color:#282f2f;color:#f2f2f2}html.theme--documenter-dark .menu-list a.is-active{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .menu-list li ul{border-left:1px solid #5e6d6f;margin:.75em;padding-left:.75em}html.theme--documenter-dark .menu-label{color:#fff;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}html.theme--documenter-dark .menu-label:not(:first-child){margin-top:1em}html.theme--documenter-dark .menu-label:not(:last-child){margin-bottom:1em}html.theme--documenter-dark .message{background-color:#282f2f;border-radius:.4em;font-size:1rem}html.theme--documenter-dark .message strong{color:currentColor}html.theme--documenter-dark .message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}html.theme--documenter-dark .message.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}html.theme--documenter-dark .message.is-medium{font-size:1.25rem}html.theme--documenter-dark .message.is-large{font-size:1.5rem}html.theme--documenter-dark .message.is-white{background-color:#fff}html.theme--documenter-dark .message.is-white .message-header{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .message.is-white .message-body{border-color:#fff}html.theme--documenter-dark .message.is-black{background-color:#fafafa}html.theme--documenter-dark .message.is-black .message-header{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .message.is-black .message-body{border-color:#0a0a0a}html.theme--documenter-dark .message.is-light{background-color:#f9fafb}html.theme--documenter-dark .message.is-light .message-header{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .message.is-light .message-body{border-color:#ecf0f1}html.theme--documenter-dark .message.is-dark,html.theme--documenter-dark .content kbd.message{background-color:#f9fafa}html.theme--documenter-dark .message.is-dark .message-header,html.theme--documenter-dark .content kbd.message .message-header{background-color:#282f2f;color:#fff}html.theme--documenter-dark .message.is-dark .message-body,html.theme--documenter-dark .content kbd.message .message-body{border-color:#282f2f}html.theme--documenter-dark .message.is-primary,html.theme--documenter-dark .docstring>section>a.message.docs-sourcelink{background-color:#f1f5f9}html.theme--documenter-dark .message.is-primary .message-header,html.theme--documenter-dark .docstring>section>a.message.docs-sourcelink .message-header{background-color:#375a7f;color:#fff}html.theme--documenter-dark .message.is-primary .message-body,html.theme--documenter-dark .docstring>section>a.message.docs-sourcelink .message-body{border-color:#375a7f;color:#4d7eb2}html.theme--documenter-dark .message.is-link{background-color:#edfdf9}html.theme--documenter-dark .message.is-link .message-header{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .message.is-link .message-body{border-color:#1abc9c;color:#15987e}html.theme--documenter-dark .message.is-info{background-color:#eff2fb}html.theme--documenter-dark .message.is-info .message-header{background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .message.is-info .message-body{border-color:#3c5dcd;color:#3253c3}html.theme--documenter-dark .message.is-success{background-color:#effded}html.theme--documenter-dark .message.is-success .message-header{background-color:#259a12;color:#fff}html.theme--documenter-dark .message.is-success .message-body{border-color:#259a12;color:#2ec016}html.theme--documenter-dark .message.is-warning{background-color:#fefaec}html.theme--documenter-dark .message.is-warning .message-header{background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .message.is-warning .message-body{border-color:#f4c72f;color:#8c6e07}html.theme--documenter-dark .message.is-danger{background-color:#fbefef}html.theme--documenter-dark .message.is-danger .message-header{background-color:#cb3c33;color:#fff}html.theme--documenter-dark .message.is-danger .message-body{border-color:#cb3c33;color:#c03930}html.theme--documenter-dark .message-header{align-items:center;background-color:#fff;border-radius:.4em .4em 0 0;color:rgba(0,0,0,0.7);display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}html.theme--documenter-dark .message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}html.theme--documenter-dark .message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}html.theme--documenter-dark .message-body{border-color:#5e6d6f;border-radius:.4em;border-style:solid;border-width:0 0 0 4px;color:#fff;padding:1.25em 1.5em}html.theme--documenter-dark .message-body code,html.theme--documenter-dark .message-body pre{background-color:#fff}html.theme--documenter-dark .message-body pre code{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}html.theme--documenter-dark .modal.is-active{display:flex}html.theme--documenter-dark .modal-background{background-color:rgba(10,10,10,0.86)}html.theme--documenter-dark .modal-content,html.theme--documenter-dark .modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){html.theme--documenter-dark .modal-content,html.theme--documenter-dark .modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}html.theme--documenter-dark .modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}html.theme--documenter-dark .modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}html.theme--documenter-dark .modal-card-head,html.theme--documenter-dark .modal-card-foot{align-items:center;background-color:#282f2f;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}html.theme--documenter-dark .modal-card-head{border-bottom:1px solid #5e6d6f;border-top-left-radius:8px;border-top-right-radius:8px}html.theme--documenter-dark .modal-card-title{color:#f2f2f2;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}html.theme--documenter-dark .modal-card-foot{border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid #5e6d6f}html.theme--documenter-dark .modal-card-foot .button:not(:last-child){margin-right:.5em}html.theme--documenter-dark .modal-card-body{-webkit-overflow-scrolling:touch;background-color:#fff;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}html.theme--documenter-dark .navbar{background-color:#375a7f;min-height:4rem;position:relative;z-index:30}html.theme--documenter-dark .navbar.is-white{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-white .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-white .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-white .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-white .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-white .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-white .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-white .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-white .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-white .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-white .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-white .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-white .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-white .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-white .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-white .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-white .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-white .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}html.theme--documenter-dark .navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}html.theme--documenter-dark .navbar.is-black{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-black .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-black .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-black .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-black .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-black .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-black .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-black .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-black .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-black .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-black .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-black .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-black .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-black .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-black .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-black .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-black .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-black .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-black .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-black .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}html.theme--documenter-dark .navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}html.theme--documenter-dark .navbar.is-light{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-light .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-light .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#dde4e6;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-light .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-light .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-light .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-light .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-light .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-light .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-light .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-light .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-light .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-light .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-light .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-light .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-light .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-light .navbar-end .navbar-link.is-active{background-color:#dde4e6;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#dde4e6;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}}html.theme--documenter-dark .navbar.is-dark,html.theme--documenter-dark .content kbd.navbar{background-color:#282f2f;color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-brand>.navbar-item,html.theme--documenter-dark .content kbd.navbar .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-dark .navbar-brand .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .content kbd.navbar .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-dark .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .content kbd.navbar .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-dark .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-dark .navbar-brand .navbar-link:focus,html.theme--documenter-dark .content kbd.navbar .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-dark .navbar-brand .navbar-link:hover,html.theme--documenter-dark .content kbd.navbar .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-dark .navbar-brand .navbar-link.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#1d2122;color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-brand .navbar-link::after,html.theme--documenter-dark .content kbd.navbar .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-burger,html.theme--documenter-dark .content kbd.navbar .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-dark .navbar-start>.navbar-item,html.theme--documenter-dark .content kbd.navbar .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-dark .navbar-start .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-dark .navbar-end>.navbar-item,html.theme--documenter-dark .content kbd.navbar .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-dark .navbar-end .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .content kbd.navbar .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-dark .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .content kbd.navbar .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-dark .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-dark .navbar-start .navbar-link:focus,html.theme--documenter-dark .content kbd.navbar .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-dark .navbar-start .navbar-link:hover,html.theme--documenter-dark .content kbd.navbar .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-dark .navbar-start .navbar-link.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-dark .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .content kbd.navbar .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-dark .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .content kbd.navbar .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-dark .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-dark .navbar-end .navbar-link:focus,html.theme--documenter-dark .content kbd.navbar .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-dark .navbar-end .navbar-link:hover,html.theme--documenter-dark .content kbd.navbar .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-dark .navbar-end .navbar-link.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#1d2122;color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-start .navbar-link::after,html.theme--documenter-dark .content kbd.navbar .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-dark .navbar-end .navbar-link::after,html.theme--documenter-dark .content kbd.navbar .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,html.theme--documenter-dark .content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#1d2122;color:#fff}html.theme--documenter-dark .navbar.is-dark .navbar-dropdown a.navbar-item.is-active,html.theme--documenter-dark .content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#282f2f;color:#fff}}html.theme--documenter-dark .navbar.is-primary,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink{background-color:#375a7f;color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-brand>.navbar-item,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-primary .navbar-brand .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-primary .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-primary .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-primary .navbar-brand .navbar-link:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-primary .navbar-brand .navbar-link:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-primary .navbar-brand .navbar-link.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#2f4d6d;color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-brand .navbar-link::after,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-burger,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-primary .navbar-start>.navbar-item,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-primary .navbar-start .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-primary .navbar-end>.navbar-item,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-primary .navbar-end .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-primary .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-primary .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-primary .navbar-start .navbar-link:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-primary .navbar-start .navbar-link:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-primary .navbar-start .navbar-link.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-primary .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-primary .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-primary .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-primary .navbar-end .navbar-link:focus,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-primary .navbar-end .navbar-link:hover,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-primary .navbar-end .navbar-link.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#2f4d6d;color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-start .navbar-link::after,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-primary .navbar-end .navbar-link::after,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#2f4d6d;color:#fff}html.theme--documenter-dark .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#375a7f;color:#fff}}html.theme--documenter-dark .navbar.is-link{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-link .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-link .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-link .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-link .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-link .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#17a689;color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-link .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-link .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-link .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-link .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-link .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-link .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-link .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-link .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-link .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-link .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-link .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-link .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-link .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-link .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-link .navbar-end .navbar-link.is-active{background-color:#17a689;color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#17a689;color:#fff}html.theme--documenter-dark .navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#1abc9c;color:#fff}}html.theme--documenter-dark .navbar.is-info{background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-info .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-info .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-info .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-info .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-info .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#3151bf;color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-info .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-info .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-info .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-info .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-info .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-info .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-info .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-info .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-info .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-info .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-info .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-info .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-info .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-info .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-info .navbar-end .navbar-link.is-active{background-color:#3151bf;color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-info .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#3151bf;color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#3c5dcd;color:#fff}}html.theme--documenter-dark .navbar.is-success{background-color:#259a12;color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-success .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-success .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-success .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-success .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-success .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#20830f;color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-success .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-success .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-success .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-success .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-success .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-success .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-success .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-success .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-success .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-success .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-success .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-success .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-success .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-success .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-success .navbar-end .navbar-link.is-active{background-color:#20830f;color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-success .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#20830f;color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#259a12;color:#fff}}html.theme--documenter-dark .navbar.is-warning{background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-warning .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-warning .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#f3c017;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-warning .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-warning .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-warning .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-warning .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-warning .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-warning .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-warning .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-warning .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-warning .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-warning .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-warning .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-warning .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-warning .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-warning .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#f3c017;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-warning .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f3c017;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#f4c72f;color:rgba(0,0,0,0.7)}}html.theme--documenter-dark .navbar.is-danger{background-color:#cb3c33;color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-danger .navbar-brand .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-brand>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-danger .navbar-brand>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-danger .navbar-brand>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-danger .navbar-brand .navbar-link:focus,html.theme--documenter-dark .navbar.is-danger .navbar-brand .navbar-link:hover,html.theme--documenter-dark .navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#b7362e;color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar.is-danger .navbar-start>.navbar-item,html.theme--documenter-dark .navbar.is-danger .navbar-start .navbar-link,html.theme--documenter-dark .navbar.is-danger .navbar-end>.navbar-item,html.theme--documenter-dark .navbar.is-danger .navbar-end .navbar-link{color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-start>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-danger .navbar-start>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-danger .navbar-start>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-danger .navbar-start .navbar-link:focus,html.theme--documenter-dark .navbar.is-danger .navbar-start .navbar-link:hover,html.theme--documenter-dark .navbar.is-danger .navbar-start .navbar-link.is-active,html.theme--documenter-dark .navbar.is-danger .navbar-end>a.navbar-item:focus,html.theme--documenter-dark .navbar.is-danger .navbar-end>a.navbar-item:hover,html.theme--documenter-dark .navbar.is-danger .navbar-end>a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-danger .navbar-end .navbar-link:focus,html.theme--documenter-dark .navbar.is-danger .navbar-end .navbar-link:hover,html.theme--documenter-dark .navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#b7362e;color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-start .navbar-link::after,html.theme--documenter-dark .navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#b7362e;color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#cb3c33;color:#fff}}html.theme--documenter-dark .navbar>.container{align-items:stretch;display:flex;min-height:4rem;width:100%}html.theme--documenter-dark .navbar.has-shadow{box-shadow:0 2px 0 0 #282f2f}html.theme--documenter-dark .navbar.is-fixed-bottom,html.theme--documenter-dark .navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}html.theme--documenter-dark .navbar.is-fixed-bottom{bottom:0}html.theme--documenter-dark .navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #282f2f}html.theme--documenter-dark .navbar.is-fixed-top{top:0}html.theme--documenter-dark html.has-navbar-fixed-top,html.theme--documenter-dark body.has-navbar-fixed-top{padding-top:4rem}html.theme--documenter-dark html.has-navbar-fixed-bottom,html.theme--documenter-dark body.has-navbar-fixed-bottom{padding-bottom:4rem}html.theme--documenter-dark .navbar-brand,html.theme--documenter-dark .navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:4rem}html.theme--documenter-dark .navbar-brand a.navbar-item:focus,html.theme--documenter-dark .navbar-brand a.navbar-item:hover{background-color:transparent}html.theme--documenter-dark .navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}html.theme--documenter-dark .navbar-burger{color:#fff;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:4rem;position:relative;width:4rem;margin-left:auto}html.theme--documenter-dark .navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}html.theme--documenter-dark .navbar-burger span:nth-child(1){top:calc(50% - 6px)}html.theme--documenter-dark .navbar-burger span:nth-child(2){top:calc(50% - 1px)}html.theme--documenter-dark .navbar-burger span:nth-child(3){top:calc(50% + 4px)}html.theme--documenter-dark .navbar-burger:hover{background-color:rgba(0,0,0,0.05)}html.theme--documenter-dark .navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}html.theme--documenter-dark .navbar-burger.is-active span:nth-child(2){opacity:0}html.theme--documenter-dark .navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}html.theme--documenter-dark .navbar-menu{display:none}html.theme--documenter-dark .navbar-item,html.theme--documenter-dark .navbar-link{color:#fff;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}html.theme--documenter-dark .navbar-item .icon:only-child,html.theme--documenter-dark .navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}html.theme--documenter-dark a.navbar-item,html.theme--documenter-dark .navbar-link{cursor:pointer}html.theme--documenter-dark a.navbar-item:focus,html.theme--documenter-dark a.navbar-item:focus-within,html.theme--documenter-dark a.navbar-item:hover,html.theme--documenter-dark a.navbar-item.is-active,html.theme--documenter-dark .navbar-link:focus,html.theme--documenter-dark .navbar-link:focus-within,html.theme--documenter-dark .navbar-link:hover,html.theme--documenter-dark .navbar-link.is-active{background-color:rgba(0,0,0,0);color:#1abc9c}html.theme--documenter-dark .navbar-item{flex-grow:0;flex-shrink:0}html.theme--documenter-dark .navbar-item img{max-height:1.75rem}html.theme--documenter-dark .navbar-item.has-dropdown{padding:0}html.theme--documenter-dark .navbar-item.is-expanded{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .navbar-item.is-tab{border-bottom:1px solid transparent;min-height:4rem;padding-bottom:calc(0.5rem - 1px)}html.theme--documenter-dark .navbar-item.is-tab:focus,html.theme--documenter-dark .navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#1abc9c}html.theme--documenter-dark .navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#1abc9c;border-bottom-style:solid;border-bottom-width:3px;color:#1abc9c;padding-bottom:calc(0.5rem - 3px)}html.theme--documenter-dark .navbar-content{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .navbar-link:not(.is-arrowless){padding-right:2.5em}html.theme--documenter-dark .navbar-link:not(.is-arrowless)::after{border-color:#fff;margin-top:-0.375em;right:1.125em}html.theme--documenter-dark .navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}html.theme--documenter-dark .navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}html.theme--documenter-dark .navbar-divider{background-color:rgba(0,0,0,0.2);border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){html.theme--documenter-dark .navbar>.container{display:block}html.theme--documenter-dark .navbar-brand .navbar-item,html.theme--documenter-dark .navbar-tabs .navbar-item{align-items:center;display:flex}html.theme--documenter-dark .navbar-link::after{display:none}html.theme--documenter-dark .navbar-menu{background-color:#375a7f;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}html.theme--documenter-dark .navbar-menu.is-active{display:block}html.theme--documenter-dark .navbar.is-fixed-bottom-touch,html.theme--documenter-dark .navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}html.theme--documenter-dark .navbar.is-fixed-bottom-touch{bottom:0}html.theme--documenter-dark .navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--documenter-dark .navbar.is-fixed-top-touch{top:0}html.theme--documenter-dark .navbar.is-fixed-top .navbar-menu,html.theme--documenter-dark .navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 4rem);overflow:auto}html.theme--documenter-dark html.has-navbar-fixed-top-touch,html.theme--documenter-dark body.has-navbar-fixed-top-touch{padding-top:4rem}html.theme--documenter-dark html.has-navbar-fixed-bottom-touch,html.theme--documenter-dark body.has-navbar-fixed-bottom-touch{padding-bottom:4rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .navbar,html.theme--documenter-dark .navbar-menu,html.theme--documenter-dark .navbar-start,html.theme--documenter-dark .navbar-end{align-items:stretch;display:flex}html.theme--documenter-dark .navbar{min-height:4rem}html.theme--documenter-dark .navbar.is-spaced{padding:1rem 2rem}html.theme--documenter-dark .navbar.is-spaced .navbar-start,html.theme--documenter-dark .navbar.is-spaced .navbar-end{align-items:center}html.theme--documenter-dark .navbar.is-spaced a.navbar-item,html.theme--documenter-dark .navbar.is-spaced .navbar-link{border-radius:.4em}html.theme--documenter-dark .navbar.is-transparent a.navbar-item:focus,html.theme--documenter-dark .navbar.is-transparent a.navbar-item:hover,html.theme--documenter-dark .navbar.is-transparent a.navbar-item.is-active,html.theme--documenter-dark .navbar.is-transparent .navbar-link:focus,html.theme--documenter-dark .navbar.is-transparent .navbar-link:hover,html.theme--documenter-dark .navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}html.theme--documenter-dark .navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,html.theme--documenter-dark .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,html.theme--documenter-dark .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,html.theme--documenter-dark .navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}html.theme--documenter-dark .navbar.is-transparent .navbar-dropdown a.navbar-item:focus,html.theme--documenter-dark .navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#dbdee0}html.theme--documenter-dark .navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#1abc9c}html.theme--documenter-dark .navbar-burger{display:none}html.theme--documenter-dark .navbar-item,html.theme--documenter-dark .navbar-link{align-items:center;display:flex}html.theme--documenter-dark .navbar-item.has-dropdown{align-items:stretch}html.theme--documenter-dark .navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}html.theme--documenter-dark .navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:1px solid rgba(0,0,0,0.2);border-radius:8px 8px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}html.theme--documenter-dark .navbar-item.is-active .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced html.theme--documenter-dark .navbar-item.is-active .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--documenter-dark .navbar-item.is-hoverable:focus .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--documenter-dark .navbar-item.is-hoverable:focus-within .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced html.theme--documenter-dark .navbar-item.is-hoverable:hover .navbar-dropdown,html.theme--documenter-dark .navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}html.theme--documenter-dark .navbar-menu{flex-grow:1;flex-shrink:0}html.theme--documenter-dark .navbar-start{justify-content:flex-start;margin-right:auto}html.theme--documenter-dark .navbar-end{justify-content:flex-end;margin-left:auto}html.theme--documenter-dark .navbar-dropdown{background-color:#375a7f;border-bottom-left-radius:8px;border-bottom-right-radius:8px;border-top:1px solid rgba(0,0,0,0.2);box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}html.theme--documenter-dark .navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}html.theme--documenter-dark .navbar-dropdown a.navbar-item{padding-right:3rem}html.theme--documenter-dark .navbar-dropdown a.navbar-item:focus,html.theme--documenter-dark .navbar-dropdown a.navbar-item:hover{background-color:rgba(0,0,0,0);color:#dbdee0}html.theme--documenter-dark .navbar-dropdown a.navbar-item.is-active{background-color:rgba(0,0,0,0);color:#1abc9c}.navbar.is-spaced html.theme--documenter-dark .navbar-dropdown,html.theme--documenter-dark .navbar-dropdown.is-boxed{border-radius:8px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}html.theme--documenter-dark .navbar-dropdown.is-right{left:auto;right:0}html.theme--documenter-dark .navbar-divider{display:block}html.theme--documenter-dark .navbar>.container .navbar-brand,html.theme--documenter-dark .container>.navbar .navbar-brand{margin-left:-.75rem}html.theme--documenter-dark .navbar>.container .navbar-menu,html.theme--documenter-dark .container>.navbar .navbar-menu{margin-right:-.75rem}html.theme--documenter-dark .navbar.is-fixed-bottom-desktop,html.theme--documenter-dark .navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}html.theme--documenter-dark .navbar.is-fixed-bottom-desktop{bottom:0}html.theme--documenter-dark .navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}html.theme--documenter-dark .navbar.is-fixed-top-desktop{top:0}html.theme--documenter-dark html.has-navbar-fixed-top-desktop,html.theme--documenter-dark body.has-navbar-fixed-top-desktop{padding-top:4rem}html.theme--documenter-dark html.has-navbar-fixed-bottom-desktop,html.theme--documenter-dark body.has-navbar-fixed-bottom-desktop{padding-bottom:4rem}html.theme--documenter-dark html.has-spaced-navbar-fixed-top,html.theme--documenter-dark body.has-spaced-navbar-fixed-top{padding-top:6rem}html.theme--documenter-dark html.has-spaced-navbar-fixed-bottom,html.theme--documenter-dark body.has-spaced-navbar-fixed-bottom{padding-bottom:6rem}html.theme--documenter-dark a.navbar-item.is-active,html.theme--documenter-dark .navbar-link.is-active{color:#1abc9c}html.theme--documenter-dark a.navbar-item.is-active:not(:focus):not(:hover),html.theme--documenter-dark .navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}html.theme--documenter-dark .navbar-item.has-dropdown:focus .navbar-link,html.theme--documenter-dark .navbar-item.has-dropdown:hover .navbar-link,html.theme--documenter-dark .navbar-item.has-dropdown.is-active .navbar-link{background-color:rgba(0,0,0,0)}}html.theme--documenter-dark .hero.is-fullheight-with-navbar{min-height:calc(100vh - 4rem)}html.theme--documenter-dark .pagination{font-size:1rem;margin:-.25rem}html.theme--documenter-dark .pagination.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}html.theme--documenter-dark .pagination.is-medium{font-size:1.25rem}html.theme--documenter-dark .pagination.is-large{font-size:1.5rem}html.theme--documenter-dark .pagination.is-rounded .pagination-previous,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,html.theme--documenter-dark .pagination.is-rounded .pagination-next,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}html.theme--documenter-dark .pagination.is-rounded .pagination-link,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}html.theme--documenter-dark .pagination,html.theme--documenter-dark .pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-link{border-color:#5e6d6f;color:#1abc9c;min-width:2.5em}html.theme--documenter-dark .pagination-previous:hover,html.theme--documenter-dark .pagination-next:hover,html.theme--documenter-dark .pagination-link:hover{border-color:#8c9b9d;color:#1dd2af}html.theme--documenter-dark .pagination-previous:focus,html.theme--documenter-dark .pagination-next:focus,html.theme--documenter-dark .pagination-link:focus{border-color:#8c9b9d}html.theme--documenter-dark .pagination-previous:active,html.theme--documenter-dark .pagination-next:active,html.theme--documenter-dark .pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}html.theme--documenter-dark .pagination-previous[disabled],html.theme--documenter-dark .pagination-previous.is-disabled,html.theme--documenter-dark .pagination-next[disabled],html.theme--documenter-dark .pagination-next.is-disabled,html.theme--documenter-dark .pagination-link[disabled],html.theme--documenter-dark .pagination-link.is-disabled{background-color:#5e6d6f;border-color:#5e6d6f;box-shadow:none;color:#fff;opacity:0.5}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}html.theme--documenter-dark .pagination-link.is-current{background-color:#1abc9c;border-color:#1abc9c;color:#fff}html.theme--documenter-dark .pagination-ellipsis{color:#8c9b9d;pointer-events:none}html.theme--documenter-dark .pagination-list{flex-wrap:wrap}html.theme--documenter-dark .pagination-list li{list-style:none}@media screen and (max-width: 768px){html.theme--documenter-dark .pagination{flex-wrap:wrap}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-ellipsis{margin-bottom:0;margin-top:0}html.theme--documenter-dark .pagination-previous{order:2}html.theme--documenter-dark .pagination-next{order:3}html.theme--documenter-dark .pagination{justify-content:space-between;margin-bottom:0;margin-top:0}html.theme--documenter-dark .pagination.is-centered .pagination-previous{order:1}html.theme--documenter-dark .pagination.is-centered .pagination-list{justify-content:center;order:2}html.theme--documenter-dark .pagination.is-centered .pagination-next{order:3}html.theme--documenter-dark .pagination.is-right .pagination-previous{order:1}html.theme--documenter-dark .pagination.is-right .pagination-next{order:2}html.theme--documenter-dark .pagination.is-right .pagination-list{justify-content:flex-end;order:3}}html.theme--documenter-dark .panel{border-radius:8px;box-shadow:#171717;font-size:1rem}html.theme--documenter-dark .panel:not(:last-child){margin-bottom:1.5rem}html.theme--documenter-dark .panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}html.theme--documenter-dark .panel.is-white .panel-block.is-active .panel-icon{color:#fff}html.theme--documenter-dark .panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}html.theme--documenter-dark .panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}html.theme--documenter-dark .panel.is-light .panel-heading{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .panel.is-light .panel-tabs a.is-active{border-bottom-color:#ecf0f1}html.theme--documenter-dark .panel.is-light .panel-block.is-active .panel-icon{color:#ecf0f1}html.theme--documenter-dark .panel.is-dark .panel-heading,html.theme--documenter-dark .content kbd.panel .panel-heading{background-color:#282f2f;color:#fff}html.theme--documenter-dark .panel.is-dark .panel-tabs a.is-active,html.theme--documenter-dark .content kbd.panel .panel-tabs a.is-active{border-bottom-color:#282f2f}html.theme--documenter-dark .panel.is-dark .panel-block.is-active .panel-icon,html.theme--documenter-dark .content kbd.panel .panel-block.is-active .panel-icon{color:#282f2f}html.theme--documenter-dark .panel.is-primary .panel-heading,html.theme--documenter-dark .docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#375a7f;color:#fff}html.theme--documenter-dark .panel.is-primary .panel-tabs a.is-active,html.theme--documenter-dark .docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#375a7f}html.theme--documenter-dark .panel.is-primary .panel-block.is-active .panel-icon,html.theme--documenter-dark .docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#375a7f}html.theme--documenter-dark .panel.is-link .panel-heading{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .panel.is-link .panel-tabs a.is-active{border-bottom-color:#1abc9c}html.theme--documenter-dark .panel.is-link .panel-block.is-active .panel-icon{color:#1abc9c}html.theme--documenter-dark .panel.is-info .panel-heading{background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .panel.is-info .panel-tabs a.is-active{border-bottom-color:#3c5dcd}html.theme--documenter-dark .panel.is-info .panel-block.is-active .panel-icon{color:#3c5dcd}html.theme--documenter-dark .panel.is-success .panel-heading{background-color:#259a12;color:#fff}html.theme--documenter-dark .panel.is-success .panel-tabs a.is-active{border-bottom-color:#259a12}html.theme--documenter-dark .panel.is-success .panel-block.is-active .panel-icon{color:#259a12}html.theme--documenter-dark .panel.is-warning .panel-heading{background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .panel.is-warning .panel-tabs a.is-active{border-bottom-color:#f4c72f}html.theme--documenter-dark .panel.is-warning .panel-block.is-active .panel-icon{color:#f4c72f}html.theme--documenter-dark .panel.is-danger .panel-heading{background-color:#cb3c33;color:#fff}html.theme--documenter-dark .panel.is-danger .panel-tabs a.is-active{border-bottom-color:#cb3c33}html.theme--documenter-dark .panel.is-danger .panel-block.is-active .panel-icon{color:#cb3c33}html.theme--documenter-dark .panel-tabs:not(:last-child),html.theme--documenter-dark .panel-block:not(:last-child){border-bottom:1px solid #ededed}html.theme--documenter-dark .panel-heading{background-color:#343c3d;border-radius:8px 8px 0 0;color:#f2f2f2;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}html.theme--documenter-dark .panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}html.theme--documenter-dark .panel-tabs a{border-bottom:1px solid #5e6d6f;margin-bottom:-1px;padding:0.5em}html.theme--documenter-dark .panel-tabs a.is-active{border-bottom-color:#343c3d;color:#17a689}html.theme--documenter-dark .panel-list a{color:#fff}html.theme--documenter-dark .panel-list a:hover{color:#1abc9c}html.theme--documenter-dark .panel-block{align-items:center;color:#f2f2f2;display:flex;justify-content:flex-start;padding:0.5em 0.75em}html.theme--documenter-dark .panel-block input[type="checkbox"]{margin-right:.75em}html.theme--documenter-dark .panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}html.theme--documenter-dark .panel-block.is-wrapped{flex-wrap:wrap}html.theme--documenter-dark .panel-block.is-active{border-left-color:#1abc9c;color:#17a689}html.theme--documenter-dark .panel-block.is-active .panel-icon{color:#1abc9c}html.theme--documenter-dark .panel-block:last-child{border-bottom-left-radius:8px;border-bottom-right-radius:8px}html.theme--documenter-dark a.panel-block,html.theme--documenter-dark label.panel-block{cursor:pointer}html.theme--documenter-dark a.panel-block:hover,html.theme--documenter-dark label.panel-block:hover{background-color:#282f2f}html.theme--documenter-dark .panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#fff;margin-right:.75em}html.theme--documenter-dark .panel-icon .fa{font-size:inherit;line-height:inherit}html.theme--documenter-dark .tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}html.theme--documenter-dark .tabs a{align-items:center;border-bottom-color:#5e6d6f;border-bottom-style:solid;border-bottom-width:1px;color:#fff;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}html.theme--documenter-dark .tabs a:hover{border-bottom-color:#f2f2f2;color:#f2f2f2}html.theme--documenter-dark .tabs li{display:block}html.theme--documenter-dark .tabs li.is-active a{border-bottom-color:#1abc9c;color:#1abc9c}html.theme--documenter-dark .tabs ul{align-items:center;border-bottom-color:#5e6d6f;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}html.theme--documenter-dark .tabs ul.is-left{padding-right:0.75em}html.theme--documenter-dark .tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}html.theme--documenter-dark .tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}html.theme--documenter-dark .tabs .icon:first-child{margin-right:.5em}html.theme--documenter-dark .tabs .icon:last-child{margin-left:.5em}html.theme--documenter-dark .tabs.is-centered ul{justify-content:center}html.theme--documenter-dark .tabs.is-right ul{justify-content:flex-end}html.theme--documenter-dark .tabs.is-boxed a{border:1px solid transparent;border-radius:.4em .4em 0 0}html.theme--documenter-dark .tabs.is-boxed a:hover{background-color:#282f2f;border-bottom-color:#5e6d6f}html.theme--documenter-dark .tabs.is-boxed li.is-active a{background-color:#fff;border-color:#5e6d6f;border-bottom-color:rgba(0,0,0,0) !important}html.theme--documenter-dark .tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}html.theme--documenter-dark .tabs.is-toggle a{border-color:#5e6d6f;border-style:solid;border-width:1px;margin-bottom:0;position:relative}html.theme--documenter-dark .tabs.is-toggle a:hover{background-color:#282f2f;border-color:#8c9b9d;z-index:2}html.theme--documenter-dark .tabs.is-toggle li+li{margin-left:-1px}html.theme--documenter-dark .tabs.is-toggle li:first-child a{border-top-left-radius:.4em;border-bottom-left-radius:.4em}html.theme--documenter-dark .tabs.is-toggle li:last-child a{border-top-right-radius:.4em;border-bottom-right-radius:.4em}html.theme--documenter-dark .tabs.is-toggle li.is-active a{background-color:#1abc9c;border-color:#1abc9c;color:#fff;z-index:1}html.theme--documenter-dark .tabs.is-toggle ul{border-bottom:none}html.theme--documenter-dark .tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}html.theme--documenter-dark .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}html.theme--documenter-dark .tabs.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}html.theme--documenter-dark .tabs.is-medium{font-size:1.25rem}html.theme--documenter-dark .tabs.is-large{font-size:1.5rem}html.theme--documenter-dark .column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>html.theme--documenter-dark .column.is-narrow{flex:none;width:unset}.columns.is-mobile>html.theme--documenter-dark .column.is-full{flex:none;width:100%}.columns.is-mobile>html.theme--documenter-dark .column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>html.theme--documenter-dark .column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>html.theme--documenter-dark .column.is-half{flex:none;width:50%}.columns.is-mobile>html.theme--documenter-dark .column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>html.theme--documenter-dark .column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>html.theme--documenter-dark .column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>html.theme--documenter-dark .column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>html.theme--documenter-dark .column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>html.theme--documenter-dark .column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-half{margin-left:50%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>html.theme--documenter-dark .column.is-0{flex:none;width:0%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-0{margin-left:0%}.columns.is-mobile>html.theme--documenter-dark .column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-3{flex:none;width:25%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-3{margin-left:25%}.columns.is-mobile>html.theme--documenter-dark .column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-6{flex:none;width:50%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-6{margin-left:50%}.columns.is-mobile>html.theme--documenter-dark .column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-9{flex:none;width:75%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-9{margin-left:75%}.columns.is-mobile>html.theme--documenter-dark .column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>html.theme--documenter-dark .column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>html.theme--documenter-dark .column.is-12{flex:none;width:100%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){html.theme--documenter-dark .column.is-narrow-mobile{flex:none;width:unset}html.theme--documenter-dark .column.is-full-mobile{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters-mobile{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds-mobile{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half-mobile{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third-mobile{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter-mobile{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth-mobile{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths-mobile{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths-mobile{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths-mobile{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters-mobile{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds-mobile{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half-mobile{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third-mobile{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter-mobile{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth-mobile{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths-mobile{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths-mobile{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths-mobile{margin-left:80%}html.theme--documenter-dark .column.is-0-mobile{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0-mobile{margin-left:0%}html.theme--documenter-dark .column.is-1-mobile{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1-mobile{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2-mobile{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2-mobile{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3-mobile{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3-mobile{margin-left:25%}html.theme--documenter-dark .column.is-4-mobile{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4-mobile{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5-mobile{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5-mobile{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6-mobile{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6-mobile{margin-left:50%}html.theme--documenter-dark .column.is-7-mobile{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7-mobile{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8-mobile{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8-mobile{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9-mobile{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9-mobile{margin-left:75%}html.theme--documenter-dark .column.is-10-mobile{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10-mobile{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11-mobile{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11-mobile{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12-mobile{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .column.is-narrow,html.theme--documenter-dark .column.is-narrow-tablet{flex:none;width:unset}html.theme--documenter-dark .column.is-full,html.theme--documenter-dark .column.is-full-tablet{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters,html.theme--documenter-dark .column.is-three-quarters-tablet{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds,html.theme--documenter-dark .column.is-two-thirds-tablet{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half,html.theme--documenter-dark .column.is-half-tablet{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third,html.theme--documenter-dark .column.is-one-third-tablet{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter,html.theme--documenter-dark .column.is-one-quarter-tablet{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth,html.theme--documenter-dark .column.is-one-fifth-tablet{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths,html.theme--documenter-dark .column.is-two-fifths-tablet{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths,html.theme--documenter-dark .column.is-three-fifths-tablet{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths,html.theme--documenter-dark .column.is-four-fifths-tablet{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters,html.theme--documenter-dark .column.is-offset-three-quarters-tablet{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds,html.theme--documenter-dark .column.is-offset-two-thirds-tablet{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half,html.theme--documenter-dark .column.is-offset-half-tablet{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third,html.theme--documenter-dark .column.is-offset-one-third-tablet{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter,html.theme--documenter-dark .column.is-offset-one-quarter-tablet{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth,html.theme--documenter-dark .column.is-offset-one-fifth-tablet{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths,html.theme--documenter-dark .column.is-offset-two-fifths-tablet{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths,html.theme--documenter-dark .column.is-offset-three-fifths-tablet{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths,html.theme--documenter-dark .column.is-offset-four-fifths-tablet{margin-left:80%}html.theme--documenter-dark .column.is-0,html.theme--documenter-dark .column.is-0-tablet{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0,html.theme--documenter-dark .column.is-offset-0-tablet{margin-left:0%}html.theme--documenter-dark .column.is-1,html.theme--documenter-dark .column.is-1-tablet{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1,html.theme--documenter-dark .column.is-offset-1-tablet{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2,html.theme--documenter-dark .column.is-2-tablet{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2,html.theme--documenter-dark .column.is-offset-2-tablet{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3,html.theme--documenter-dark .column.is-3-tablet{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3,html.theme--documenter-dark .column.is-offset-3-tablet{margin-left:25%}html.theme--documenter-dark .column.is-4,html.theme--documenter-dark .column.is-4-tablet{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4,html.theme--documenter-dark .column.is-offset-4-tablet{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5,html.theme--documenter-dark .column.is-5-tablet{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5,html.theme--documenter-dark .column.is-offset-5-tablet{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6,html.theme--documenter-dark .column.is-6-tablet{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6,html.theme--documenter-dark .column.is-offset-6-tablet{margin-left:50%}html.theme--documenter-dark .column.is-7,html.theme--documenter-dark .column.is-7-tablet{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7,html.theme--documenter-dark .column.is-offset-7-tablet{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8,html.theme--documenter-dark .column.is-8-tablet{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8,html.theme--documenter-dark .column.is-offset-8-tablet{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9,html.theme--documenter-dark .column.is-9-tablet{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9,html.theme--documenter-dark .column.is-offset-9-tablet{margin-left:75%}html.theme--documenter-dark .column.is-10,html.theme--documenter-dark .column.is-10-tablet{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10,html.theme--documenter-dark .column.is-offset-10-tablet{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11,html.theme--documenter-dark .column.is-11-tablet{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11,html.theme--documenter-dark .column.is-offset-11-tablet{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12,html.theme--documenter-dark .column.is-12-tablet{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12,html.theme--documenter-dark .column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){html.theme--documenter-dark .column.is-narrow-touch{flex:none;width:unset}html.theme--documenter-dark .column.is-full-touch{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters-touch{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds-touch{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half-touch{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third-touch{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter-touch{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth-touch{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths-touch{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths-touch{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths-touch{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters-touch{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds-touch{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half-touch{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third-touch{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter-touch{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth-touch{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths-touch{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths-touch{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths-touch{margin-left:80%}html.theme--documenter-dark .column.is-0-touch{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0-touch{margin-left:0%}html.theme--documenter-dark .column.is-1-touch{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1-touch{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2-touch{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2-touch{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3-touch{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3-touch{margin-left:25%}html.theme--documenter-dark .column.is-4-touch{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4-touch{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5-touch{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5-touch{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6-touch{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6-touch{margin-left:50%}html.theme--documenter-dark .column.is-7-touch{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7-touch{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8-touch{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8-touch{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9-touch{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9-touch{margin-left:75%}html.theme--documenter-dark .column.is-10-touch{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10-touch{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11-touch{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11-touch{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12-touch{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){html.theme--documenter-dark .column.is-narrow-desktop{flex:none;width:unset}html.theme--documenter-dark .column.is-full-desktop{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters-desktop{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds-desktop{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half-desktop{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third-desktop{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter-desktop{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth-desktop{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths-desktop{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths-desktop{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths-desktop{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters-desktop{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds-desktop{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half-desktop{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third-desktop{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter-desktop{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth-desktop{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths-desktop{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths-desktop{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths-desktop{margin-left:80%}html.theme--documenter-dark .column.is-0-desktop{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0-desktop{margin-left:0%}html.theme--documenter-dark .column.is-1-desktop{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1-desktop{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2-desktop{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2-desktop{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3-desktop{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3-desktop{margin-left:25%}html.theme--documenter-dark .column.is-4-desktop{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4-desktop{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5-desktop{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5-desktop{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6-desktop{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6-desktop{margin-left:50%}html.theme--documenter-dark .column.is-7-desktop{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7-desktop{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8-desktop{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8-desktop{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9-desktop{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9-desktop{margin-left:75%}html.theme--documenter-dark .column.is-10-desktop{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10-desktop{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11-desktop{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11-desktop{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12-desktop{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){html.theme--documenter-dark .column.is-narrow-widescreen{flex:none;width:unset}html.theme--documenter-dark .column.is-full-widescreen{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters-widescreen{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds-widescreen{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half-widescreen{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third-widescreen{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter-widescreen{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth-widescreen{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths-widescreen{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths-widescreen{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths-widescreen{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters-widescreen{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds-widescreen{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half-widescreen{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third-widescreen{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter-widescreen{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth-widescreen{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths-widescreen{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths-widescreen{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths-widescreen{margin-left:80%}html.theme--documenter-dark .column.is-0-widescreen{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0-widescreen{margin-left:0%}html.theme--documenter-dark .column.is-1-widescreen{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1-widescreen{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2-widescreen{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2-widescreen{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3-widescreen{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3-widescreen{margin-left:25%}html.theme--documenter-dark .column.is-4-widescreen{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4-widescreen{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5-widescreen{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5-widescreen{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6-widescreen{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6-widescreen{margin-left:50%}html.theme--documenter-dark .column.is-7-widescreen{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7-widescreen{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8-widescreen{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8-widescreen{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9-widescreen{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9-widescreen{margin-left:75%}html.theme--documenter-dark .column.is-10-widescreen{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10-widescreen{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11-widescreen{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11-widescreen{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12-widescreen{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){html.theme--documenter-dark .column.is-narrow-fullhd{flex:none;width:unset}html.theme--documenter-dark .column.is-full-fullhd{flex:none;width:100%}html.theme--documenter-dark .column.is-three-quarters-fullhd{flex:none;width:75%}html.theme--documenter-dark .column.is-two-thirds-fullhd{flex:none;width:66.6666%}html.theme--documenter-dark .column.is-half-fullhd{flex:none;width:50%}html.theme--documenter-dark .column.is-one-third-fullhd{flex:none;width:33.3333%}html.theme--documenter-dark .column.is-one-quarter-fullhd{flex:none;width:25%}html.theme--documenter-dark .column.is-one-fifth-fullhd{flex:none;width:20%}html.theme--documenter-dark .column.is-two-fifths-fullhd{flex:none;width:40%}html.theme--documenter-dark .column.is-three-fifths-fullhd{flex:none;width:60%}html.theme--documenter-dark .column.is-four-fifths-fullhd{flex:none;width:80%}html.theme--documenter-dark .column.is-offset-three-quarters-fullhd{margin-left:75%}html.theme--documenter-dark .column.is-offset-two-thirds-fullhd{margin-left:66.6666%}html.theme--documenter-dark .column.is-offset-half-fullhd{margin-left:50%}html.theme--documenter-dark .column.is-offset-one-third-fullhd{margin-left:33.3333%}html.theme--documenter-dark .column.is-offset-one-quarter-fullhd{margin-left:25%}html.theme--documenter-dark .column.is-offset-one-fifth-fullhd{margin-left:20%}html.theme--documenter-dark .column.is-offset-two-fifths-fullhd{margin-left:40%}html.theme--documenter-dark .column.is-offset-three-fifths-fullhd{margin-left:60%}html.theme--documenter-dark .column.is-offset-four-fifths-fullhd{margin-left:80%}html.theme--documenter-dark .column.is-0-fullhd{flex:none;width:0%}html.theme--documenter-dark .column.is-offset-0-fullhd{margin-left:0%}html.theme--documenter-dark .column.is-1-fullhd{flex:none;width:8.33333337%}html.theme--documenter-dark .column.is-offset-1-fullhd{margin-left:8.33333337%}html.theme--documenter-dark .column.is-2-fullhd{flex:none;width:16.66666674%}html.theme--documenter-dark .column.is-offset-2-fullhd{margin-left:16.66666674%}html.theme--documenter-dark .column.is-3-fullhd{flex:none;width:25%}html.theme--documenter-dark .column.is-offset-3-fullhd{margin-left:25%}html.theme--documenter-dark .column.is-4-fullhd{flex:none;width:33.33333337%}html.theme--documenter-dark .column.is-offset-4-fullhd{margin-left:33.33333337%}html.theme--documenter-dark .column.is-5-fullhd{flex:none;width:41.66666674%}html.theme--documenter-dark .column.is-offset-5-fullhd{margin-left:41.66666674%}html.theme--documenter-dark .column.is-6-fullhd{flex:none;width:50%}html.theme--documenter-dark .column.is-offset-6-fullhd{margin-left:50%}html.theme--documenter-dark .column.is-7-fullhd{flex:none;width:58.33333337%}html.theme--documenter-dark .column.is-offset-7-fullhd{margin-left:58.33333337%}html.theme--documenter-dark .column.is-8-fullhd{flex:none;width:66.66666674%}html.theme--documenter-dark .column.is-offset-8-fullhd{margin-left:66.66666674%}html.theme--documenter-dark .column.is-9-fullhd{flex:none;width:75%}html.theme--documenter-dark .column.is-offset-9-fullhd{margin-left:75%}html.theme--documenter-dark .column.is-10-fullhd{flex:none;width:83.33333337%}html.theme--documenter-dark .column.is-offset-10-fullhd{margin-left:83.33333337%}html.theme--documenter-dark .column.is-11-fullhd{flex:none;width:91.66666674%}html.theme--documenter-dark .column.is-offset-11-fullhd{margin-left:91.66666674%}html.theme--documenter-dark .column.is-12-fullhd{flex:none;width:100%}html.theme--documenter-dark .column.is-offset-12-fullhd{margin-left:100%}}html.theme--documenter-dark .columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--documenter-dark .columns:last-child{margin-bottom:-.75rem}html.theme--documenter-dark .columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}html.theme--documenter-dark .columns.is-centered{justify-content:center}html.theme--documenter-dark .columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}html.theme--documenter-dark .columns.is-gapless>.column{margin:0;padding:0 !important}html.theme--documenter-dark .columns.is-gapless:not(:last-child){margin-bottom:1.5rem}html.theme--documenter-dark .columns.is-gapless:last-child{margin-bottom:0}html.theme--documenter-dark .columns.is-mobile{display:flex}html.theme--documenter-dark .columns.is-multiline{flex-wrap:wrap}html.theme--documenter-dark .columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-desktop{display:flex}}html.theme--documenter-dark .columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}html.theme--documenter-dark .columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}html.theme--documenter-dark .columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-0-fullhd{--columnGap: 0rem}}html.theme--documenter-dark .columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-1-fullhd{--columnGap: .25rem}}html.theme--documenter-dark .columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-2-fullhd{--columnGap: .5rem}}html.theme--documenter-dark .columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-3-fullhd{--columnGap: .75rem}}html.theme--documenter-dark .columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-4-fullhd{--columnGap: 1rem}}html.theme--documenter-dark .columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}html.theme--documenter-dark .columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}html.theme--documenter-dark .columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}html.theme--documenter-dark .columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){html.theme--documenter-dark .columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark .columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){html.theme--documenter-dark .columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){html.theme--documenter-dark .columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){html.theme--documenter-dark .columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){html.theme--documenter-dark .columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){html.theme--documenter-dark .columns.is-variable.is-8-fullhd{--columnGap: 2rem}}html.theme--documenter-dark .tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}html.theme--documenter-dark .tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}html.theme--documenter-dark .tile.is-ancestor:last-child{margin-bottom:-.75rem}html.theme--documenter-dark .tile.is-ancestor:not(:last-child){margin-bottom:.75rem}html.theme--documenter-dark .tile.is-child{margin:0 !important}html.theme--documenter-dark .tile.is-parent{padding:.75rem}html.theme--documenter-dark .tile.is-vertical{flex-direction:column}html.theme--documenter-dark .tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{html.theme--documenter-dark .tile:not(.is-child){display:flex}html.theme--documenter-dark .tile.is-1{flex:none;width:8.33333337%}html.theme--documenter-dark .tile.is-2{flex:none;width:16.66666674%}html.theme--documenter-dark .tile.is-3{flex:none;width:25%}html.theme--documenter-dark .tile.is-4{flex:none;width:33.33333337%}html.theme--documenter-dark .tile.is-5{flex:none;width:41.66666674%}html.theme--documenter-dark .tile.is-6{flex:none;width:50%}html.theme--documenter-dark .tile.is-7{flex:none;width:58.33333337%}html.theme--documenter-dark .tile.is-8{flex:none;width:66.66666674%}html.theme--documenter-dark .tile.is-9{flex:none;width:75%}html.theme--documenter-dark .tile.is-10{flex:none;width:83.33333337%}html.theme--documenter-dark .tile.is-11{flex:none;width:91.66666674%}html.theme--documenter-dark .tile.is-12{flex:none;width:100%}}html.theme--documenter-dark .hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}html.theme--documenter-dark .hero .navbar{background:none}html.theme--documenter-dark .hero .tabs ul{border-bottom:none}html.theme--documenter-dark .hero.is-white{background-color:#fff;color:#0a0a0a}html.theme--documenter-dark .hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-white strong{color:inherit}html.theme--documenter-dark .hero.is-white .title{color:#0a0a0a}html.theme--documenter-dark .hero.is-white .subtitle{color:rgba(10,10,10,0.9)}html.theme--documenter-dark .hero.is-white .subtitle a:not(.button),html.theme--documenter-dark .hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-white .navbar-menu{background-color:#fff}}html.theme--documenter-dark .hero.is-white .navbar-item,html.theme--documenter-dark .hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}html.theme--documenter-dark .hero.is-white a.navbar-item:hover,html.theme--documenter-dark .hero.is-white a.navbar-item.is-active,html.theme--documenter-dark .hero.is-white .navbar-link:hover,html.theme--documenter-dark .hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}html.theme--documenter-dark .hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}html.theme--documenter-dark .hero.is-white .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}html.theme--documenter-dark .hero.is-white .tabs.is-boxed a,html.theme--documenter-dark .hero.is-white .tabs.is-toggle a{color:#0a0a0a}html.theme--documenter-dark .hero.is-white .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-white .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-white .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-white .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}html.theme--documenter-dark .hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}html.theme--documenter-dark .hero.is-black{background-color:#0a0a0a;color:#fff}html.theme--documenter-dark .hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-black strong{color:inherit}html.theme--documenter-dark .hero.is-black .title{color:#fff}html.theme--documenter-dark .hero.is-black .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-black .subtitle a:not(.button),html.theme--documenter-dark .hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-black .navbar-menu{background-color:#0a0a0a}}html.theme--documenter-dark .hero.is-black .navbar-item,html.theme--documenter-dark .hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-black a.navbar-item:hover,html.theme--documenter-dark .hero.is-black a.navbar-item.is-active,html.theme--documenter-dark .hero.is-black .navbar-link:hover,html.theme--documenter-dark .hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}html.theme--documenter-dark .hero.is-black .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-black .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}html.theme--documenter-dark .hero.is-black .tabs.is-boxed a,html.theme--documenter-dark .hero.is-black .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-black .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-black .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-black .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-black .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}html.theme--documenter-dark .hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}html.theme--documenter-dark .hero.is-light{background-color:#ecf0f1;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-light strong{color:inherit}html.theme--documenter-dark .hero.is-light .title{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-light .subtitle{color:rgba(0,0,0,0.9)}html.theme--documenter-dark .hero.is-light .subtitle a:not(.button),html.theme--documenter-dark .hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-light .navbar-menu{background-color:#ecf0f1}}html.theme--documenter-dark .hero.is-light .navbar-item,html.theme--documenter-dark .hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-light a.navbar-item:hover,html.theme--documenter-dark .hero.is-light a.navbar-item.is-active,html.theme--documenter-dark .hero.is-light .navbar-link:hover,html.theme--documenter-dark .hero.is-light .navbar-link.is-active{background-color:#dde4e6;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--documenter-dark .hero.is-light .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-light .tabs li.is-active a{color:#ecf0f1 !important;opacity:1}html.theme--documenter-dark .hero.is-light .tabs.is-boxed a,html.theme--documenter-dark .hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-light .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-light .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-light .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-light .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#ecf0f1}html.theme--documenter-dark .hero.is-light.is-bold{background-image:linear-gradient(141deg, #cadfe0 0%, #ecf0f1 71%, #fafbfc 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #cadfe0 0%, #ecf0f1 71%, #fafbfc 100%)}}html.theme--documenter-dark .hero.is-dark,html.theme--documenter-dark .content kbd.hero{background-color:#282f2f;color:#fff}html.theme--documenter-dark .hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-dark strong,html.theme--documenter-dark .content kbd.hero strong{color:inherit}html.theme--documenter-dark .hero.is-dark .title,html.theme--documenter-dark .content kbd.hero .title{color:#fff}html.theme--documenter-dark .hero.is-dark .subtitle,html.theme--documenter-dark .content kbd.hero .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-dark .subtitle a:not(.button),html.theme--documenter-dark .content kbd.hero .subtitle a:not(.button),html.theme--documenter-dark .hero.is-dark .subtitle strong,html.theme--documenter-dark .content kbd.hero .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-dark .navbar-menu,html.theme--documenter-dark .content kbd.hero .navbar-menu{background-color:#282f2f}}html.theme--documenter-dark .hero.is-dark .navbar-item,html.theme--documenter-dark .content kbd.hero .navbar-item,html.theme--documenter-dark .hero.is-dark .navbar-link,html.theme--documenter-dark .content kbd.hero .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-dark a.navbar-item:hover,html.theme--documenter-dark .content kbd.hero a.navbar-item:hover,html.theme--documenter-dark .hero.is-dark a.navbar-item.is-active,html.theme--documenter-dark .content kbd.hero a.navbar-item.is-active,html.theme--documenter-dark .hero.is-dark .navbar-link:hover,html.theme--documenter-dark .content kbd.hero .navbar-link:hover,html.theme--documenter-dark .hero.is-dark .navbar-link.is-active,html.theme--documenter-dark .content kbd.hero .navbar-link.is-active{background-color:#1d2122;color:#fff}html.theme--documenter-dark .hero.is-dark .tabs a,html.theme--documenter-dark .content kbd.hero .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-dark .tabs a:hover,html.theme--documenter-dark .content kbd.hero .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-dark .tabs li.is-active a,html.theme--documenter-dark .content kbd.hero .tabs li.is-active a{color:#282f2f !important;opacity:1}html.theme--documenter-dark .hero.is-dark .tabs.is-boxed a,html.theme--documenter-dark .content kbd.hero .tabs.is-boxed a,html.theme--documenter-dark .hero.is-dark .tabs.is-toggle a,html.theme--documenter-dark .content kbd.hero .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-dark .tabs.is-boxed a:hover,html.theme--documenter-dark .content kbd.hero .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-dark .tabs.is-toggle a:hover,html.theme--documenter-dark .content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-dark .tabs.is-boxed li.is-active a,html.theme--documenter-dark .content kbd.hero .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-dark .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-dark .tabs.is-toggle li.is-active a,html.theme--documenter-dark .content kbd.hero .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#282f2f}html.theme--documenter-dark .hero.is-dark.is-bold,html.theme--documenter-dark .content kbd.hero.is-bold{background-image:linear-gradient(141deg, #0f1615 0%, #282f2f 71%, #313c40 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-dark.is-bold .navbar-menu,html.theme--documenter-dark .content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #0f1615 0%, #282f2f 71%, #313c40 100%)}}html.theme--documenter-dark .hero.is-primary,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink{background-color:#375a7f;color:#fff}html.theme--documenter-dark .hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-primary strong,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink strong{color:inherit}html.theme--documenter-dark .hero.is-primary .title,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .title{color:#fff}html.theme--documenter-dark .hero.is-primary .subtitle,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-primary .subtitle a:not(.button),html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),html.theme--documenter-dark .hero.is-primary .subtitle strong,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-primary .navbar-menu,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#375a7f}}html.theme--documenter-dark .hero.is-primary .navbar-item,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar-item,html.theme--documenter-dark .hero.is-primary .navbar-link,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-primary a.navbar-item:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,html.theme--documenter-dark .hero.is-primary a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,html.theme--documenter-dark .hero.is-primary .navbar-link:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar-link:hover,html.theme--documenter-dark .hero.is-primary .navbar-link.is-active,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#2f4d6d;color:#fff}html.theme--documenter-dark .hero.is-primary .tabs a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-primary .tabs a:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-primary .tabs li.is-active a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#375a7f !important;opacity:1}html.theme--documenter-dark .hero.is-primary .tabs.is-boxed a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,html.theme--documenter-dark .hero.is-primary .tabs.is-toggle a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-primary .tabs.is-boxed a:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-primary .tabs.is-toggle a:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-primary .tabs.is-boxed li.is-active a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-primary .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-primary .tabs.is-toggle li.is-active a,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#375a7f}html.theme--documenter-dark .hero.is-primary.is-bold,html.theme--documenter-dark .docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #214b62 0%, #375a7f 71%, #3a5796 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-primary.is-bold .navbar-menu,html.theme--documenter-dark .docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #214b62 0%, #375a7f 71%, #3a5796 100%)}}html.theme--documenter-dark .hero.is-link{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-link strong{color:inherit}html.theme--documenter-dark .hero.is-link .title{color:#fff}html.theme--documenter-dark .hero.is-link .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-link .subtitle a:not(.button),html.theme--documenter-dark .hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-link .navbar-menu{background-color:#1abc9c}}html.theme--documenter-dark .hero.is-link .navbar-item,html.theme--documenter-dark .hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-link a.navbar-item:hover,html.theme--documenter-dark .hero.is-link a.navbar-item.is-active,html.theme--documenter-dark .hero.is-link .navbar-link:hover,html.theme--documenter-dark .hero.is-link .navbar-link.is-active{background-color:#17a689;color:#fff}html.theme--documenter-dark .hero.is-link .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-link .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-link .tabs li.is-active a{color:#1abc9c !important;opacity:1}html.theme--documenter-dark .hero.is-link .tabs.is-boxed a,html.theme--documenter-dark .hero.is-link .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-link .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-link .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-link .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-link .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#1abc9c}html.theme--documenter-dark .hero.is-link.is-bold{background-image:linear-gradient(141deg, #0c9764 0%, #1abc9c 71%, #17d8d2 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #0c9764 0%, #1abc9c 71%, #17d8d2 100%)}}html.theme--documenter-dark .hero.is-info{background-color:#3c5dcd;color:#fff}html.theme--documenter-dark .hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-info strong{color:inherit}html.theme--documenter-dark .hero.is-info .title{color:#fff}html.theme--documenter-dark .hero.is-info .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-info .subtitle a:not(.button),html.theme--documenter-dark .hero.is-info .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-info .navbar-menu{background-color:#3c5dcd}}html.theme--documenter-dark .hero.is-info .navbar-item,html.theme--documenter-dark .hero.is-info .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-info a.navbar-item:hover,html.theme--documenter-dark .hero.is-info a.navbar-item.is-active,html.theme--documenter-dark .hero.is-info .navbar-link:hover,html.theme--documenter-dark .hero.is-info .navbar-link.is-active{background-color:#3151bf;color:#fff}html.theme--documenter-dark .hero.is-info .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-info .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-info .tabs li.is-active a{color:#3c5dcd !important;opacity:1}html.theme--documenter-dark .hero.is-info .tabs.is-boxed a,html.theme--documenter-dark .hero.is-info .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-info .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-info .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-info .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-info .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#3c5dcd}html.theme--documenter-dark .hero.is-info.is-bold{background-image:linear-gradient(141deg, #215bb5 0%, #3c5dcd 71%, #4b53d8 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #215bb5 0%, #3c5dcd 71%, #4b53d8 100%)}}html.theme--documenter-dark .hero.is-success{background-color:#259a12;color:#fff}html.theme--documenter-dark .hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-success strong{color:inherit}html.theme--documenter-dark .hero.is-success .title{color:#fff}html.theme--documenter-dark .hero.is-success .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-success .subtitle a:not(.button),html.theme--documenter-dark .hero.is-success .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-success .navbar-menu{background-color:#259a12}}html.theme--documenter-dark .hero.is-success .navbar-item,html.theme--documenter-dark .hero.is-success .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-success a.navbar-item:hover,html.theme--documenter-dark .hero.is-success a.navbar-item.is-active,html.theme--documenter-dark .hero.is-success .navbar-link:hover,html.theme--documenter-dark .hero.is-success .navbar-link.is-active{background-color:#20830f;color:#fff}html.theme--documenter-dark .hero.is-success .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-success .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-success .tabs li.is-active a{color:#259a12 !important;opacity:1}html.theme--documenter-dark .hero.is-success .tabs.is-boxed a,html.theme--documenter-dark .hero.is-success .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-success .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-success .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-success .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-success .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#259a12}html.theme--documenter-dark .hero.is-success.is-bold{background-image:linear-gradient(141deg, #287207 0%, #259a12 71%, #10b614 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #287207 0%, #259a12 71%, #10b614 100%)}}html.theme--documenter-dark .hero.is-warning{background-color:#f4c72f;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-warning strong{color:inherit}html.theme--documenter-dark .hero.is-warning .title{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-warning .subtitle{color:rgba(0,0,0,0.9)}html.theme--documenter-dark .hero.is-warning .subtitle a:not(.button),html.theme--documenter-dark .hero.is-warning .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-warning .navbar-menu{background-color:#f4c72f}}html.theme--documenter-dark .hero.is-warning .navbar-item,html.theme--documenter-dark .hero.is-warning .navbar-link{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-warning a.navbar-item:hover,html.theme--documenter-dark .hero.is-warning a.navbar-item.is-active,html.theme--documenter-dark .hero.is-warning .navbar-link:hover,html.theme--documenter-dark .hero.is-warning .navbar-link.is-active{background-color:#f3c017;color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-warning .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}html.theme--documenter-dark .hero.is-warning .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-warning .tabs li.is-active a{color:#f4c72f !important;opacity:1}html.theme--documenter-dark .hero.is-warning .tabs.is-boxed a,html.theme--documenter-dark .hero.is-warning .tabs.is-toggle a{color:rgba(0,0,0,0.7)}html.theme--documenter-dark .hero.is-warning .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-warning .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-warning .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-warning .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f4c72f}html.theme--documenter-dark .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #f09100 0%, #f4c72f 71%, #faef42 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #f09100 0%, #f4c72f 71%, #faef42 100%)}}html.theme--documenter-dark .hero.is-danger{background-color:#cb3c33;color:#fff}html.theme--documenter-dark .hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),html.theme--documenter-dark .hero.is-danger strong{color:inherit}html.theme--documenter-dark .hero.is-danger .title{color:#fff}html.theme--documenter-dark .hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-danger .subtitle a:not(.button),html.theme--documenter-dark .hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-danger .navbar-menu{background-color:#cb3c33}}html.theme--documenter-dark .hero.is-danger .navbar-item,html.theme--documenter-dark .hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}html.theme--documenter-dark .hero.is-danger a.navbar-item:hover,html.theme--documenter-dark .hero.is-danger a.navbar-item.is-active,html.theme--documenter-dark .hero.is-danger .navbar-link:hover,html.theme--documenter-dark .hero.is-danger .navbar-link.is-active{background-color:#b7362e;color:#fff}html.theme--documenter-dark .hero.is-danger .tabs a{color:#fff;opacity:0.9}html.theme--documenter-dark .hero.is-danger .tabs a:hover{opacity:1}html.theme--documenter-dark .hero.is-danger .tabs li.is-active a{color:#cb3c33 !important;opacity:1}html.theme--documenter-dark .hero.is-danger .tabs.is-boxed a,html.theme--documenter-dark .hero.is-danger .tabs.is-toggle a{color:#fff}html.theme--documenter-dark .hero.is-danger .tabs.is-boxed a:hover,html.theme--documenter-dark .hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}html.theme--documenter-dark .hero.is-danger .tabs.is-boxed li.is-active a,html.theme--documenter-dark .hero.is-danger .tabs.is-boxed li.is-active a:hover,html.theme--documenter-dark .hero.is-danger .tabs.is-toggle li.is-active a,html.theme--documenter-dark .hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#cb3c33}html.theme--documenter-dark .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #ac1f2e 0%, #cb3c33 71%, #d66341 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #ac1f2e 0%, #cb3c33 71%, #d66341 100%)}}html.theme--documenter-dark .hero.is-small .hero-body,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero.is-large .hero-body{padding:18rem 6rem}}html.theme--documenter-dark .hero.is-halfheight .hero-body,html.theme--documenter-dark .hero.is-fullheight .hero-body,html.theme--documenter-dark .hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}html.theme--documenter-dark .hero.is-halfheight .hero-body>.container,html.theme--documenter-dark .hero.is-fullheight .hero-body>.container,html.theme--documenter-dark .hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}html.theme--documenter-dark .hero.is-halfheight{min-height:50vh}html.theme--documenter-dark .hero.is-fullheight{min-height:100vh}html.theme--documenter-dark .hero-video{overflow:hidden}html.theme--documenter-dark .hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}html.theme--documenter-dark .hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){html.theme--documenter-dark .hero-video{display:none}}html.theme--documenter-dark .hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){html.theme--documenter-dark .hero-buttons .button{display:flex}html.theme--documenter-dark .hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero-buttons{display:flex;justify-content:center}html.theme--documenter-dark .hero-buttons .button:not(:last-child){margin-right:1.5rem}}html.theme--documenter-dark .hero-head,html.theme--documenter-dark .hero-foot{flex-grow:0;flex-shrink:0}html.theme--documenter-dark .hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero-body{padding:3rem 3rem}}html.theme--documenter-dark .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--documenter-dark .section{padding:3rem 3rem}html.theme--documenter-dark .section.is-medium{padding:9rem 4.5rem}html.theme--documenter-dark .section.is-large{padding:18rem 6rem}}html.theme--documenter-dark .footer{background-color:#282f2f;padding:3rem 1.5rem 6rem}html.theme--documenter-dark hr{height:1px}html.theme--documenter-dark h6{text-transform:uppercase;letter-spacing:0.5px}html.theme--documenter-dark .hero{background-color:#343c3d}html.theme--documenter-dark a{transition:all 200ms ease}html.theme--documenter-dark .button{transition:all 200ms ease;border-width:1px;color:#fff}html.theme--documenter-dark .button.is-active,html.theme--documenter-dark .button.is-focused,html.theme--documenter-dark .button:active,html.theme--documenter-dark .button:focus{box-shadow:0 0 0 2px rgba(140,155,157,0.5)}html.theme--documenter-dark .button.is-white.is-hovered,html.theme--documenter-dark .button.is-white:hover{background-color:#fff}html.theme--documenter-dark .button.is-white.is-active,html.theme--documenter-dark .button.is-white.is-focused,html.theme--documenter-dark .button.is-white:active,html.theme--documenter-dark .button.is-white:focus{border-color:#fff;box-shadow:0 0 0 2px rgba(255,255,255,0.5)}html.theme--documenter-dark .button.is-black.is-hovered,html.theme--documenter-dark .button.is-black:hover{background-color:#1d1d1d}html.theme--documenter-dark .button.is-black.is-active,html.theme--documenter-dark .button.is-black.is-focused,html.theme--documenter-dark .button.is-black:active,html.theme--documenter-dark .button.is-black:focus{border-color:#0a0a0a;box-shadow:0 0 0 2px rgba(10,10,10,0.5)}html.theme--documenter-dark .button.is-light.is-hovered,html.theme--documenter-dark .button.is-light:hover{background-color:#fff}html.theme--documenter-dark .button.is-light.is-active,html.theme--documenter-dark .button.is-light.is-focused,html.theme--documenter-dark .button.is-light:active,html.theme--documenter-dark .button.is-light:focus{border-color:#ecf0f1;box-shadow:0 0 0 2px rgba(236,240,241,0.5)}html.theme--documenter-dark .button.is-dark.is-hovered,html.theme--documenter-dark .content kbd.button.is-hovered,html.theme--documenter-dark .button.is-dark:hover,html.theme--documenter-dark .content kbd.button:hover{background-color:#3a4344}html.theme--documenter-dark .button.is-dark.is-active,html.theme--documenter-dark .content kbd.button.is-active,html.theme--documenter-dark .button.is-dark.is-focused,html.theme--documenter-dark .content kbd.button.is-focused,html.theme--documenter-dark .button.is-dark:active,html.theme--documenter-dark .content kbd.button:active,html.theme--documenter-dark .button.is-dark:focus,html.theme--documenter-dark .content kbd.button:focus{border-color:#282f2f;box-shadow:0 0 0 2px rgba(40,47,47,0.5)}html.theme--documenter-dark .button.is-primary.is-hovered,html.theme--documenter-dark .docstring>section>a.button.is-hovered.docs-sourcelink,html.theme--documenter-dark .button.is-primary:hover,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:hover{background-color:#436d9a}html.theme--documenter-dark .button.is-primary.is-active,html.theme--documenter-dark .docstring>section>a.button.is-active.docs-sourcelink,html.theme--documenter-dark .button.is-primary.is-focused,html.theme--documenter-dark .docstring>section>a.button.is-focused.docs-sourcelink,html.theme--documenter-dark .button.is-primary:active,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:active,html.theme--documenter-dark .button.is-primary:focus,html.theme--documenter-dark .docstring>section>a.button.docs-sourcelink:focus{border-color:#375a7f;box-shadow:0 0 0 2px rgba(55,90,127,0.5)}html.theme--documenter-dark .button.is-link.is-hovered,html.theme--documenter-dark .button.is-link:hover{background-color:#1fdeb8}html.theme--documenter-dark .button.is-link.is-active,html.theme--documenter-dark .button.is-link.is-focused,html.theme--documenter-dark .button.is-link:active,html.theme--documenter-dark .button.is-link:focus{border-color:#1abc9c;box-shadow:0 0 0 2px rgba(26,188,156,0.5)}html.theme--documenter-dark .button.is-info.is-hovered,html.theme--documenter-dark .button.is-info:hover{background-color:#5a76d5}html.theme--documenter-dark .button.is-info.is-active,html.theme--documenter-dark .button.is-info.is-focused,html.theme--documenter-dark .button.is-info:active,html.theme--documenter-dark .button.is-info:focus{border-color:#3c5dcd;box-shadow:0 0 0 2px rgba(60,93,205,0.5)}html.theme--documenter-dark .button.is-success.is-hovered,html.theme--documenter-dark .button.is-success:hover{background-color:#2dbc16}html.theme--documenter-dark .button.is-success.is-active,html.theme--documenter-dark .button.is-success.is-focused,html.theme--documenter-dark .button.is-success:active,html.theme--documenter-dark .button.is-success:focus{border-color:#259a12;box-shadow:0 0 0 2px rgba(37,154,18,0.5)}html.theme--documenter-dark .button.is-warning.is-hovered,html.theme--documenter-dark .button.is-warning:hover{background-color:#f6d153}html.theme--documenter-dark .button.is-warning.is-active,html.theme--documenter-dark .button.is-warning.is-focused,html.theme--documenter-dark .button.is-warning:active,html.theme--documenter-dark .button.is-warning:focus{border-color:#f4c72f;box-shadow:0 0 0 2px rgba(244,199,47,0.5)}html.theme--documenter-dark .button.is-danger.is-hovered,html.theme--documenter-dark .button.is-danger:hover{background-color:#d35951}html.theme--documenter-dark .button.is-danger.is-active,html.theme--documenter-dark .button.is-danger.is-focused,html.theme--documenter-dark .button.is-danger:active,html.theme--documenter-dark .button.is-danger:focus{border-color:#cb3c33;box-shadow:0 0 0 2px rgba(203,60,51,0.5)}html.theme--documenter-dark .label{color:#dbdee0}html.theme--documenter-dark .button,html.theme--documenter-dark .control.has-icons-left .icon,html.theme--documenter-dark .control.has-icons-right .icon,html.theme--documenter-dark .input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark .pagination-ellipsis,html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .select,html.theme--documenter-dark .select select,html.theme--documenter-dark .textarea{height:2.5em}html.theme--documenter-dark .input,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark .textarea{transition:all 200ms ease;box-shadow:none;border-width:1px;padding-left:1em;padding-right:1em}html.theme--documenter-dark .select:after,html.theme--documenter-dark .select select{border-width:1px}html.theme--documenter-dark .control.has-addons .button,html.theme--documenter-dark .control.has-addons .input,html.theme--documenter-dark .control.has-addons #documenter .docs-sidebar form.docs-search>input,html.theme--documenter-dark #documenter .docs-sidebar .control.has-addons form.docs-search>input,html.theme--documenter-dark .control.has-addons .select{margin-right:-1px}html.theme--documenter-dark .notification{background-color:#343c3d}html.theme--documenter-dark .card{box-shadow:none;border:1px solid #343c3d;background-color:#282f2f;border-radius:.4em}html.theme--documenter-dark .card .card-image img{border-radius:.4em .4em 0 0}html.theme--documenter-dark .card .card-header{box-shadow:none;background-color:rgba(18,18,18,0.2);border-radius:.4em .4em 0 0}html.theme--documenter-dark .card .card-footer{background-color:rgba(18,18,18,0.2)}html.theme--documenter-dark .card .card-footer,html.theme--documenter-dark .card .card-footer-item{border-width:1px;border-color:#343c3d}html.theme--documenter-dark .notification.is-white a:not(.button){color:#0a0a0a;text-decoration:underline}html.theme--documenter-dark .notification.is-black a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-light a:not(.button){color:rgba(0,0,0,0.7);text-decoration:underline}html.theme--documenter-dark .notification.is-dark a:not(.button),html.theme--documenter-dark .content kbd.notification a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-primary a:not(.button),html.theme--documenter-dark .docstring>section>a.notification.docs-sourcelink a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-link a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-info a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-success a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .notification.is-warning a:not(.button){color:rgba(0,0,0,0.7);text-decoration:underline}html.theme--documenter-dark .notification.is-danger a:not(.button){color:#fff;text-decoration:underline}html.theme--documenter-dark .tag,html.theme--documenter-dark .content kbd,html.theme--documenter-dark .docstring>section>a.docs-sourcelink{border-radius:.4em}html.theme--documenter-dark .menu-list a{transition:all 300ms ease}html.theme--documenter-dark .modal-card-body{background-color:#282f2f}html.theme--documenter-dark .modal-card-foot,html.theme--documenter-dark .modal-card-head{border-color:#343c3d}html.theme--documenter-dark .message-header{font-weight:700;background-color:#343c3d;color:#fff}html.theme--documenter-dark .message-body{border-width:1px;border-color:#343c3d}html.theme--documenter-dark .navbar{border-radius:.4em}html.theme--documenter-dark .navbar.is-transparent{background:none}html.theme--documenter-dark .navbar.is-primary .navbar-dropdown a.navbar-item.is-active,html.theme--documenter-dark .docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#1abc9c}@media screen and (max-width: 1055px){html.theme--documenter-dark .navbar .navbar-menu{background-color:#375a7f;border-radius:0 0 .4em .4em}}html.theme--documenter-dark .hero .navbar,html.theme--documenter-dark body>.navbar{border-radius:0}html.theme--documenter-dark .pagination-link,html.theme--documenter-dark .pagination-next,html.theme--documenter-dark .pagination-previous{border-width:1px}html.theme--documenter-dark .panel-block,html.theme--documenter-dark .panel-heading,html.theme--documenter-dark .panel-tabs{border-width:1px}html.theme--documenter-dark .panel-block:first-child,html.theme--documenter-dark .panel-heading:first-child,html.theme--documenter-dark .panel-tabs:first-child{border-top-width:1px}html.theme--documenter-dark .panel-heading{font-weight:700}html.theme--documenter-dark .panel-tabs a{border-width:1px;margin-bottom:-1px}html.theme--documenter-dark .panel-tabs a.is-active{border-bottom-color:#17a689}html.theme--documenter-dark .panel-block:hover{color:#1dd2af}html.theme--documenter-dark .panel-block:hover .panel-icon{color:#1dd2af}html.theme--documenter-dark .panel-block.is-active .panel-icon{color:#17a689}html.theme--documenter-dark .tabs a{border-bottom-width:1px;margin-bottom:-1px}html.theme--documenter-dark .tabs ul{border-bottom-width:1px}html.theme--documenter-dark .tabs.is-boxed a{border-width:1px}html.theme--documenter-dark .tabs.is-boxed li.is-active a{background-color:#1f2424}html.theme--documenter-dark .tabs.is-toggle li a{border-width:1px;margin-bottom:0}html.theme--documenter-dark .tabs.is-toggle li+li{margin-left:-1px}html.theme--documenter-dark .hero.is-white .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-black .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-light .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-dark .navbar .navbar-dropdown .navbar-item:hover,html.theme--documenter-dark .content kbd.hero .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-primary .navbar .navbar-dropdown .navbar-item:hover,html.theme--documenter-dark .docstring>section>a.hero.docs-sourcelink .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-link .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-info .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-success .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-warning .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark .hero.is-danger .navbar .navbar-dropdown .navbar-item:hover{background-color:rgba(0,0,0,0)}html.theme--documenter-dark h1 .docs-heading-anchor,html.theme--documenter-dark h1 .docs-heading-anchor:hover,html.theme--documenter-dark h1 .docs-heading-anchor:visited,html.theme--documenter-dark h2 .docs-heading-anchor,html.theme--documenter-dark h2 .docs-heading-anchor:hover,html.theme--documenter-dark h2 .docs-heading-anchor:visited,html.theme--documenter-dark h3 .docs-heading-anchor,html.theme--documenter-dark h3 .docs-heading-anchor:hover,html.theme--documenter-dark h3 .docs-heading-anchor:visited,html.theme--documenter-dark h4 .docs-heading-anchor,html.theme--documenter-dark h4 .docs-heading-anchor:hover,html.theme--documenter-dark h4 .docs-heading-anchor:visited,html.theme--documenter-dark h5 .docs-heading-anchor,html.theme--documenter-dark h5 .docs-heading-anchor:hover,html.theme--documenter-dark h5 .docs-heading-anchor:visited,html.theme--documenter-dark h6 .docs-heading-anchor,html.theme--documenter-dark h6 .docs-heading-anchor:hover,html.theme--documenter-dark h6 .docs-heading-anchor:visited{color:#f2f2f2}html.theme--documenter-dark h1 .docs-heading-anchor-permalink,html.theme--documenter-dark h2 .docs-heading-anchor-permalink,html.theme--documenter-dark h3 .docs-heading-anchor-permalink,html.theme--documenter-dark h4 .docs-heading-anchor-permalink,html.theme--documenter-dark h5 .docs-heading-anchor-permalink,html.theme--documenter-dark h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}html.theme--documenter-dark h1 .docs-heading-anchor-permalink::before,html.theme--documenter-dark h2 .docs-heading-anchor-permalink::before,html.theme--documenter-dark h3 .docs-heading-anchor-permalink::before,html.theme--documenter-dark h4 .docs-heading-anchor-permalink::before,html.theme--documenter-dark h5 .docs-heading-anchor-permalink::before,html.theme--documenter-dark h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}html.theme--documenter-dark h1:hover .docs-heading-anchor-permalink,html.theme--documenter-dark h2:hover .docs-heading-anchor-permalink,html.theme--documenter-dark h3:hover .docs-heading-anchor-permalink,html.theme--documenter-dark h4:hover .docs-heading-anchor-permalink,html.theme--documenter-dark h5:hover .docs-heading-anchor-permalink,html.theme--documenter-dark h6:hover .docs-heading-anchor-permalink{visibility:visible}html.theme--documenter-dark .docs-light-only{display:none !important}html.theme--documenter-dark pre{position:relative;overflow:hidden}html.theme--documenter-dark pre code,html.theme--documenter-dark pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}html.theme--documenter-dark pre code:first-of-type,html.theme--documenter-dark pre code.hljs:first-of-type{padding-top:0.5rem !important}html.theme--documenter-dark pre code:last-of-type,html.theme--documenter-dark pre code.hljs:last-of-type{padding-bottom:0.5rem !important}html.theme--documenter-dark pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#fff;cursor:pointer;text-align:center}html.theme--documenter-dark pre .copy-button:focus,html.theme--documenter-dark pre .copy-button:hover{opacity:1;background:rgba(255,255,255,0.1);color:#1abc9c}html.theme--documenter-dark pre .copy-button.success{color:#259a12;opacity:1}html.theme--documenter-dark pre .copy-button.error{color:#cb3c33;opacity:1}html.theme--documenter-dark pre:hover .copy-button{opacity:1}html.theme--documenter-dark .admonition{background-color:#282f2f;border-style:solid;border-width:2px;border-color:#dbdee0;border-radius:4px;font-size:1rem}html.theme--documenter-dark .admonition strong{color:currentColor}html.theme--documenter-dark .admonition.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}html.theme--documenter-dark .admonition.is-medium{font-size:1.25rem}html.theme--documenter-dark .admonition.is-large{font-size:1.5rem}html.theme--documenter-dark .admonition.is-default{background-color:#282f2f;border-color:#dbdee0}html.theme--documenter-dark .admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#dbdee0}html.theme--documenter-dark .admonition.is-default>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-info{background-color:#282f2f;border-color:#3c5dcd}html.theme--documenter-dark .admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#3c5dcd}html.theme--documenter-dark .admonition.is-info>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-success{background-color:#282f2f;border-color:#259a12}html.theme--documenter-dark .admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#259a12}html.theme--documenter-dark .admonition.is-success>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-warning{background-color:#282f2f;border-color:#f4c72f}html.theme--documenter-dark .admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#f4c72f}html.theme--documenter-dark .admonition.is-warning>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-danger{background-color:#282f2f;border-color:#cb3c33}html.theme--documenter-dark .admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#cb3c33}html.theme--documenter-dark .admonition.is-danger>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-compat{background-color:#282f2f;border-color:#3489da}html.theme--documenter-dark .admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#3489da}html.theme--documenter-dark .admonition.is-compat>.admonition-body{color:#fff}html.theme--documenter-dark .admonition-header{color:#dbdee0;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}html.theme--documenter-dark .admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}html.theme--documenter-dark details.admonition.is-details>.admonition-header{list-style:none}html.theme--documenter-dark details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}html.theme--documenter-dark details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}html.theme--documenter-dark .admonition-body{color:#fff;padding:0.5rem .75rem}html.theme--documenter-dark .admonition-body pre{background-color:#282f2f}html.theme--documenter-dark .admonition-body code{background-color:rgba(255,255,255,0.05)}html.theme--documenter-dark .docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #5e6d6f;border-radius:4px;box-shadow:none;max-width:100%}html.theme--documenter-dark .docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#282f2f;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #5e6d6f;overflow:auto}html.theme--documenter-dark .docstring>header code{background-color:transparent}html.theme--documenter-dark .docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}html.theme--documenter-dark .docstring>header .docstring-binding{margin-right:0.3em}html.theme--documenter-dark .docstring>header .docstring-category{margin-left:0.3em}html.theme--documenter-dark .docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #5e6d6f}html.theme--documenter-dark .docstring>section:last-child{border-bottom:none}html.theme--documenter-dark .docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}html.theme--documenter-dark .docstring>section>a.docs-sourcelink:focus{opacity:1 !important}html.theme--documenter-dark .docstring:hover>section>a.docs-sourcelink{opacity:0.2}html.theme--documenter-dark .docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}html.theme--documenter-dark .docstring>section:hover a.docs-sourcelink{opacity:1}html.theme--documenter-dark .documenter-example-output{background-color:#1f2424}html.theme--documenter-dark .outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#282f2f;color:#fff;border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}html.theme--documenter-dark .outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}html.theme--documenter-dark .outdated-warning-overlay a{color:#1abc9c}html.theme--documenter-dark .outdated-warning-overlay a:hover{color:#1dd2af}html.theme--documenter-dark .content pre{border:2px solid #5e6d6f;border-radius:4px}html.theme--documenter-dark .content code{font-weight:inherit}html.theme--documenter-dark .content a code{color:#1abc9c}html.theme--documenter-dark .content a:hover code{color:#1dd2af}html.theme--documenter-dark .content h1 code,html.theme--documenter-dark .content h2 code,html.theme--documenter-dark .content h3 code,html.theme--documenter-dark .content h4 code,html.theme--documenter-dark .content h5 code,html.theme--documenter-dark .content h6 code{color:#f2f2f2}html.theme--documenter-dark .content table{display:block;width:initial;max-width:100%;overflow-x:auto}html.theme--documenter-dark .content blockquote>ul:first-child,html.theme--documenter-dark .content blockquote>ol:first-child,html.theme--documenter-dark .content .admonition-body>ul:first-child,html.theme--documenter-dark .content .admonition-body>ol:first-child{margin-top:0}html.theme--documenter-dark pre,html.theme--documenter-dark code{font-variant-ligatures:no-contextual}html.theme--documenter-dark .breadcrumb a.is-disabled{cursor:default;pointer-events:none}html.theme--documenter-dark .breadcrumb a.is-disabled,html.theme--documenter-dark .breadcrumb a.is-disabled:hover{color:#f2f2f2}html.theme--documenter-dark .hljs{background:initial !important}html.theme--documenter-dark .katex .katex-mathml{top:0;right:0}html.theme--documenter-dark .katex-display,html.theme--documenter-dark mjx-container,html.theme--documenter-dark .MathJax_Display{margin:0.5em 0 !important}html.theme--documenter-dark html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}html.theme--documenter-dark li.no-marker{list-style:none}html.theme--documenter-dark #documenter .docs-main>article{overflow-wrap:break-word}html.theme--documenter-dark #documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){html.theme--documenter-dark #documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){html.theme--documenter-dark #documenter .docs-main{width:100%}html.theme--documenter-dark #documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}html.theme--documenter-dark #documenter .docs-main>header,html.theme--documenter-dark #documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}html.theme--documenter-dark #documenter .docs-main header.docs-navbar{background-color:#1f2424;border-bottom:1px solid #5e6d6f;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-icon,html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}html.theme--documenter-dark #documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){html.theme--documenter-dark #documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}html.theme--documenter-dark #documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #171717;transition-duration:0.7s;-webkit-transition-duration:0.7s}html.theme--documenter-dark #documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}html.theme--documenter-dark #documenter .docs-main section.footnotes{border-top:1px solid #5e6d6f}html.theme--documenter-dark #documenter .docs-main section.footnotes li .tag:first-child,html.theme--documenter-dark #documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,html.theme--documenter-dark #documenter .docs-main section.footnotes li .content kbd:first-child,html.theme--documenter-dark .content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}html.theme--documenter-dark #documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #5e6d6f;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){html.theme--documenter-dark #documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}html.theme--documenter-dark #documenter .docs-main .docs-footer .docs-footer-nextpage,html.theme--documenter-dark #documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}html.theme--documenter-dark #documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}html.theme--documenter-dark #documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}html.theme--documenter-dark #documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}html.theme--documenter-dark #documenter .docs-sidebar{display:flex;flex-direction:column;color:#fff;background-color:#282f2f;border-right:1px solid #5e6d6f;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}html.theme--documenter-dark #documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #171717}@media screen and (min-width: 1056px){html.theme--documenter-dark #documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){html.theme--documenter-dark #documenter .docs-sidebar{left:0;top:0}}html.theme--documenter-dark #documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}html.theme--documenter-dark #documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}html.theme--documenter-dark #documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}html.theme--documenter-dark #documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}html.theme--documenter-dark #documenter .docs-sidebar .docs-package-name a,html.theme--documenter-dark #documenter .docs-sidebar .docs-package-name a:hover{color:#fff}html.theme--documenter-dark #documenter .docs-sidebar .docs-version-selector{border-top:1px solid #5e6d6f;display:none;padding:0.5rem}html.theme--documenter-dark #documenter .docs-sidebar .docs-version-selector.visible{display:flex}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #5e6d6f;padding-bottom:1.5rem}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #5e6d6f}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu .tocitem,html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#fff;background:#282f2f}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu a.tocitem:hover,html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#fff;background-color:#32393a}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #5e6d6f;border-bottom:1px solid #5e6d6f;background-color:#1f2424}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#1f2424;color:#fff}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#32393a;color:#fff}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #5e6d6f}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}html.theme--documenter-dark #documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input{width:14.4rem}html.theme--documenter-dark #documenter .docs-sidebar #documenter-search-query{color:#868c98;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#3b4445}html.theme--documenter-dark #documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#4e5a5c}}@media screen and (max-width: 1055px){html.theme--documenter-dark #documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}html.theme--documenter-dark #documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}html.theme--documenter-dark #documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#3b4445}html.theme--documenter-dark #documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#4e5a5c}}html.theme--documenter-dark kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(245,245,245,0.6);box-shadow:0 2px 0 1px rgba(245,245,245,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}html.theme--documenter-dark .search-min-width-50{min-width:50%}html.theme--documenter-dark .search-min-height-100{min-height:100%}html.theme--documenter-dark .search-modal-card-body{max-height:calc(100vh - 15rem)}html.theme--documenter-dark .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--documenter-dark .search-result-link:hover,html.theme--documenter-dark .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--documenter-dark .search-result-link .property-search-result-badge,html.theme--documenter-dark .search-result-link .search-filter{transition:all 300ms}html.theme--documenter-dark .property-search-result-badge,html.theme--documenter-dark .search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}html.theme--documenter-dark .search-result-link:hover .property-search-result-badge,html.theme--documenter-dark .search-result-link:hover .search-filter,html.theme--documenter-dark .search-result-link:focus .property-search-result-badge,html.theme--documenter-dark .search-result-link:focus .search-filter{color:#333;background-color:#f1f5f9}html.theme--documenter-dark .search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}html.theme--documenter-dark .search-filter:hover,html.theme--documenter-dark .search-filter:focus{color:#333}html.theme--documenter-dark .search-filter-selected{color:#f5f5f5;background-color:rgba(139,0,139,0.5)}html.theme--documenter-dark .search-filter-selected:hover,html.theme--documenter-dark .search-filter-selected:focus{color:#f5f5f5}html.theme--documenter-dark .search-result-highlight{background-color:#ffdd57;color:black}html.theme--documenter-dark .search-divider{border-bottom:1px solid #5e6d6f}html.theme--documenter-dark .search-result-title{width:85%;color:#f5f5f5}html.theme--documenter-dark .search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}html.theme--documenter-dark #search-modal .modal-card-body::-webkit-scrollbar,html.theme--documenter-dark #search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}html.theme--documenter-dark #search-modal .modal-card-body::-webkit-scrollbar-thumb,html.theme--documenter-dark #search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}html.theme--documenter-dark #search-modal .modal-card-body::-webkit-scrollbar-track,html.theme--documenter-dark #search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}html.theme--documenter-dark .w-100{width:100%}html.theme--documenter-dark .gap-2{gap:0.5rem}html.theme--documenter-dark .gap-4{gap:1rem}html.theme--documenter-dark .gap-8{gap:2rem}html.theme--documenter-dark{background-color:#1f2424;font-size:16px;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}html.theme--documenter-dark .ansi span.sgr1{font-weight:bolder}html.theme--documenter-dark .ansi span.sgr2{font-weight:lighter}html.theme--documenter-dark .ansi span.sgr3{font-style:italic}html.theme--documenter-dark .ansi span.sgr4{text-decoration:underline}html.theme--documenter-dark .ansi span.sgr7{color:#1f2424;background-color:#fff}html.theme--documenter-dark .ansi span.sgr8{color:transparent}html.theme--documenter-dark .ansi span.sgr8 span{color:transparent}html.theme--documenter-dark .ansi span.sgr9{text-decoration:line-through}html.theme--documenter-dark .ansi span.sgr30{color:#242424}html.theme--documenter-dark .ansi span.sgr31{color:#f6705f}html.theme--documenter-dark .ansi span.sgr32{color:#4fb43a}html.theme--documenter-dark .ansi span.sgr33{color:#f4c72f}html.theme--documenter-dark .ansi span.sgr34{color:#7587f0}html.theme--documenter-dark .ansi span.sgr35{color:#bc89d3}html.theme--documenter-dark .ansi span.sgr36{color:#49b6ca}html.theme--documenter-dark .ansi span.sgr37{color:#b3bdbe}html.theme--documenter-dark .ansi span.sgr40{background-color:#242424}html.theme--documenter-dark .ansi span.sgr41{background-color:#f6705f}html.theme--documenter-dark .ansi span.sgr42{background-color:#4fb43a}html.theme--documenter-dark .ansi span.sgr43{background-color:#f4c72f}html.theme--documenter-dark .ansi span.sgr44{background-color:#7587f0}html.theme--documenter-dark .ansi span.sgr45{background-color:#bc89d3}html.theme--documenter-dark .ansi span.sgr46{background-color:#49b6ca}html.theme--documenter-dark .ansi span.sgr47{background-color:#b3bdbe}html.theme--documenter-dark .ansi span.sgr90{color:#92a0a2}html.theme--documenter-dark .ansi span.sgr91{color:#ff8674}html.theme--documenter-dark .ansi span.sgr92{color:#79d462}html.theme--documenter-dark .ansi span.sgr93{color:#ffe76b}html.theme--documenter-dark .ansi span.sgr94{color:#8a98ff}html.theme--documenter-dark .ansi span.sgr95{color:#d2a4e6}html.theme--documenter-dark .ansi span.sgr96{color:#6bc8db}html.theme--documenter-dark .ansi span.sgr97{color:#ecf0f1}html.theme--documenter-dark .ansi span.sgr100{background-color:#92a0a2}html.theme--documenter-dark .ansi span.sgr101{background-color:#ff8674}html.theme--documenter-dark .ansi span.sgr102{background-color:#79d462}html.theme--documenter-dark .ansi span.sgr103{background-color:#ffe76b}html.theme--documenter-dark .ansi span.sgr104{background-color:#8a98ff}html.theme--documenter-dark .ansi span.sgr105{background-color:#d2a4e6}html.theme--documenter-dark .ansi span.sgr106{background-color:#6bc8db}html.theme--documenter-dark .ansi span.sgr107{background-color:#ecf0f1}html.theme--documenter-dark code.language-julia-repl>span.hljs-meta{color:#4fb43a;font-weight:bolder}html.theme--documenter-dark .hljs{background:#2b2b2b;color:#f8f8f2}html.theme--documenter-dark .hljs-comment,html.theme--documenter-dark .hljs-quote{color:#d4d0ab}html.theme--documenter-dark .hljs-variable,html.theme--documenter-dark .hljs-template-variable,html.theme--documenter-dark .hljs-tag,html.theme--documenter-dark .hljs-name,html.theme--documenter-dark .hljs-selector-id,html.theme--documenter-dark .hljs-selector-class,html.theme--documenter-dark .hljs-regexp,html.theme--documenter-dark .hljs-deletion{color:#ffa07a}html.theme--documenter-dark .hljs-number,html.theme--documenter-dark .hljs-built_in,html.theme--documenter-dark .hljs-literal,html.theme--documenter-dark .hljs-type,html.theme--documenter-dark .hljs-params,html.theme--documenter-dark .hljs-meta,html.theme--documenter-dark .hljs-link{color:#f5ab35}html.theme--documenter-dark .hljs-attribute{color:#ffd700}html.theme--documenter-dark .hljs-string,html.theme--documenter-dark .hljs-symbol,html.theme--documenter-dark .hljs-bullet,html.theme--documenter-dark .hljs-addition{color:#abe338}html.theme--documenter-dark .hljs-title,html.theme--documenter-dark .hljs-section{color:#00e0e0}html.theme--documenter-dark .hljs-keyword,html.theme--documenter-dark .hljs-selector-tag{color:#dcc6e0}html.theme--documenter-dark .hljs-emphasis{font-style:italic}html.theme--documenter-dark .hljs-strong{font-weight:bold}@media screen and (-ms-high-contrast: active){html.theme--documenter-dark .hljs-addition,html.theme--documenter-dark .hljs-attribute,html.theme--documenter-dark .hljs-built_in,html.theme--documenter-dark .hljs-bullet,html.theme--documenter-dark .hljs-comment,html.theme--documenter-dark .hljs-link,html.theme--documenter-dark .hljs-literal,html.theme--documenter-dark .hljs-meta,html.theme--documenter-dark .hljs-number,html.theme--documenter-dark .hljs-params,html.theme--documenter-dark .hljs-string,html.theme--documenter-dark .hljs-symbol,html.theme--documenter-dark .hljs-type,html.theme--documenter-dark .hljs-quote{color:highlight}html.theme--documenter-dark .hljs-keyword,html.theme--documenter-dark .hljs-selector-tag{font-weight:bold}}html.theme--documenter-dark .hljs-subst{color:#f8f8f2}html.theme--documenter-dark .search-result-link{border-radius:0.7em;transition:all 300ms}html.theme--documenter-dark .search-result-link:hover,html.theme--documenter-dark .search-result-link:focus{background-color:rgba(0,128,128,0.1)}html.theme--documenter-dark .search-result-link .property-search-result-badge,html.theme--documenter-dark .search-result-link .search-filter{transition:all 300ms}html.theme--documenter-dark .search-result-link:hover .property-search-result-badge,html.theme--documenter-dark .search-result-link:hover .search-filter,html.theme--documenter-dark .search-result-link:focus .property-search-result-badge,html.theme--documenter-dark .search-result-link:focus .search-filter{color:#333 !important;background-color:#f1f5f9 !important}html.theme--documenter-dark .search-result-title{color:whitesmoke}html.theme--documenter-dark .search-result-highlight{background-color:greenyellow;color:black}html.theme--documenter-dark .search-divider{border-bottom:1px solid #5e6d6f50}html.theme--documenter-dark .w-100{width:100%}html.theme--documenter-dark .gap-2{gap:0.5rem}html.theme--documenter-dark .gap-4{gap:1rem} diff --git a/v0.16.1/assets/themes/documenter-light.css b/v0.16.1/assets/themes/documenter-light.css new file mode 100644 index 000000000..a435b3b63 --- /dev/null +++ b/v0.16.1/assets/themes/documenter-light.css @@ -0,0 +1,9 @@ +.pagination-previous,.pagination-next,.pagination-link,.pagination-ellipsis,.file-cta,.file-name,.select select,.textarea,.input,#documenter .docs-sidebar form.docs-search>input,.button{-moz-appearance:none;-webkit-appearance:none;align-items:center;border:1px solid transparent;border-radius:4px;box-shadow:none;display:inline-flex;font-size:1rem;height:2.5em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.5em - 1px);padding-left:calc(0.75em - 1px);padding-right:calc(0.75em - 1px);padding-top:calc(0.5em - 1px);position:relative;vertical-align:top}.pagination-previous:focus,.pagination-next:focus,.pagination-link:focus,.pagination-ellipsis:focus,.file-cta:focus,.file-name:focus,.select select:focus,.textarea:focus,.input:focus,#documenter .docs-sidebar form.docs-search>input:focus,.button:focus,.is-focused.pagination-previous,.is-focused.pagination-next,.is-focused.pagination-link,.is-focused.pagination-ellipsis,.is-focused.file-cta,.is-focused.file-name,.select select.is-focused,.is-focused.textarea,.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-focused.button,.pagination-previous:active,.pagination-next:active,.pagination-link:active,.pagination-ellipsis:active,.file-cta:active,.file-name:active,.select select:active,.textarea:active,.input:active,#documenter .docs-sidebar form.docs-search>input:active,.button:active,.is-active.pagination-previous,.is-active.pagination-next,.is-active.pagination-link,.is-active.pagination-ellipsis,.is-active.file-cta,.is-active.file-name,.select select.is-active,.is-active.textarea,.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active,.is-active.button{outline:none}.pagination-previous[disabled],.pagination-next[disabled],.pagination-link[disabled],.pagination-ellipsis[disabled],.file-cta[disabled],.file-name[disabled],.select select[disabled],.textarea[disabled],.input[disabled],#documenter .docs-sidebar form.docs-search>input[disabled],.button[disabled],fieldset[disabled] .pagination-previous,fieldset[disabled] .pagination-next,fieldset[disabled] .pagination-link,fieldset[disabled] .pagination-ellipsis,fieldset[disabled] .file-cta,fieldset[disabled] .file-name,fieldset[disabled] .select select,.select fieldset[disabled] select,fieldset[disabled] .textarea,fieldset[disabled] .input,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input,fieldset[disabled] .button{cursor:not-allowed}.tabs,.pagination-previous,.pagination-next,.pagination-link,.pagination-ellipsis,.breadcrumb,.file,.button,.is-unselectable{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none}.navbar-link:not(.is-arrowless)::after,.select:not(.is-multiple):not(.is-loading)::after{border:3px solid rgba(0,0,0,0);border-radius:2px;border-right:0;border-top:0;content:" ";display:block;height:0.625em;margin-top:-0.4375em;pointer-events:none;position:absolute;top:50%;transform:rotate(-45deg);transform-origin:center;width:0.625em}.admonition:not(:last-child),.tabs:not(:last-child),.pagination:not(:last-child),.message:not(:last-child),.level:not(:last-child),.breadcrumb:not(:last-child),.block:not(:last-child),.title:not(:last-child),.subtitle:not(:last-child),.table-container:not(:last-child),.table:not(:last-child),.progress:not(:last-child),.notification:not(:last-child),.content:not(:last-child),.box:not(:last-child){margin-bottom:1.5rem}.modal-close,.delete{-webkit-touch-callout:none;-webkit-user-select:none;-moz-user-select:none;-ms-user-select:none;user-select:none;-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:9999px;cursor:pointer;pointer-events:auto;display:inline-block;flex-grow:0;flex-shrink:0;font-size:0;height:20px;max-height:20px;max-width:20px;min-height:20px;min-width:20px;outline:none;position:relative;vertical-align:top;width:20px}.modal-close::before,.delete::before,.modal-close::after,.delete::after{background-color:#fff;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}.modal-close::before,.delete::before{height:2px;width:50%}.modal-close::after,.delete::after{height:50%;width:2px}.modal-close:hover,.delete:hover,.modal-close:focus,.delete:focus{background-color:rgba(10,10,10,0.3)}.modal-close:active,.delete:active{background-color:rgba(10,10,10,0.4)}.is-small.modal-close,#documenter .docs-sidebar form.docs-search>input.modal-close,.is-small.delete,#documenter .docs-sidebar form.docs-search>input.delete{height:16px;max-height:16px;max-width:16px;min-height:16px;min-width:16px;width:16px}.is-medium.modal-close,.is-medium.delete{height:24px;max-height:24px;max-width:24px;min-height:24px;min-width:24px;width:24px}.is-large.modal-close,.is-large.delete{height:32px;max-height:32px;max-width:32px;min-height:32px;min-width:32px;width:32px}.control.is-loading::after,.select.is-loading::after,.loader,.button.is-loading::after{animation:spinAround 500ms infinite linear;border:2px solid #dbdbdb;border-radius:9999px;border-right-color:transparent;border-top-color:transparent;content:"";display:block;height:1em;position:relative;width:1em}.hero-video,.modal-background,.modal,.image.is-square img,#documenter .docs-sidebar .docs-logo>img.is-square img,.image.is-square .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,.image.is-1by1 img,#documenter .docs-sidebar .docs-logo>img.is-1by1 img,.image.is-1by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,.image.is-5by4 img,#documenter .docs-sidebar .docs-logo>img.is-5by4 img,.image.is-5by4 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,.image.is-4by3 img,#documenter .docs-sidebar .docs-logo>img.is-4by3 img,.image.is-4by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,.image.is-3by2 img,#documenter .docs-sidebar .docs-logo>img.is-3by2 img,.image.is-3by2 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,.image.is-5by3 img,#documenter .docs-sidebar .docs-logo>img.is-5by3 img,.image.is-5by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,.image.is-16by9 img,#documenter .docs-sidebar .docs-logo>img.is-16by9 img,.image.is-16by9 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,.image.is-2by1 img,#documenter .docs-sidebar .docs-logo>img.is-2by1 img,.image.is-2by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,.image.is-3by1 img,#documenter .docs-sidebar .docs-logo>img.is-3by1 img,.image.is-3by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,.image.is-4by5 img,#documenter .docs-sidebar .docs-logo>img.is-4by5 img,.image.is-4by5 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,.image.is-3by4 img,#documenter .docs-sidebar .docs-logo>img.is-3by4 img,.image.is-3by4 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,.image.is-2by3 img,#documenter .docs-sidebar .docs-logo>img.is-2by3 img,.image.is-2by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,.image.is-3by5 img,#documenter .docs-sidebar .docs-logo>img.is-3by5 img,.image.is-3by5 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,.image.is-9by16 img,#documenter .docs-sidebar .docs-logo>img.is-9by16 img,.image.is-9by16 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,.image.is-1by2 img,#documenter .docs-sidebar .docs-logo>img.is-1by2 img,.image.is-1by2 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,.image.is-1by3 img,#documenter .docs-sidebar .docs-logo>img.is-1by3 img,.image.is-1by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio,.is-overlay{bottom:0;left:0;position:absolute;right:0;top:0}.navbar-burger{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0}.has-text-white{color:#fff !important}a.has-text-white:hover,a.has-text-white:focus{color:#e6e6e6 !important}.has-background-white{background-color:#fff !important}.has-text-black{color:#0a0a0a !important}a.has-text-black:hover,a.has-text-black:focus{color:#000 !important}.has-background-black{background-color:#0a0a0a !important}.has-text-light{color:#f5f5f5 !important}a.has-text-light:hover,a.has-text-light:focus{color:#dbdbdb !important}.has-background-light{background-color:#f5f5f5 !important}.has-text-dark{color:#363636 !important}a.has-text-dark:hover,a.has-text-dark:focus{color:#1c1c1c !important}.has-background-dark{background-color:#363636 !important}.has-text-primary{color:#4eb5de !important}a.has-text-primary:hover,a.has-text-primary:focus{color:#27a1d2 !important}.has-background-primary{background-color:#4eb5de !important}.has-text-primary-light{color:#eef8fc !important}a.has-text-primary-light:hover,a.has-text-primary-light:focus{color:#c3e6f4 !important}.has-background-primary-light{background-color:#eef8fc !important}.has-text-primary-dark{color:#1a6d8e !important}a.has-text-primary-dark:hover,a.has-text-primary-dark:focus{color:#228eb9 !important}.has-background-primary-dark{background-color:#1a6d8e !important}.has-text-link{color:#2e63b8 !important}a.has-text-link:hover,a.has-text-link:focus{color:#244d8f !important}.has-background-link{background-color:#2e63b8 !important}.has-text-link-light{color:#eff3fb !important}a.has-text-link-light:hover,a.has-text-link-light:focus{color:#c6d6f1 !important}.has-background-link-light{background-color:#eff3fb !important}.has-text-link-dark{color:#3169c4 !important}a.has-text-link-dark:hover,a.has-text-link-dark:focus{color:#5485d4 !important}.has-background-link-dark{background-color:#3169c4 !important}.has-text-info{color:#3c5dcd !important}a.has-text-info:hover,a.has-text-info:focus{color:#2c48aa !important}.has-background-info{background-color:#3c5dcd !important}.has-text-info-light{color:#eff2fb !important}a.has-text-info-light:hover,a.has-text-info-light:focus{color:#c6d0f0 !important}.has-background-info-light{background-color:#eff2fb !important}.has-text-info-dark{color:#3253c3 !important}a.has-text-info-dark:hover,a.has-text-info-dark:focus{color:#5571d3 !important}.has-background-info-dark{background-color:#3253c3 !important}.has-text-success{color:#259a12 !important}a.has-text-success:hover,a.has-text-success:focus{color:#1a6c0d !important}.has-background-success{background-color:#259a12 !important}.has-text-success-light{color:#effded !important}a.has-text-success-light:hover,a.has-text-success-light:focus{color:#c7f8bf !important}.has-background-success-light{background-color:#effded !important}.has-text-success-dark{color:#2ec016 !important}a.has-text-success-dark:hover,a.has-text-success-dark:focus{color:#3fe524 !important}.has-background-success-dark{background-color:#2ec016 !important}.has-text-warning{color:#a98800 !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#765f00 !important}.has-background-warning{background-color:#a98800 !important}.has-text-warning-light{color:#fffbeb !important}a.has-text-warning-light:hover,a.has-text-warning-light:focus{color:#fff1b8 !important}.has-background-warning-light{background-color:#fffbeb !important}.has-text-warning-dark{color:#cca400 !important}a.has-text-warning-dark:hover,a.has-text-warning-dark:focus{color:#ffcd00 !important}.has-background-warning-dark{background-color:#cca400 !important}.has-text-danger{color:#cb3c33 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#a23029 !important}.has-background-danger{background-color:#cb3c33 !important}.has-text-danger-light{color:#fbefef !important}a.has-text-danger-light:hover,a.has-text-danger-light:focus{color:#f1c8c6 !important}.has-background-danger-light{background-color:#fbefef !important}.has-text-danger-dark{color:#c03930 !important}a.has-text-danger-dark:hover,a.has-text-danger-dark:focus{color:#d35850 !important}.has-background-danger-dark{background-color:#c03930 !important}.has-text-black-bis{color:#121212 !important}.has-background-black-bis{background-color:#121212 !important}.has-text-black-ter{color:#242424 !important}.has-background-black-ter{background-color:#242424 !important}.has-text-grey-darker{color:#363636 !important}.has-background-grey-darker{background-color:#363636 !important}.has-text-grey-dark{color:#4a4a4a !important}.has-background-grey-dark{background-color:#4a4a4a !important}.has-text-grey{color:#6b6b6b !important}.has-background-grey{background-color:#6b6b6b !important}.has-text-grey-light{color:#b5b5b5 !important}.has-background-grey-light{background-color:#b5b5b5 !important}.has-text-grey-lighter{color:#dbdbdb !important}.has-background-grey-lighter{background-color:#dbdbdb !important}.has-text-white-ter{color:#f5f5f5 !important}.has-background-white-ter{background-color:#f5f5f5 !important}.has-text-white-bis{color:#fafafa !important}.has-background-white-bis{background-color:#fafafa !important}.is-flex-direction-row{flex-direction:row !important}.is-flex-direction-row-reverse{flex-direction:row-reverse !important}.is-flex-direction-column{flex-direction:column !important}.is-flex-direction-column-reverse{flex-direction:column-reverse !important}.is-flex-wrap-nowrap{flex-wrap:nowrap !important}.is-flex-wrap-wrap{flex-wrap:wrap !important}.is-flex-wrap-wrap-reverse{flex-wrap:wrap-reverse !important}.is-justify-content-flex-start{justify-content:flex-start !important}.is-justify-content-flex-end{justify-content:flex-end !important}.is-justify-content-center{justify-content:center !important}.is-justify-content-space-between{justify-content:space-between !important}.is-justify-content-space-around{justify-content:space-around !important}.is-justify-content-space-evenly{justify-content:space-evenly !important}.is-justify-content-start{justify-content:start !important}.is-justify-content-end{justify-content:end !important}.is-justify-content-left{justify-content:left !important}.is-justify-content-right{justify-content:right !important}.is-align-content-flex-start{align-content:flex-start !important}.is-align-content-flex-end{align-content:flex-end !important}.is-align-content-center{align-content:center !important}.is-align-content-space-between{align-content:space-between !important}.is-align-content-space-around{align-content:space-around !important}.is-align-content-space-evenly{align-content:space-evenly !important}.is-align-content-stretch{align-content:stretch !important}.is-align-content-start{align-content:start !important}.is-align-content-end{align-content:end !important}.is-align-content-baseline{align-content:baseline !important}.is-align-items-stretch{align-items:stretch !important}.is-align-items-flex-start{align-items:flex-start !important}.is-align-items-flex-end{align-items:flex-end !important}.is-align-items-center{align-items:center !important}.is-align-items-baseline{align-items:baseline !important}.is-align-items-start{align-items:start !important}.is-align-items-end{align-items:end !important}.is-align-items-self-start{align-items:self-start !important}.is-align-items-self-end{align-items:self-end !important}.is-align-self-auto{align-self:auto !important}.is-align-self-flex-start{align-self:flex-start !important}.is-align-self-flex-end{align-self:flex-end !important}.is-align-self-center{align-self:center !important}.is-align-self-baseline{align-self:baseline !important}.is-align-self-stretch{align-self:stretch !important}.is-flex-grow-0{flex-grow:0 !important}.is-flex-grow-1{flex-grow:1 !important}.is-flex-grow-2{flex-grow:2 !important}.is-flex-grow-3{flex-grow:3 !important}.is-flex-grow-4{flex-grow:4 !important}.is-flex-grow-5{flex-grow:5 !important}.is-flex-shrink-0{flex-shrink:0 !important}.is-flex-shrink-1{flex-shrink:1 !important}.is-flex-shrink-2{flex-shrink:2 !important}.is-flex-shrink-3{flex-shrink:3 !important}.is-flex-shrink-4{flex-shrink:4 !important}.is-flex-shrink-5{flex-shrink:5 !important}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-clickable{cursor:pointer !important;pointer-events:all !important}.is-clipped{overflow:hidden !important}.is-relative{position:relative !important}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.m-0{margin:0 !important}.mt-0{margin-top:0 !important}.mr-0{margin-right:0 !important}.mb-0{margin-bottom:0 !important}.ml-0{margin-left:0 !important}.mx-0{margin-left:0 !important;margin-right:0 !important}.my-0{margin-top:0 !important;margin-bottom:0 !important}.m-1{margin:.25rem !important}.mt-1{margin-top:.25rem !important}.mr-1{margin-right:.25rem !important}.mb-1{margin-bottom:.25rem !important}.ml-1{margin-left:.25rem !important}.mx-1{margin-left:.25rem !important;margin-right:.25rem !important}.my-1{margin-top:.25rem !important;margin-bottom:.25rem !important}.m-2{margin:.5rem !important}.mt-2{margin-top:.5rem !important}.mr-2{margin-right:.5rem !important}.mb-2{margin-bottom:.5rem !important}.ml-2{margin-left:.5rem !important}.mx-2{margin-left:.5rem !important;margin-right:.5rem !important}.my-2{margin-top:.5rem !important;margin-bottom:.5rem !important}.m-3{margin:.75rem !important}.mt-3{margin-top:.75rem !important}.mr-3{margin-right:.75rem !important}.mb-3{margin-bottom:.75rem !important}.ml-3{margin-left:.75rem !important}.mx-3{margin-left:.75rem !important;margin-right:.75rem !important}.my-3{margin-top:.75rem !important;margin-bottom:.75rem !important}.m-4{margin:1rem !important}.mt-4{margin-top:1rem !important}.mr-4{margin-right:1rem !important}.mb-4{margin-bottom:1rem !important}.ml-4{margin-left:1rem !important}.mx-4{margin-left:1rem !important;margin-right:1rem !important}.my-4{margin-top:1rem !important;margin-bottom:1rem !important}.m-5{margin:1.5rem !important}.mt-5{margin-top:1.5rem !important}.mr-5{margin-right:1.5rem !important}.mb-5{margin-bottom:1.5rem !important}.ml-5{margin-left:1.5rem !important}.mx-5{margin-left:1.5rem !important;margin-right:1.5rem !important}.my-5{margin-top:1.5rem !important;margin-bottom:1.5rem !important}.m-6{margin:3rem !important}.mt-6{margin-top:3rem !important}.mr-6{margin-right:3rem !important}.mb-6{margin-bottom:3rem !important}.ml-6{margin-left:3rem !important}.mx-6{margin-left:3rem !important;margin-right:3rem !important}.my-6{margin-top:3rem !important;margin-bottom:3rem !important}.m-auto{margin:auto !important}.mt-auto{margin-top:auto !important}.mr-auto{margin-right:auto !important}.mb-auto{margin-bottom:auto !important}.ml-auto{margin-left:auto !important}.mx-auto{margin-left:auto !important;margin-right:auto !important}.my-auto{margin-top:auto !important;margin-bottom:auto !important}.p-0{padding:0 !important}.pt-0{padding-top:0 !important}.pr-0{padding-right:0 !important}.pb-0{padding-bottom:0 !important}.pl-0{padding-left:0 !important}.px-0{padding-left:0 !important;padding-right:0 !important}.py-0{padding-top:0 !important;padding-bottom:0 !important}.p-1{padding:.25rem !important}.pt-1{padding-top:.25rem !important}.pr-1{padding-right:.25rem !important}.pb-1{padding-bottom:.25rem !important}.pl-1{padding-left:.25rem !important}.px-1{padding-left:.25rem !important;padding-right:.25rem !important}.py-1{padding-top:.25rem !important;padding-bottom:.25rem !important}.p-2{padding:.5rem !important}.pt-2{padding-top:.5rem !important}.pr-2{padding-right:.5rem !important}.pb-2{padding-bottom:.5rem !important}.pl-2{padding-left:.5rem !important}.px-2{padding-left:.5rem !important;padding-right:.5rem !important}.py-2{padding-top:.5rem !important;padding-bottom:.5rem !important}.p-3{padding:.75rem !important}.pt-3{padding-top:.75rem !important}.pr-3{padding-right:.75rem !important}.pb-3{padding-bottom:.75rem !important}.pl-3{padding-left:.75rem !important}.px-3{padding-left:.75rem !important;padding-right:.75rem !important}.py-3{padding-top:.75rem !important;padding-bottom:.75rem !important}.p-4{padding:1rem !important}.pt-4{padding-top:1rem !important}.pr-4{padding-right:1rem !important}.pb-4{padding-bottom:1rem !important}.pl-4{padding-left:1rem !important}.px-4{padding-left:1rem !important;padding-right:1rem !important}.py-4{padding-top:1rem !important;padding-bottom:1rem !important}.p-5{padding:1.5rem !important}.pt-5{padding-top:1.5rem !important}.pr-5{padding-right:1.5rem !important}.pb-5{padding-bottom:1.5rem !important}.pl-5{padding-left:1.5rem !important}.px-5{padding-left:1.5rem !important;padding-right:1.5rem !important}.py-5{padding-top:1.5rem !important;padding-bottom:1.5rem !important}.p-6{padding:3rem !important}.pt-6{padding-top:3rem !important}.pr-6{padding-right:3rem !important}.pb-6{padding-bottom:3rem !important}.pl-6{padding-left:3rem !important}.px-6{padding-left:3rem !important;padding-right:3rem !important}.py-6{padding-top:3rem !important;padding-bottom:3rem !important}.p-auto{padding:auto !important}.pt-auto{padding-top:auto !important}.pr-auto{padding-right:auto !important}.pb-auto{padding-bottom:auto !important}.pl-auto{padding-left:auto !important}.px-auto{padding-left:auto !important;padding-right:auto !important}.py-auto{padding-top:auto !important;padding-bottom:auto !important}.is-size-1{font-size:3rem !important}.is-size-2{font-size:2.5rem !important}.is-size-3{font-size:2rem !important}.is-size-4{font-size:1.5rem !important}.is-size-5{font-size:1.25rem !important}.is-size-6{font-size:1rem !important}.is-size-7,.docstring>section>a.docs-sourcelink{font-size:.75rem !important}@media screen and (max-width: 768px){.is-size-1-mobile{font-size:3rem !important}.is-size-2-mobile{font-size:2.5rem !important}.is-size-3-mobile{font-size:2rem !important}.is-size-4-mobile{font-size:1.5rem !important}.is-size-5-mobile{font-size:1.25rem !important}.is-size-6-mobile{font-size:1rem !important}.is-size-7-mobile{font-size:.75rem !important}}@media screen and (min-width: 769px),print{.is-size-1-tablet{font-size:3rem !important}.is-size-2-tablet{font-size:2.5rem !important}.is-size-3-tablet{font-size:2rem !important}.is-size-4-tablet{font-size:1.5rem !important}.is-size-5-tablet{font-size:1.25rem !important}.is-size-6-tablet{font-size:1rem !important}.is-size-7-tablet{font-size:.75rem !important}}@media screen and (max-width: 1055px){.is-size-1-touch{font-size:3rem !important}.is-size-2-touch{font-size:2.5rem !important}.is-size-3-touch{font-size:2rem !important}.is-size-4-touch{font-size:1.5rem !important}.is-size-5-touch{font-size:1.25rem !important}.is-size-6-touch{font-size:1rem !important}.is-size-7-touch{font-size:.75rem !important}}@media screen and (min-width: 1056px){.is-size-1-desktop{font-size:3rem !important}.is-size-2-desktop{font-size:2.5rem !important}.is-size-3-desktop{font-size:2rem !important}.is-size-4-desktop{font-size:1.5rem !important}.is-size-5-desktop{font-size:1.25rem !important}.is-size-6-desktop{font-size:1rem !important}.is-size-7-desktop{font-size:.75rem !important}}@media screen and (min-width: 1216px){.is-size-1-widescreen{font-size:3rem !important}.is-size-2-widescreen{font-size:2.5rem !important}.is-size-3-widescreen{font-size:2rem !important}.is-size-4-widescreen{font-size:1.5rem !important}.is-size-5-widescreen{font-size:1.25rem !important}.is-size-6-widescreen{font-size:1rem !important}.is-size-7-widescreen{font-size:.75rem !important}}@media screen and (min-width: 1408px){.is-size-1-fullhd{font-size:3rem !important}.is-size-2-fullhd{font-size:2.5rem !important}.is-size-3-fullhd{font-size:2rem !important}.is-size-4-fullhd{font-size:1.5rem !important}.is-size-5-fullhd{font-size:1.25rem !important}.is-size-6-fullhd{font-size:1rem !important}.is-size-7-fullhd{font-size:.75rem !important}}.has-text-centered{text-align:center !important}.has-text-justified{text-align:justify !important}.has-text-left{text-align:left !important}.has-text-right{text-align:right !important}@media screen and (max-width: 768px){.has-text-centered-mobile{text-align:center !important}}@media screen and (min-width: 769px),print{.has-text-centered-tablet{text-align:center !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-centered-tablet-only{text-align:center !important}}@media screen and (max-width: 1055px){.has-text-centered-touch{text-align:center !important}}@media screen and (min-width: 1056px){.has-text-centered-desktop{text-align:center !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-centered-desktop-only{text-align:center !important}}@media screen and (min-width: 1216px){.has-text-centered-widescreen{text-align:center !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-centered-widescreen-only{text-align:center !important}}@media screen and (min-width: 1408px){.has-text-centered-fullhd{text-align:center !important}}@media screen and (max-width: 768px){.has-text-justified-mobile{text-align:justify !important}}@media screen and (min-width: 769px),print{.has-text-justified-tablet{text-align:justify !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-justified-tablet-only{text-align:justify !important}}@media screen and (max-width: 1055px){.has-text-justified-touch{text-align:justify !important}}@media screen and (min-width: 1056px){.has-text-justified-desktop{text-align:justify !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-justified-desktop-only{text-align:justify !important}}@media screen and (min-width: 1216px){.has-text-justified-widescreen{text-align:justify !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-justified-widescreen-only{text-align:justify !important}}@media screen and (min-width: 1408px){.has-text-justified-fullhd{text-align:justify !important}}@media screen and (max-width: 768px){.has-text-left-mobile{text-align:left !important}}@media screen and (min-width: 769px),print{.has-text-left-tablet{text-align:left !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-left-tablet-only{text-align:left !important}}@media screen and (max-width: 1055px){.has-text-left-touch{text-align:left !important}}@media screen and (min-width: 1056px){.has-text-left-desktop{text-align:left !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-left-desktop-only{text-align:left !important}}@media screen and (min-width: 1216px){.has-text-left-widescreen{text-align:left !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-left-widescreen-only{text-align:left !important}}@media screen and (min-width: 1408px){.has-text-left-fullhd{text-align:left !important}}@media screen and (max-width: 768px){.has-text-right-mobile{text-align:right !important}}@media screen and (min-width: 769px),print{.has-text-right-tablet{text-align:right !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.has-text-right-tablet-only{text-align:right !important}}@media screen and (max-width: 1055px){.has-text-right-touch{text-align:right !important}}@media screen and (min-width: 1056px){.has-text-right-desktop{text-align:right !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.has-text-right-desktop-only{text-align:right !important}}@media screen and (min-width: 1216px){.has-text-right-widescreen{text-align:right !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.has-text-right-widescreen-only{text-align:right !important}}@media screen and (min-width: 1408px){.has-text-right-fullhd{text-align:right !important}}.is-capitalized{text-transform:capitalize !important}.is-lowercase{text-transform:lowercase !important}.is-uppercase{text-transform:uppercase !important}.is-italic{font-style:italic !important}.is-underlined{text-decoration:underline !important}.has-text-weight-light{font-weight:300 !important}.has-text-weight-normal{font-weight:400 !important}.has-text-weight-medium{font-weight:500 !important}.has-text-weight-semibold{font-weight:600 !important}.has-text-weight-bold{font-weight:700 !important}.is-family-primary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-secondary{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-sans-serif{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif !important}.is-family-monospace{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-family-code{font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace !important}.is-block{display:block !important}@media screen and (max-width: 768px){.is-block-mobile{display:block !important}}@media screen and (min-width: 769px),print{.is-block-tablet{display:block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-block-tablet-only{display:block !important}}@media screen and (max-width: 1055px){.is-block-touch{display:block !important}}@media screen and (min-width: 1056px){.is-block-desktop{display:block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-block-desktop-only{display:block !important}}@media screen and (min-width: 1216px){.is-block-widescreen{display:block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-block-widescreen-only{display:block !important}}@media screen and (min-width: 1408px){.is-block-fullhd{display:block !important}}.is-flex{display:flex !important}@media screen and (max-width: 768px){.is-flex-mobile{display:flex !important}}@media screen and (min-width: 769px),print{.is-flex-tablet{display:flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-flex-tablet-only{display:flex !important}}@media screen and (max-width: 1055px){.is-flex-touch{display:flex !important}}@media screen and (min-width: 1056px){.is-flex-desktop{display:flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-flex-desktop-only{display:flex !important}}@media screen and (min-width: 1216px){.is-flex-widescreen{display:flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-flex-widescreen-only{display:flex !important}}@media screen and (min-width: 1408px){.is-flex-fullhd{display:flex !important}}.is-inline{display:inline !important}@media screen and (max-width: 768px){.is-inline-mobile{display:inline !important}}@media screen and (min-width: 769px),print{.is-inline-tablet{display:inline !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-tablet-only{display:inline !important}}@media screen and (max-width: 1055px){.is-inline-touch{display:inline !important}}@media screen and (min-width: 1056px){.is-inline-desktop{display:inline !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-desktop-only{display:inline !important}}@media screen and (min-width: 1216px){.is-inline-widescreen{display:inline !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-widescreen-only{display:inline !important}}@media screen and (min-width: 1408px){.is-inline-fullhd{display:inline !important}}.is-inline-block{display:inline-block !important}@media screen and (max-width: 768px){.is-inline-block-mobile{display:inline-block !important}}@media screen and (min-width: 769px),print{.is-inline-block-tablet{display:inline-block !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-block-tablet-only{display:inline-block !important}}@media screen and (max-width: 1055px){.is-inline-block-touch{display:inline-block !important}}@media screen and (min-width: 1056px){.is-inline-block-desktop{display:inline-block !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-block-desktop-only{display:inline-block !important}}@media screen and (min-width: 1216px){.is-inline-block-widescreen{display:inline-block !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-block-widescreen-only{display:inline-block !important}}@media screen and (min-width: 1408px){.is-inline-block-fullhd{display:inline-block !important}}.is-inline-flex{display:inline-flex !important}@media screen and (max-width: 768px){.is-inline-flex-mobile{display:inline-flex !important}}@media screen and (min-width: 769px),print{.is-inline-flex-tablet{display:inline-flex !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-inline-flex-tablet-only{display:inline-flex !important}}@media screen and (max-width: 1055px){.is-inline-flex-touch{display:inline-flex !important}}@media screen and (min-width: 1056px){.is-inline-flex-desktop{display:inline-flex !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-inline-flex-desktop-only{display:inline-flex !important}}@media screen and (min-width: 1216px){.is-inline-flex-widescreen{display:inline-flex !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-inline-flex-widescreen-only{display:inline-flex !important}}@media screen and (min-width: 1408px){.is-inline-flex-fullhd{display:inline-flex !important}}.is-hidden{display:none !important}.is-sr-only{border:none !important;clip:rect(0, 0, 0, 0) !important;height:0.01em !important;overflow:hidden !important;padding:0 !important;position:absolute !important;white-space:nowrap !important;width:0.01em !important}@media screen and (max-width: 768px){.is-hidden-mobile{display:none !important}}@media screen and (min-width: 769px),print{.is-hidden-tablet{display:none !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-hidden-tablet-only{display:none !important}}@media screen and (max-width: 1055px){.is-hidden-touch{display:none !important}}@media screen and (min-width: 1056px){.is-hidden-desktop{display:none !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-hidden-desktop-only{display:none !important}}@media screen and (min-width: 1216px){.is-hidden-widescreen{display:none !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-hidden-widescreen-only{display:none !important}}@media screen and (min-width: 1408px){.is-hidden-fullhd{display:none !important}}.is-invisible{visibility:hidden !important}@media screen and (max-width: 768px){.is-invisible-mobile{visibility:hidden !important}}@media screen and (min-width: 769px),print{.is-invisible-tablet{visibility:hidden !important}}@media screen and (min-width: 769px) and (max-width: 1055px){.is-invisible-tablet-only{visibility:hidden !important}}@media screen and (max-width: 1055px){.is-invisible-touch{visibility:hidden !important}}@media screen and (min-width: 1056px){.is-invisible-desktop{visibility:hidden !important}}@media screen and (min-width: 1056px) and (max-width: 1215px){.is-invisible-desktop-only{visibility:hidden !important}}@media screen and (min-width: 1216px){.is-invisible-widescreen{visibility:hidden !important}}@media screen and (min-width: 1216px) and (max-width: 1407px){.is-invisible-widescreen-only{visibility:hidden !important}}@media screen and (min-width: 1408px){.is-invisible-fullhd{visibility:hidden !important}}/*! minireset.css v0.0.6 | MIT License | github.com/jgthms/minireset.css */html,body,p,ol,ul,li,dl,dt,dd,blockquote,figure,fieldset,legend,textarea,pre,iframe,hr,h1,h2,h3,h4,h5,h6{margin:0;padding:0}h1,h2,h3,h4,h5,h6{font-size:100%;font-weight:normal}ul{list-style:none}button,input,select,textarea{margin:0}html{box-sizing:border-box}*,*::before,*::after{box-sizing:inherit}img,video{height:auto;max-width:100%}iframe{border:0}table{border-collapse:collapse;border-spacing:0}td,th{padding:0}td:not([align]),th:not([align]){text-align:inherit}html{background-color:#fff;font-size:16px;-moz-osx-font-smoothing:grayscale;-webkit-font-smoothing:antialiased;min-width:300px;overflow-x:auto;overflow-y:scroll;text-rendering:optimizeLegibility;text-size-adjust:100%}article,aside,figure,footer,header,hgroup,section{display:block}body,button,input,optgroup,select,textarea{font-family:"Lato Medium",-apple-system,BlinkMacSystemFont,"Segoe UI","Helvetica Neue","Helvetica","Arial",sans-serif}code,pre{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}body{color:#222;font-size:1em;font-weight:400;line-height:1.5}a{color:#2e63b8;cursor:pointer;text-decoration:none}a strong{color:currentColor}a:hover{color:#363636}code{background-color:rgba(0,0,0,0.05);color:#000;font-size:.875em;font-weight:normal;padding:.1em}hr{background-color:#f5f5f5;border:none;display:block;height:2px;margin:1.5rem 0}img{height:auto;max-width:100%}input[type="checkbox"],input[type="radio"]{vertical-align:baseline}small{font-size:.875em}span{font-style:inherit;font-weight:inherit}strong{color:#222;font-weight:700}fieldset{border:none}pre{-webkit-overflow-scrolling:touch;background-color:#f5f5f5;color:#222;font-size:.875em;overflow-x:auto;padding:1.25rem 1.5rem;white-space:pre;word-wrap:normal}pre code{background-color:transparent;color:currentColor;font-size:1em;padding:0}table td,table th{vertical-align:top}table td:not([align]),table th:not([align]){text-align:inherit}table th{color:#222}@keyframes spinAround{from{transform:rotate(0deg)}to{transform:rotate(359deg)}}.box{background-color:#fff;border-radius:6px;box-shadow:#bbb;color:#222;display:block;padding:1.25rem}a.box:hover,a.box:focus{box-shadow:0 0.5em 1em -0.125em rgba(10,10,10,0.1),0 0 0 1px #2e63b8}a.box:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2),0 0 0 1px #2e63b8}.button{background-color:#fff;border-color:#dbdbdb;border-width:1px;color:#222;cursor:pointer;justify-content:center;padding-bottom:calc(0.5em - 1px);padding-left:1em;padding-right:1em;padding-top:calc(0.5em - 1px);text-align:center;white-space:nowrap}.button strong{color:inherit}.button .icon,.button .icon.is-small,.button #documenter .docs-sidebar form.docs-search>input.icon,#documenter .docs-sidebar .button form.docs-search>input.icon,.button .icon.is-medium,.button .icon.is-large{height:1.5em;width:1.5em}.button .icon:first-child:not(:last-child){margin-left:calc(-0.5em - 1px);margin-right:.25em}.button .icon:last-child:not(:first-child){margin-left:.25em;margin-right:calc(-0.5em - 1px)}.button .icon:first-child:last-child{margin-left:calc(-0.5em - 1px);margin-right:calc(-0.5em - 1px)}.button:hover,.button.is-hovered{border-color:#b5b5b5;color:#363636}.button:focus,.button.is-focused{border-color:#3c5dcd;color:#363636}.button:focus:not(:active),.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(46,99,184,0.25)}.button:active,.button.is-active{border-color:#4a4a4a;color:#363636}.button.is-text{background-color:transparent;border-color:transparent;color:#222;text-decoration:underline}.button.is-text:hover,.button.is-text.is-hovered,.button.is-text:focus,.button.is-text.is-focused{background-color:#f5f5f5;color:#222}.button.is-text:active,.button.is-text.is-active{background-color:#e8e8e8;color:#222}.button.is-text[disabled],fieldset[disabled] .button.is-text{background-color:transparent;border-color:transparent;box-shadow:none}.button.is-ghost{background:none;border-color:rgba(0,0,0,0);color:#2e63b8;text-decoration:none}.button.is-ghost:hover,.button.is-ghost.is-hovered{color:#2e63b8;text-decoration:underline}.button.is-white{background-color:#fff;border-color:transparent;color:#0a0a0a}.button.is-white:hover,.button.is-white.is-hovered{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}.button.is-white:focus,.button.is-white.is-focused{border-color:transparent;color:#0a0a0a}.button.is-white:focus:not(:active),.button.is-white.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}.button.is-white:active,.button.is-white.is-active{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}.button.is-white[disabled],fieldset[disabled] .button.is-white{background-color:#fff;border-color:#fff;box-shadow:none}.button.is-white.is-inverted{background-color:#0a0a0a;color:#fff}.button.is-white.is-inverted:hover,.button.is-white.is-inverted.is-hovered{background-color:#000}.button.is-white.is-inverted[disabled],fieldset[disabled] .button.is-white.is-inverted{background-color:#0a0a0a;border-color:transparent;box-shadow:none;color:#fff}.button.is-white.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}.button.is-white.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-white.is-outlined:hover,.button.is-white.is-outlined.is-hovered,.button.is-white.is-outlined:focus,.button.is-white.is-outlined.is-focused{background-color:#fff;border-color:#fff;color:#0a0a0a}.button.is-white.is-outlined.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-white.is-outlined.is-loading:hover::after,.button.is-white.is-outlined.is-loading.is-hovered::after,.button.is-white.is-outlined.is-loading:focus::after,.button.is-white.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}.button.is-white.is-outlined[disabled],fieldset[disabled] .button.is-white.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}.button.is-white.is-inverted.is-outlined:hover,.button.is-white.is-inverted.is-outlined.is-hovered,.button.is-white.is-inverted.is-outlined:focus,.button.is-white.is-inverted.is-outlined.is-focused{background-color:#0a0a0a;color:#fff}.button.is-white.is-inverted.is-outlined.is-loading:hover::after,.button.is-white.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-white.is-inverted.is-outlined.is-loading:focus::after,.button.is-white.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-white.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-white.is-inverted.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}.button.is-black{background-color:#0a0a0a;border-color:transparent;color:#fff}.button.is-black:hover,.button.is-black.is-hovered{background-color:#040404;border-color:transparent;color:#fff}.button.is-black:focus,.button.is-black.is-focused{border-color:transparent;color:#fff}.button.is-black:focus:not(:active),.button.is-black.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}.button.is-black:active,.button.is-black.is-active{background-color:#000;border-color:transparent;color:#fff}.button.is-black[disabled],fieldset[disabled] .button.is-black{background-color:#0a0a0a;border-color:#0a0a0a;box-shadow:none}.button.is-black.is-inverted{background-color:#fff;color:#0a0a0a}.button.is-black.is-inverted:hover,.button.is-black.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-black.is-inverted[disabled],fieldset[disabled] .button.is-black.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#0a0a0a}.button.is-black.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;color:#0a0a0a}.button.is-black.is-outlined:hover,.button.is-black.is-outlined.is-hovered,.button.is-black.is-outlined:focus,.button.is-black.is-outlined.is-focused{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}.button.is-black.is-outlined.is-loading::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}.button.is-black.is-outlined.is-loading:hover::after,.button.is-black.is-outlined.is-loading.is-hovered::after,.button.is-black.is-outlined.is-loading:focus::after,.button.is-black.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-black.is-outlined[disabled],fieldset[disabled] .button.is-black.is-outlined{background-color:transparent;border-color:#0a0a0a;box-shadow:none;color:#0a0a0a}.button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-black.is-inverted.is-outlined:hover,.button.is-black.is-inverted.is-outlined.is-hovered,.button.is-black.is-inverted.is-outlined:focus,.button.is-black.is-inverted.is-outlined.is-focused{background-color:#fff;color:#0a0a0a}.button.is-black.is-inverted.is-outlined.is-loading:hover::after,.button.is-black.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-black.is-inverted.is-outlined.is-loading:focus::after,.button.is-black.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #0a0a0a #0a0a0a !important}.button.is-black.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-black.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-light{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-light:hover,.button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-light:focus,.button.is-light.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-light:focus:not(:active),.button.is-light.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}.button.is-light:active,.button.is-light.is-active{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-light[disabled],fieldset[disabled] .button.is-light{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none}.button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);color:#f5f5f5}.button.is-light.is-inverted:hover,.button.is-light.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}.button.is-light.is-inverted[disabled],fieldset[disabled] .button.is-light.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#f5f5f5}.button.is-light.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}.button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;color:#f5f5f5}.button.is-light.is-outlined:hover,.button.is-light.is-outlined.is-hovered,.button.is-light.is-outlined:focus,.button.is-light.is-outlined.is-focused{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}.button.is-light.is-outlined.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}.button.is-light.is-outlined.is-loading:hover::after,.button.is-light.is-outlined.is-loading.is-hovered::after,.button.is-light.is-outlined.is-loading:focus::after,.button.is-light.is-outlined.is-loading.is-focused::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}.button.is-light.is-outlined[disabled],fieldset[disabled] .button.is-light.is-outlined{background-color:transparent;border-color:#f5f5f5;box-shadow:none;color:#f5f5f5}.button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);color:rgba(0,0,0,0.7)}.button.is-light.is-inverted.is-outlined:hover,.button.is-light.is-inverted.is-outlined.is-hovered,.button.is-light.is-inverted.is-outlined:focus,.button.is-light.is-inverted.is-outlined.is-focused{background-color:rgba(0,0,0,0.7);color:#f5f5f5}.button.is-light.is-inverted.is-outlined.is-loading:hover::after,.button.is-light.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-light.is-inverted.is-outlined.is-loading:focus::after,.button.is-light.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !important}.button.is-light.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-light.is-inverted.is-outlined{background-color:transparent;border-color:rgba(0,0,0,0.7);box-shadow:none;color:rgba(0,0,0,0.7)}.button.is-dark,.content kbd.button{background-color:#363636;border-color:transparent;color:#fff}.button.is-dark:hover,.content kbd.button:hover,.button.is-dark.is-hovered,.content kbd.button.is-hovered{background-color:#2f2f2f;border-color:transparent;color:#fff}.button.is-dark:focus,.content kbd.button:focus,.button.is-dark.is-focused,.content kbd.button.is-focused{border-color:transparent;color:#fff}.button.is-dark:focus:not(:active),.content kbd.button:focus:not(:active),.button.is-dark.is-focused:not(:active),.content kbd.button.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(54,54,54,0.25)}.button.is-dark:active,.content kbd.button:active,.button.is-dark.is-active,.content kbd.button.is-active{background-color:#292929;border-color:transparent;color:#fff}.button.is-dark[disabled],.content kbd.button[disabled],fieldset[disabled] .button.is-dark,fieldset[disabled] .content kbd.button,.content fieldset[disabled] kbd.button{background-color:#363636;border-color:#363636;box-shadow:none}.button.is-dark.is-inverted,.content kbd.button.is-inverted{background-color:#fff;color:#363636}.button.is-dark.is-inverted:hover,.content kbd.button.is-inverted:hover,.button.is-dark.is-inverted.is-hovered,.content kbd.button.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-dark.is-inverted[disabled],.content kbd.button.is-inverted[disabled],fieldset[disabled] .button.is-dark.is-inverted,fieldset[disabled] .content kbd.button.is-inverted,.content fieldset[disabled] kbd.button.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#363636}.button.is-dark.is-loading::after,.content kbd.button.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-dark.is-outlined,.content kbd.button.is-outlined{background-color:transparent;border-color:#363636;color:#363636}.button.is-dark.is-outlined:hover,.content kbd.button.is-outlined:hover,.button.is-dark.is-outlined.is-hovered,.content kbd.button.is-outlined.is-hovered,.button.is-dark.is-outlined:focus,.content kbd.button.is-outlined:focus,.button.is-dark.is-outlined.is-focused,.content kbd.button.is-outlined.is-focused{background-color:#363636;border-color:#363636;color:#fff}.button.is-dark.is-outlined.is-loading::after,.content kbd.button.is-outlined.is-loading::after{border-color:transparent transparent #363636 #363636 !important}.button.is-dark.is-outlined.is-loading:hover::after,.content kbd.button.is-outlined.is-loading:hover::after,.button.is-dark.is-outlined.is-loading.is-hovered::after,.content kbd.button.is-outlined.is-loading.is-hovered::after,.button.is-dark.is-outlined.is-loading:focus::after,.content kbd.button.is-outlined.is-loading:focus::after,.button.is-dark.is-outlined.is-loading.is-focused::after,.content kbd.button.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-dark.is-outlined[disabled],.content kbd.button.is-outlined[disabled],fieldset[disabled] .button.is-dark.is-outlined,fieldset[disabled] .content kbd.button.is-outlined,.content fieldset[disabled] kbd.button.is-outlined{background-color:transparent;border-color:#363636;box-shadow:none;color:#363636}.button.is-dark.is-inverted.is-outlined,.content kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-dark.is-inverted.is-outlined:hover,.content kbd.button.is-inverted.is-outlined:hover,.button.is-dark.is-inverted.is-outlined.is-hovered,.content kbd.button.is-inverted.is-outlined.is-hovered,.button.is-dark.is-inverted.is-outlined:focus,.content kbd.button.is-inverted.is-outlined:focus,.button.is-dark.is-inverted.is-outlined.is-focused,.content kbd.button.is-inverted.is-outlined.is-focused{background-color:#fff;color:#363636}.button.is-dark.is-inverted.is-outlined.is-loading:hover::after,.content kbd.button.is-inverted.is-outlined.is-loading:hover::after,.button.is-dark.is-inverted.is-outlined.is-loading.is-hovered::after,.content kbd.button.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-dark.is-inverted.is-outlined.is-loading:focus::after,.content kbd.button.is-inverted.is-outlined.is-loading:focus::after,.button.is-dark.is-inverted.is-outlined.is-loading.is-focused::after,.content kbd.button.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #363636 #363636 !important}.button.is-dark.is-inverted.is-outlined[disabled],.content kbd.button.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-dark.is-inverted.is-outlined,fieldset[disabled] .content kbd.button.is-inverted.is-outlined,.content fieldset[disabled] kbd.button.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-primary,.docstring>section>a.button.docs-sourcelink{background-color:#4eb5de;border-color:transparent;color:#fff}.button.is-primary:hover,.docstring>section>a.button.docs-sourcelink:hover,.button.is-primary.is-hovered,.docstring>section>a.button.is-hovered.docs-sourcelink{background-color:#43b1dc;border-color:transparent;color:#fff}.button.is-primary:focus,.docstring>section>a.button.docs-sourcelink:focus,.button.is-primary.is-focused,.docstring>section>a.button.is-focused.docs-sourcelink{border-color:transparent;color:#fff}.button.is-primary:focus:not(:active),.docstring>section>a.button.docs-sourcelink:focus:not(:active),.button.is-primary.is-focused:not(:active),.docstring>section>a.button.is-focused.docs-sourcelink:not(:active){box-shadow:0 0 0 0.125em rgba(78,181,222,0.25)}.button.is-primary:active,.docstring>section>a.button.docs-sourcelink:active,.button.is-primary.is-active,.docstring>section>a.button.is-active.docs-sourcelink{background-color:#39acda;border-color:transparent;color:#fff}.button.is-primary[disabled],.docstring>section>a.button.docs-sourcelink[disabled],fieldset[disabled] .button.is-primary,fieldset[disabled] .docstring>section>a.button.docs-sourcelink{background-color:#4eb5de;border-color:#4eb5de;box-shadow:none}.button.is-primary.is-inverted,.docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;color:#4eb5de}.button.is-primary.is-inverted:hover,.docstring>section>a.button.is-inverted.docs-sourcelink:hover,.button.is-primary.is-inverted.is-hovered,.docstring>section>a.button.is-inverted.is-hovered.docs-sourcelink{background-color:#f2f2f2}.button.is-primary.is-inverted[disabled],.docstring>section>a.button.is-inverted.docs-sourcelink[disabled],fieldset[disabled] .button.is-primary.is-inverted,fieldset[disabled] .docstring>section>a.button.is-inverted.docs-sourcelink{background-color:#fff;border-color:transparent;box-shadow:none;color:#4eb5de}.button.is-primary.is-loading::after,.docstring>section>a.button.is-loading.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}.button.is-primary.is-outlined,.docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#4eb5de;color:#4eb5de}.button.is-primary.is-outlined:hover,.docstring>section>a.button.is-outlined.docs-sourcelink:hover,.button.is-primary.is-outlined.is-hovered,.docstring>section>a.button.is-outlined.is-hovered.docs-sourcelink,.button.is-primary.is-outlined:focus,.docstring>section>a.button.is-outlined.docs-sourcelink:focus,.button.is-primary.is-outlined.is-focused,.docstring>section>a.button.is-outlined.is-focused.docs-sourcelink{background-color:#4eb5de;border-color:#4eb5de;color:#fff}.button.is-primary.is-outlined.is-loading::after,.docstring>section>a.button.is-outlined.is-loading.docs-sourcelink::after{border-color:transparent transparent #4eb5de #4eb5de !important}.button.is-primary.is-outlined.is-loading:hover::after,.docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:hover::after,.button.is-primary.is-outlined.is-loading.is-hovered::after,.docstring>section>a.button.is-outlined.is-loading.is-hovered.docs-sourcelink::after,.button.is-primary.is-outlined.is-loading:focus::after,.docstring>section>a.button.is-outlined.is-loading.docs-sourcelink:focus::after,.button.is-primary.is-outlined.is-loading.is-focused::after,.docstring>section>a.button.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #fff #fff !important}.button.is-primary.is-outlined[disabled],.docstring>section>a.button.is-outlined.docs-sourcelink[disabled],fieldset[disabled] .button.is-primary.is-outlined,fieldset[disabled] .docstring>section>a.button.is-outlined.docs-sourcelink{background-color:transparent;border-color:#4eb5de;box-shadow:none;color:#4eb5de}.button.is-primary.is-inverted.is-outlined,.docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;color:#fff}.button.is-primary.is-inverted.is-outlined:hover,.docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:hover,.button.is-primary.is-inverted.is-outlined.is-hovered,.docstring>section>a.button.is-inverted.is-outlined.is-hovered.docs-sourcelink,.button.is-primary.is-inverted.is-outlined:focus,.docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink:focus,.button.is-primary.is-inverted.is-outlined.is-focused,.docstring>section>a.button.is-inverted.is-outlined.is-focused.docs-sourcelink{background-color:#fff;color:#4eb5de}.button.is-primary.is-inverted.is-outlined.is-loading:hover::after,.docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:hover::after,.button.is-primary.is-inverted.is-outlined.is-loading.is-hovered::after,.docstring>section>a.button.is-inverted.is-outlined.is-loading.is-hovered.docs-sourcelink::after,.button.is-primary.is-inverted.is-outlined.is-loading:focus::after,.docstring>section>a.button.is-inverted.is-outlined.is-loading.docs-sourcelink:focus::after,.button.is-primary.is-inverted.is-outlined.is-loading.is-focused::after,.docstring>section>a.button.is-inverted.is-outlined.is-loading.is-focused.docs-sourcelink::after{border-color:transparent transparent #4eb5de #4eb5de !important}.button.is-primary.is-inverted.is-outlined[disabled],.docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink[disabled],fieldset[disabled] .button.is-primary.is-inverted.is-outlined,fieldset[disabled] .docstring>section>a.button.is-inverted.is-outlined.docs-sourcelink{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-primary.is-light,.docstring>section>a.button.is-light.docs-sourcelink{background-color:#eef8fc;color:#1a6d8e}.button.is-primary.is-light:hover,.docstring>section>a.button.is-light.docs-sourcelink:hover,.button.is-primary.is-light.is-hovered,.docstring>section>a.button.is-light.is-hovered.docs-sourcelink{background-color:#e3f3fa;border-color:transparent;color:#1a6d8e}.button.is-primary.is-light:active,.docstring>section>a.button.is-light.docs-sourcelink:active,.button.is-primary.is-light.is-active,.docstring>section>a.button.is-light.is-active.docs-sourcelink{background-color:#d8eff8;border-color:transparent;color:#1a6d8e}.button.is-link{background-color:#2e63b8;border-color:transparent;color:#fff}.button.is-link:hover,.button.is-link.is-hovered{background-color:#2b5eae;border-color:transparent;color:#fff}.button.is-link:focus,.button.is-link.is-focused{border-color:transparent;color:#fff}.button.is-link:focus:not(:active),.button.is-link.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(46,99,184,0.25)}.button.is-link:active,.button.is-link.is-active{background-color:#2958a4;border-color:transparent;color:#fff}.button.is-link[disabled],fieldset[disabled] .button.is-link{background-color:#2e63b8;border-color:#2e63b8;box-shadow:none}.button.is-link.is-inverted{background-color:#fff;color:#2e63b8}.button.is-link.is-inverted:hover,.button.is-link.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-link.is-inverted[disabled],fieldset[disabled] .button.is-link.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#2e63b8}.button.is-link.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-link.is-outlined{background-color:transparent;border-color:#2e63b8;color:#2e63b8}.button.is-link.is-outlined:hover,.button.is-link.is-outlined.is-hovered,.button.is-link.is-outlined:focus,.button.is-link.is-outlined.is-focused{background-color:#2e63b8;border-color:#2e63b8;color:#fff}.button.is-link.is-outlined.is-loading::after{border-color:transparent transparent #2e63b8 #2e63b8 !important}.button.is-link.is-outlined.is-loading:hover::after,.button.is-link.is-outlined.is-loading.is-hovered::after,.button.is-link.is-outlined.is-loading:focus::after,.button.is-link.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-link.is-outlined[disabled],fieldset[disabled] .button.is-link.is-outlined{background-color:transparent;border-color:#2e63b8;box-shadow:none;color:#2e63b8}.button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-link.is-inverted.is-outlined:hover,.button.is-link.is-inverted.is-outlined.is-hovered,.button.is-link.is-inverted.is-outlined:focus,.button.is-link.is-inverted.is-outlined.is-focused{background-color:#fff;color:#2e63b8}.button.is-link.is-inverted.is-outlined.is-loading:hover::after,.button.is-link.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-link.is-inverted.is-outlined.is-loading:focus::after,.button.is-link.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #2e63b8 #2e63b8 !important}.button.is-link.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-link.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-link.is-light{background-color:#eff3fb;color:#3169c4}.button.is-link.is-light:hover,.button.is-link.is-light.is-hovered{background-color:#e4ecf8;border-color:transparent;color:#3169c4}.button.is-link.is-light:active,.button.is-link.is-light.is-active{background-color:#dae5f6;border-color:transparent;color:#3169c4}.button.is-info{background-color:#3c5dcd;border-color:transparent;color:#fff}.button.is-info:hover,.button.is-info.is-hovered{background-color:#3355c9;border-color:transparent;color:#fff}.button.is-info:focus,.button.is-info.is-focused{border-color:transparent;color:#fff}.button.is-info:focus:not(:active),.button.is-info.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}.button.is-info:active,.button.is-info.is-active{background-color:#3151bf;border-color:transparent;color:#fff}.button.is-info[disabled],fieldset[disabled] .button.is-info{background-color:#3c5dcd;border-color:#3c5dcd;box-shadow:none}.button.is-info.is-inverted{background-color:#fff;color:#3c5dcd}.button.is-info.is-inverted:hover,.button.is-info.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-info.is-inverted[disabled],fieldset[disabled] .button.is-info.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#3c5dcd}.button.is-info.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-info.is-outlined{background-color:transparent;border-color:#3c5dcd;color:#3c5dcd}.button.is-info.is-outlined:hover,.button.is-info.is-outlined.is-hovered,.button.is-info.is-outlined:focus,.button.is-info.is-outlined.is-focused{background-color:#3c5dcd;border-color:#3c5dcd;color:#fff}.button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #3c5dcd #3c5dcd !important}.button.is-info.is-outlined.is-loading:hover::after,.button.is-info.is-outlined.is-loading.is-hovered::after,.button.is-info.is-outlined.is-loading:focus::after,.button.is-info.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-info.is-outlined[disabled],fieldset[disabled] .button.is-info.is-outlined{background-color:transparent;border-color:#3c5dcd;box-shadow:none;color:#3c5dcd}.button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-info.is-inverted.is-outlined:hover,.button.is-info.is-inverted.is-outlined.is-hovered,.button.is-info.is-inverted.is-outlined:focus,.button.is-info.is-inverted.is-outlined.is-focused{background-color:#fff;color:#3c5dcd}.button.is-info.is-inverted.is-outlined.is-loading:hover::after,.button.is-info.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-info.is-inverted.is-outlined.is-loading:focus::after,.button.is-info.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #3c5dcd #3c5dcd !important}.button.is-info.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-info.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-info.is-light{background-color:#eff2fb;color:#3253c3}.button.is-info.is-light:hover,.button.is-info.is-light.is-hovered{background-color:#e5e9f8;border-color:transparent;color:#3253c3}.button.is-info.is-light:active,.button.is-info.is-light.is-active{background-color:#dae1f6;border-color:transparent;color:#3253c3}.button.is-success{background-color:#259a12;border-color:transparent;color:#fff}.button.is-success:hover,.button.is-success.is-hovered{background-color:#228f11;border-color:transparent;color:#fff}.button.is-success:focus,.button.is-success.is-focused{border-color:transparent;color:#fff}.button.is-success:focus:not(:active),.button.is-success.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}.button.is-success:active,.button.is-success.is-active{background-color:#20830f;border-color:transparent;color:#fff}.button.is-success[disabled],fieldset[disabled] .button.is-success{background-color:#259a12;border-color:#259a12;box-shadow:none}.button.is-success.is-inverted{background-color:#fff;color:#259a12}.button.is-success.is-inverted:hover,.button.is-success.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-success.is-inverted[disabled],fieldset[disabled] .button.is-success.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#259a12}.button.is-success.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-success.is-outlined{background-color:transparent;border-color:#259a12;color:#259a12}.button.is-success.is-outlined:hover,.button.is-success.is-outlined.is-hovered,.button.is-success.is-outlined:focus,.button.is-success.is-outlined.is-focused{background-color:#259a12;border-color:#259a12;color:#fff}.button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #259a12 #259a12 !important}.button.is-success.is-outlined.is-loading:hover::after,.button.is-success.is-outlined.is-loading.is-hovered::after,.button.is-success.is-outlined.is-loading:focus::after,.button.is-success.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-success.is-outlined[disabled],fieldset[disabled] .button.is-success.is-outlined{background-color:transparent;border-color:#259a12;box-shadow:none;color:#259a12}.button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-success.is-inverted.is-outlined:hover,.button.is-success.is-inverted.is-outlined.is-hovered,.button.is-success.is-inverted.is-outlined:focus,.button.is-success.is-inverted.is-outlined.is-focused{background-color:#fff;color:#259a12}.button.is-success.is-inverted.is-outlined.is-loading:hover::after,.button.is-success.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-success.is-inverted.is-outlined.is-loading:focus::after,.button.is-success.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #259a12 #259a12 !important}.button.is-success.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-success.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-success.is-light{background-color:#effded;color:#2ec016}.button.is-success.is-light:hover,.button.is-success.is-light.is-hovered{background-color:#e5fce1;border-color:transparent;color:#2ec016}.button.is-success.is-light:active,.button.is-success.is-light.is-active{background-color:#dbfad6;border-color:transparent;color:#2ec016}.button.is-warning{background-color:#a98800;border-color:transparent;color:#fff}.button.is-warning:hover,.button.is-warning.is-hovered{background-color:#9c7d00;border-color:transparent;color:#fff}.button.is-warning:focus,.button.is-warning.is-focused{border-color:transparent;color:#fff}.button.is-warning:focus:not(:active),.button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(169,136,0,0.25)}.button.is-warning:active,.button.is-warning.is-active{background-color:#8f7300;border-color:transparent;color:#fff}.button.is-warning[disabled],fieldset[disabled] .button.is-warning{background-color:#a98800;border-color:#a98800;box-shadow:none}.button.is-warning.is-inverted{background-color:#fff;color:#a98800}.button.is-warning.is-inverted:hover,.button.is-warning.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-warning.is-inverted[disabled],fieldset[disabled] .button.is-warning.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#a98800}.button.is-warning.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-warning.is-outlined{background-color:transparent;border-color:#a98800;color:#a98800}.button.is-warning.is-outlined:hover,.button.is-warning.is-outlined.is-hovered,.button.is-warning.is-outlined:focus,.button.is-warning.is-outlined.is-focused{background-color:#a98800;border-color:#a98800;color:#fff}.button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #a98800 #a98800 !important}.button.is-warning.is-outlined.is-loading:hover::after,.button.is-warning.is-outlined.is-loading.is-hovered::after,.button.is-warning.is-outlined.is-loading:focus::after,.button.is-warning.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-warning.is-outlined[disabled],fieldset[disabled] .button.is-warning.is-outlined{background-color:transparent;border-color:#a98800;box-shadow:none;color:#a98800}.button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-warning.is-inverted.is-outlined:hover,.button.is-warning.is-inverted.is-outlined.is-hovered,.button.is-warning.is-inverted.is-outlined:focus,.button.is-warning.is-inverted.is-outlined.is-focused{background-color:#fff;color:#a98800}.button.is-warning.is-inverted.is-outlined.is-loading:hover::after,.button.is-warning.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-warning.is-inverted.is-outlined.is-loading:focus::after,.button.is-warning.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #a98800 #a98800 !important}.button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-warning.is-light{background-color:#fffbeb;color:#cca400}.button.is-warning.is-light:hover,.button.is-warning.is-light.is-hovered{background-color:#fff9de;border-color:transparent;color:#cca400}.button.is-warning.is-light:active,.button.is-warning.is-light.is-active{background-color:#fff6d1;border-color:transparent;color:#cca400}.button.is-danger{background-color:#cb3c33;border-color:transparent;color:#fff}.button.is-danger:hover,.button.is-danger.is-hovered{background-color:#c13930;border-color:transparent;color:#fff}.button.is-danger:focus,.button.is-danger.is-focused{border-color:transparent;color:#fff}.button.is-danger:focus:not(:active),.button.is-danger.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}.button.is-danger:active,.button.is-danger.is-active{background-color:#b7362e;border-color:transparent;color:#fff}.button.is-danger[disabled],fieldset[disabled] .button.is-danger{background-color:#cb3c33;border-color:#cb3c33;box-shadow:none}.button.is-danger.is-inverted{background-color:#fff;color:#cb3c33}.button.is-danger.is-inverted:hover,.button.is-danger.is-inverted.is-hovered{background-color:#f2f2f2}.button.is-danger.is-inverted[disabled],fieldset[disabled] .button.is-danger.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#cb3c33}.button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-danger.is-outlined{background-color:transparent;border-color:#cb3c33;color:#cb3c33}.button.is-danger.is-outlined:hover,.button.is-danger.is-outlined.is-hovered,.button.is-danger.is-outlined:focus,.button.is-danger.is-outlined.is-focused{background-color:#cb3c33;border-color:#cb3c33;color:#fff}.button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #cb3c33 #cb3c33 !important}.button.is-danger.is-outlined.is-loading:hover::after,.button.is-danger.is-outlined.is-loading.is-hovered::after,.button.is-danger.is-outlined.is-loading:focus::after,.button.is-danger.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #fff #fff !important}.button.is-danger.is-outlined[disabled],fieldset[disabled] .button.is-danger.is-outlined{background-color:transparent;border-color:#cb3c33;box-shadow:none;color:#cb3c33}.button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}.button.is-danger.is-inverted.is-outlined:hover,.button.is-danger.is-inverted.is-outlined.is-hovered,.button.is-danger.is-inverted.is-outlined:focus,.button.is-danger.is-inverted.is-outlined.is-focused{background-color:#fff;color:#cb3c33}.button.is-danger.is-inverted.is-outlined.is-loading:hover::after,.button.is-danger.is-inverted.is-outlined.is-loading.is-hovered::after,.button.is-danger.is-inverted.is-outlined.is-loading:focus::after,.button.is-danger.is-inverted.is-outlined.is-loading.is-focused::after{border-color:transparent transparent #cb3c33 #cb3c33 !important}.button.is-danger.is-inverted.is-outlined[disabled],fieldset[disabled] .button.is-danger.is-inverted.is-outlined{background-color:transparent;border-color:#fff;box-shadow:none;color:#fff}.button.is-danger.is-light{background-color:#fbefef;color:#c03930}.button.is-danger.is-light:hover,.button.is-danger.is-light.is-hovered{background-color:#f8e6e5;border-color:transparent;color:#c03930}.button.is-danger.is-light:active,.button.is-danger.is-light.is-active{background-color:#f6dcda;border-color:transparent;color:#c03930}.button.is-small,#documenter .docs-sidebar form.docs-search>input.button{font-size:.75rem}.button.is-small:not(.is-rounded),#documenter .docs-sidebar form.docs-search>input.button:not(.is-rounded){border-radius:2px}.button.is-normal{font-size:1rem}.button.is-medium{font-size:1.25rem}.button.is-large{font-size:1.5rem}.button[disabled],fieldset[disabled] .button{background-color:#fff;border-color:#dbdbdb;box-shadow:none;opacity:.5}.button.is-fullwidth{display:flex;width:100%}.button.is-loading{color:transparent !important;pointer-events:none}.button.is-loading::after{position:absolute;left:calc(50% - (1em * 0.5));top:calc(50% - (1em * 0.5));position:absolute !important}.button.is-static{background-color:#f5f5f5;border-color:#dbdbdb;color:#6b6b6b;box-shadow:none;pointer-events:none}.button.is-rounded,#documenter .docs-sidebar form.docs-search>input.button{border-radius:9999px;padding-left:calc(1em + 0.25em);padding-right:calc(1em + 0.25em)}.buttons{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}.buttons .button{margin-bottom:0.5rem}.buttons .button:not(:last-child):not(.is-fullwidth){margin-right:.5rem}.buttons:last-child{margin-bottom:-0.5rem}.buttons:not(:last-child){margin-bottom:1rem}.buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large){font-size:.75rem}.buttons.are-small .button:not(.is-normal):not(.is-medium):not(.is-large):not(.is-rounded){border-radius:2px}.buttons.are-medium .button:not(.is-small):not(.is-normal):not(.is-large){font-size:1.25rem}.buttons.are-large .button:not(.is-small):not(.is-normal):not(.is-medium){font-size:1.5rem}.buttons.has-addons .button:not(:first-child){border-bottom-left-radius:0;border-top-left-radius:0}.buttons.has-addons .button:not(:last-child){border-bottom-right-radius:0;border-top-right-radius:0;margin-right:-1px}.buttons.has-addons .button:last-child{margin-right:0}.buttons.has-addons .button:hover,.buttons.has-addons .button.is-hovered{z-index:2}.buttons.has-addons .button:focus,.buttons.has-addons .button.is-focused,.buttons.has-addons .button:active,.buttons.has-addons .button.is-active,.buttons.has-addons .button.is-selected{z-index:3}.buttons.has-addons .button:focus:hover,.buttons.has-addons .button.is-focused:hover,.buttons.has-addons .button:active:hover,.buttons.has-addons .button.is-active:hover,.buttons.has-addons .button.is-selected:hover{z-index:4}.buttons.has-addons .button.is-expanded{flex-grow:1;flex-shrink:1}.buttons.is-centered{justify-content:center}.buttons.is-centered:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}.buttons.is-right{justify-content:flex-end}.buttons.is-right:not(.has-addons) .button:not(.is-fullwidth){margin-left:0.25rem;margin-right:0.25rem}@media screen and (max-width: 768px){.button.is-responsive.is-small,#documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.5625rem}.button.is-responsive,.button.is-responsive.is-normal{font-size:.65625rem}.button.is-responsive.is-medium{font-size:.75rem}.button.is-responsive.is-large{font-size:1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.button.is-responsive.is-small,#documenter .docs-sidebar form.docs-search>input.is-responsive{font-size:.65625rem}.button.is-responsive,.button.is-responsive.is-normal{font-size:.75rem}.button.is-responsive.is-medium{font-size:1rem}.button.is-responsive.is-large{font-size:1.25rem}}.container{flex-grow:1;margin:0 auto;position:relative;width:auto}.container.is-fluid{max-width:none !important;padding-left:32px;padding-right:32px;width:100%}@media screen and (min-width: 1056px){.container{max-width:992px}}@media screen and (max-width: 1215px){.container.is-widescreen:not(.is-max-desktop){max-width:1152px}}@media screen and (max-width: 1407px){.container.is-fullhd:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}@media screen and (min-width: 1216px){.container:not(.is-max-desktop){max-width:1152px}}@media screen and (min-width: 1408px){.container:not(.is-max-desktop):not(.is-max-widescreen){max-width:1344px}}.content li+li{margin-top:0.25em}.content p:not(:last-child),.content dl:not(:last-child),.content ol:not(:last-child),.content ul:not(:last-child),.content blockquote:not(:last-child),.content pre:not(:last-child),.content table:not(:last-child){margin-bottom:1em}.content h1,.content h2,.content h3,.content h4,.content h5,.content h6{color:#222;font-weight:600;line-height:1.125}.content h1{font-size:2em;margin-bottom:0.5em}.content h1:not(:first-child){margin-top:1em}.content h2{font-size:1.75em;margin-bottom:0.5714em}.content h2:not(:first-child){margin-top:1.1428em}.content h3{font-size:1.5em;margin-bottom:0.6666em}.content h3:not(:first-child){margin-top:1.3333em}.content h4{font-size:1.25em;margin-bottom:0.8em}.content h5{font-size:1.125em;margin-bottom:0.8888em}.content h6{font-size:1em;margin-bottom:1em}.content blockquote{background-color:#f5f5f5;border-left:5px solid #dbdbdb;padding:1.25em 1.5em}.content ol{list-style-position:outside;margin-left:2em;margin-top:1em}.content ol:not([type]){list-style-type:decimal}.content ol.is-lower-alpha:not([type]){list-style-type:lower-alpha}.content ol.is-lower-roman:not([type]){list-style-type:lower-roman}.content ol.is-upper-alpha:not([type]){list-style-type:upper-alpha}.content ol.is-upper-roman:not([type]){list-style-type:upper-roman}.content ul{list-style:disc outside;margin-left:2em;margin-top:1em}.content ul ul{list-style-type:circle;margin-top:0.5em}.content ul ul ul{list-style-type:square}.content dd{margin-left:2em}.content figure{margin-left:2em;margin-right:2em;text-align:center}.content figure:not(:first-child){margin-top:2em}.content figure:not(:last-child){margin-bottom:2em}.content figure img{display:inline-block}.content figure figcaption{font-style:italic}.content pre{-webkit-overflow-scrolling:touch;overflow-x:auto;padding:0;white-space:pre;word-wrap:normal}.content sup,.content sub{font-size:75%}.content table{width:100%}.content table td,.content table th{border:1px solid #dbdbdb;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}.content table th{color:#222}.content table th:not([align]){text-align:inherit}.content table thead td,.content table thead th{border-width:0 0 2px;color:#222}.content table tfoot td,.content table tfoot th{border-width:2px 0 0;color:#222}.content table tbody tr:last-child td,.content table tbody tr:last-child th{border-bottom-width:0}.content .tabs li+li{margin-top:0}.content.is-small,#documenter .docs-sidebar form.docs-search>input.content{font-size:.75rem}.content.is-normal{font-size:1rem}.content.is-medium{font-size:1.25rem}.content.is-large{font-size:1.5rem}.icon{align-items:center;display:inline-flex;justify-content:center;height:1.5rem;width:1.5rem}.icon.is-small,#documenter .docs-sidebar form.docs-search>input.icon{height:1rem;width:1rem}.icon.is-medium{height:2rem;width:2rem}.icon.is-large{height:3rem;width:3rem}.icon-text{align-items:flex-start;color:inherit;display:inline-flex;flex-wrap:wrap;line-height:1.5rem;vertical-align:top}.icon-text .icon{flex-grow:0;flex-shrink:0}.icon-text .icon:not(:last-child){margin-right:.25em}.icon-text .icon:not(:first-child){margin-left:.25em}div.icon-text{display:flex}.image,#documenter .docs-sidebar .docs-logo>img{display:block;position:relative}.image img,#documenter .docs-sidebar .docs-logo>img img{display:block;height:auto;width:100%}.image img.is-rounded,#documenter .docs-sidebar .docs-logo>img img.is-rounded{border-radius:9999px}.image.is-fullwidth,#documenter .docs-sidebar .docs-logo>img.is-fullwidth{width:100%}.image.is-square img,#documenter .docs-sidebar .docs-logo>img.is-square img,.image.is-square .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-square .has-ratio,.image.is-1by1 img,#documenter .docs-sidebar .docs-logo>img.is-1by1 img,.image.is-1by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by1 .has-ratio,.image.is-5by4 img,#documenter .docs-sidebar .docs-logo>img.is-5by4 img,.image.is-5by4 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-5by4 .has-ratio,.image.is-4by3 img,#documenter .docs-sidebar .docs-logo>img.is-4by3 img,.image.is-4by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-4by3 .has-ratio,.image.is-3by2 img,#documenter .docs-sidebar .docs-logo>img.is-3by2 img,.image.is-3by2 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by2 .has-ratio,.image.is-5by3 img,#documenter .docs-sidebar .docs-logo>img.is-5by3 img,.image.is-5by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-5by3 .has-ratio,.image.is-16by9 img,#documenter .docs-sidebar .docs-logo>img.is-16by9 img,.image.is-16by9 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-16by9 .has-ratio,.image.is-2by1 img,#documenter .docs-sidebar .docs-logo>img.is-2by1 img,.image.is-2by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-2by1 .has-ratio,.image.is-3by1 img,#documenter .docs-sidebar .docs-logo>img.is-3by1 img,.image.is-3by1 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by1 .has-ratio,.image.is-4by5 img,#documenter .docs-sidebar .docs-logo>img.is-4by5 img,.image.is-4by5 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-4by5 .has-ratio,.image.is-3by4 img,#documenter .docs-sidebar .docs-logo>img.is-3by4 img,.image.is-3by4 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by4 .has-ratio,.image.is-2by3 img,#documenter .docs-sidebar .docs-logo>img.is-2by3 img,.image.is-2by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-2by3 .has-ratio,.image.is-3by5 img,#documenter .docs-sidebar .docs-logo>img.is-3by5 img,.image.is-3by5 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-3by5 .has-ratio,.image.is-9by16 img,#documenter .docs-sidebar .docs-logo>img.is-9by16 img,.image.is-9by16 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-9by16 .has-ratio,.image.is-1by2 img,#documenter .docs-sidebar .docs-logo>img.is-1by2 img,.image.is-1by2 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by2 .has-ratio,.image.is-1by3 img,#documenter .docs-sidebar .docs-logo>img.is-1by3 img,.image.is-1by3 .has-ratio,#documenter .docs-sidebar .docs-logo>img.is-1by3 .has-ratio{height:100%;width:100%}.image.is-square,#documenter .docs-sidebar .docs-logo>img.is-square,.image.is-1by1,#documenter .docs-sidebar .docs-logo>img.is-1by1{padding-top:100%}.image.is-5by4,#documenter .docs-sidebar .docs-logo>img.is-5by4{padding-top:80%}.image.is-4by3,#documenter .docs-sidebar .docs-logo>img.is-4by3{padding-top:75%}.image.is-3by2,#documenter .docs-sidebar .docs-logo>img.is-3by2{padding-top:66.6666%}.image.is-5by3,#documenter .docs-sidebar .docs-logo>img.is-5by3{padding-top:60%}.image.is-16by9,#documenter .docs-sidebar .docs-logo>img.is-16by9{padding-top:56.25%}.image.is-2by1,#documenter .docs-sidebar .docs-logo>img.is-2by1{padding-top:50%}.image.is-3by1,#documenter .docs-sidebar .docs-logo>img.is-3by1{padding-top:33.3333%}.image.is-4by5,#documenter .docs-sidebar .docs-logo>img.is-4by5{padding-top:125%}.image.is-3by4,#documenter .docs-sidebar .docs-logo>img.is-3by4{padding-top:133.3333%}.image.is-2by3,#documenter .docs-sidebar .docs-logo>img.is-2by3{padding-top:150%}.image.is-3by5,#documenter .docs-sidebar .docs-logo>img.is-3by5{padding-top:166.6666%}.image.is-9by16,#documenter .docs-sidebar .docs-logo>img.is-9by16{padding-top:177.7777%}.image.is-1by2,#documenter .docs-sidebar .docs-logo>img.is-1by2{padding-top:200%}.image.is-1by3,#documenter .docs-sidebar .docs-logo>img.is-1by3{padding-top:300%}.image.is-16x16,#documenter .docs-sidebar .docs-logo>img.is-16x16{height:16px;width:16px}.image.is-24x24,#documenter .docs-sidebar .docs-logo>img.is-24x24{height:24px;width:24px}.image.is-32x32,#documenter .docs-sidebar .docs-logo>img.is-32x32{height:32px;width:32px}.image.is-48x48,#documenter .docs-sidebar .docs-logo>img.is-48x48{height:48px;width:48px}.image.is-64x64,#documenter .docs-sidebar .docs-logo>img.is-64x64{height:64px;width:64px}.image.is-96x96,#documenter .docs-sidebar .docs-logo>img.is-96x96{height:96px;width:96px}.image.is-128x128,#documenter .docs-sidebar .docs-logo>img.is-128x128{height:128px;width:128px}.notification{background-color:#f5f5f5;border-radius:4px;position:relative;padding:1.25rem 2.5rem 1.25rem 1.5rem}.notification a:not(.button):not(.dropdown-item){color:currentColor;text-decoration:underline}.notification strong{color:currentColor}.notification code,.notification pre{background:#fff}.notification pre code{background:transparent}.notification>.delete{right:.5rem;position:absolute;top:0.5rem}.notification .title,.notification .subtitle,.notification .content{color:currentColor}.notification.is-white{background-color:#fff;color:#0a0a0a}.notification.is-black{background-color:#0a0a0a;color:#fff}.notification.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.notification.is-dark,.content kbd.notification{background-color:#363636;color:#fff}.notification.is-primary,.docstring>section>a.notification.docs-sourcelink{background-color:#4eb5de;color:#fff}.notification.is-primary.is-light,.docstring>section>a.notification.is-light.docs-sourcelink{background-color:#eef8fc;color:#1a6d8e}.notification.is-link{background-color:#2e63b8;color:#fff}.notification.is-link.is-light{background-color:#eff3fb;color:#3169c4}.notification.is-info{background-color:#3c5dcd;color:#fff}.notification.is-info.is-light{background-color:#eff2fb;color:#3253c3}.notification.is-success{background-color:#259a12;color:#fff}.notification.is-success.is-light{background-color:#effded;color:#2ec016}.notification.is-warning{background-color:#a98800;color:#fff}.notification.is-warning.is-light{background-color:#fffbeb;color:#cca400}.notification.is-danger{background-color:#cb3c33;color:#fff}.notification.is-danger.is-light{background-color:#fbefef;color:#c03930}.progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:9999px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}.progress::-webkit-progress-bar{background-color:#ededed}.progress::-webkit-progress-value{background-color:#222}.progress::-moz-progress-bar{background-color:#222}.progress::-ms-fill{background-color:#222;border:none}.progress.is-white::-webkit-progress-value{background-color:#fff}.progress.is-white::-moz-progress-bar{background-color:#fff}.progress.is-white::-ms-fill{background-color:#fff}.progress.is-white:indeterminate{background-image:linear-gradient(to right, #fff 30%, #ededed 30%)}.progress.is-black::-webkit-progress-value{background-color:#0a0a0a}.progress.is-black::-moz-progress-bar{background-color:#0a0a0a}.progress.is-black::-ms-fill{background-color:#0a0a0a}.progress.is-black:indeterminate{background-image:linear-gradient(to right, #0a0a0a 30%, #ededed 30%)}.progress.is-light::-webkit-progress-value{background-color:#f5f5f5}.progress.is-light::-moz-progress-bar{background-color:#f5f5f5}.progress.is-light::-ms-fill{background-color:#f5f5f5}.progress.is-light:indeterminate{background-image:linear-gradient(to right, #f5f5f5 30%, #ededed 30%)}.progress.is-dark::-webkit-progress-value,.content kbd.progress::-webkit-progress-value{background-color:#363636}.progress.is-dark::-moz-progress-bar,.content kbd.progress::-moz-progress-bar{background-color:#363636}.progress.is-dark::-ms-fill,.content kbd.progress::-ms-fill{background-color:#363636}.progress.is-dark:indeterminate,.content kbd.progress:indeterminate{background-image:linear-gradient(to right, #363636 30%, #ededed 30%)}.progress.is-primary::-webkit-progress-value,.docstring>section>a.progress.docs-sourcelink::-webkit-progress-value{background-color:#4eb5de}.progress.is-primary::-moz-progress-bar,.docstring>section>a.progress.docs-sourcelink::-moz-progress-bar{background-color:#4eb5de}.progress.is-primary::-ms-fill,.docstring>section>a.progress.docs-sourcelink::-ms-fill{background-color:#4eb5de}.progress.is-primary:indeterminate,.docstring>section>a.progress.docs-sourcelink:indeterminate{background-image:linear-gradient(to right, #4eb5de 30%, #ededed 30%)}.progress.is-link::-webkit-progress-value{background-color:#2e63b8}.progress.is-link::-moz-progress-bar{background-color:#2e63b8}.progress.is-link::-ms-fill{background-color:#2e63b8}.progress.is-link:indeterminate{background-image:linear-gradient(to right, #2e63b8 30%, #ededed 30%)}.progress.is-info::-webkit-progress-value{background-color:#3c5dcd}.progress.is-info::-moz-progress-bar{background-color:#3c5dcd}.progress.is-info::-ms-fill{background-color:#3c5dcd}.progress.is-info:indeterminate{background-image:linear-gradient(to right, #3c5dcd 30%, #ededed 30%)}.progress.is-success::-webkit-progress-value{background-color:#259a12}.progress.is-success::-moz-progress-bar{background-color:#259a12}.progress.is-success::-ms-fill{background-color:#259a12}.progress.is-success:indeterminate{background-image:linear-gradient(to right, #259a12 30%, #ededed 30%)}.progress.is-warning::-webkit-progress-value{background-color:#a98800}.progress.is-warning::-moz-progress-bar{background-color:#a98800}.progress.is-warning::-ms-fill{background-color:#a98800}.progress.is-warning:indeterminate{background-image:linear-gradient(to right, #a98800 30%, #ededed 30%)}.progress.is-danger::-webkit-progress-value{background-color:#cb3c33}.progress.is-danger::-moz-progress-bar{background-color:#cb3c33}.progress.is-danger::-ms-fill{background-color:#cb3c33}.progress.is-danger:indeterminate{background-image:linear-gradient(to right, #cb3c33 30%, #ededed 30%)}.progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#ededed;background-image:linear-gradient(to right, #222 30%, #ededed 30%);background-position:top left;background-repeat:no-repeat;background-size:150% 150%}.progress:indeterminate::-webkit-progress-bar{background-color:transparent}.progress:indeterminate::-moz-progress-bar{background-color:transparent}.progress:indeterminate::-ms-fill{animation-name:none}.progress.is-small,#documenter .docs-sidebar form.docs-search>input.progress{height:.75rem}.progress.is-medium{height:1.25rem}.progress.is-large{height:1.5rem}@keyframes moveIndeterminate{from{background-position:200% 0}to{background-position:-200% 0}}.table{background-color:#fff;color:#222}.table td,.table th{border:1px solid #dbdbdb;border-width:0 0 1px;padding:0.5em 0.75em;vertical-align:top}.table td.is-white,.table th.is-white{background-color:#fff;border-color:#fff;color:#0a0a0a}.table td.is-black,.table th.is-black{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}.table td.is-light,.table th.is-light{background-color:#f5f5f5;border-color:#f5f5f5;color:rgba(0,0,0,0.7)}.table td.is-dark,.table th.is-dark{background-color:#363636;border-color:#363636;color:#fff}.table td.is-primary,.table th.is-primary{background-color:#4eb5de;border-color:#4eb5de;color:#fff}.table td.is-link,.table th.is-link{background-color:#2e63b8;border-color:#2e63b8;color:#fff}.table td.is-info,.table th.is-info{background-color:#3c5dcd;border-color:#3c5dcd;color:#fff}.table td.is-success,.table th.is-success{background-color:#259a12;border-color:#259a12;color:#fff}.table td.is-warning,.table th.is-warning{background-color:#a98800;border-color:#a98800;color:#fff}.table td.is-danger,.table th.is-danger{background-color:#cb3c33;border-color:#cb3c33;color:#fff}.table td.is-narrow,.table th.is-narrow{white-space:nowrap;width:1%}.table td.is-selected,.table th.is-selected{background-color:#4eb5de;color:#fff}.table td.is-selected a,.table td.is-selected strong,.table th.is-selected a,.table th.is-selected strong{color:currentColor}.table td.is-vcentered,.table th.is-vcentered{vertical-align:middle}.table th{color:#222}.table th:not([align]){text-align:left}.table tr.is-selected{background-color:#4eb5de;color:#fff}.table tr.is-selected a,.table tr.is-selected strong{color:currentColor}.table tr.is-selected td,.table tr.is-selected th{border-color:#fff;color:currentColor}.table thead{background-color:rgba(0,0,0,0)}.table thead td,.table thead th{border-width:0 0 2px;color:#222}.table tfoot{background-color:rgba(0,0,0,0)}.table tfoot td,.table tfoot th{border-width:2px 0 0;color:#222}.table tbody{background-color:rgba(0,0,0,0)}.table tbody tr:last-child td,.table tbody tr:last-child th{border-bottom-width:0}.table.is-bordered td,.table.is-bordered th{border-width:1px}.table.is-bordered tr:last-child td,.table.is-bordered tr:last-child th{border-bottom-width:1px}.table.is-fullwidth{width:100%}.table.is-hoverable tbody tr:not(.is-selected):hover{background-color:#fafafa}.table.is-hoverable.is-striped tbody tr:not(.is-selected):hover{background-color:#fafafa}.table.is-hoverable.is-striped tbody tr:not(.is-selected):hover:nth-child(even){background-color:#f5f5f5}.table.is-narrow td,.table.is-narrow th{padding:0.25em 0.5em}.table.is-striped tbody tr:not(.is-selected):nth-child(even){background-color:#fafafa}.table-container{-webkit-overflow-scrolling:touch;overflow:auto;overflow-y:hidden;max-width:100%}.tags{align-items:center;display:flex;flex-wrap:wrap;justify-content:flex-start}.tags .tag,.tags .content kbd,.content .tags kbd,.tags .docstring>section>a.docs-sourcelink{margin-bottom:0.5rem}.tags .tag:not(:last-child),.tags .content kbd:not(:last-child),.content .tags kbd:not(:last-child),.tags .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:.5rem}.tags:last-child{margin-bottom:-0.5rem}.tags:not(:last-child){margin-bottom:1rem}.tags.are-medium .tag:not(.is-normal):not(.is-large),.tags.are-medium .content kbd:not(.is-normal):not(.is-large),.content .tags.are-medium kbd:not(.is-normal):not(.is-large),.tags.are-medium .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-large){font-size:1rem}.tags.are-large .tag:not(.is-normal):not(.is-medium),.tags.are-large .content kbd:not(.is-normal):not(.is-medium),.content .tags.are-large kbd:not(.is-normal):not(.is-medium),.tags.are-large .docstring>section>a.docs-sourcelink:not(.is-normal):not(.is-medium){font-size:1.25rem}.tags.is-centered{justify-content:center}.tags.is-centered .tag,.tags.is-centered .content kbd,.content .tags.is-centered kbd,.tags.is-centered .docstring>section>a.docs-sourcelink{margin-right:0.25rem;margin-left:0.25rem}.tags.is-right{justify-content:flex-end}.tags.is-right .tag:not(:first-child),.tags.is-right .content kbd:not(:first-child),.content .tags.is-right kbd:not(:first-child),.tags.is-right .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0.5rem}.tags.is-right .tag:not(:last-child),.tags.is-right .content kbd:not(:last-child),.content .tags.is-right kbd:not(:last-child),.tags.is-right .docstring>section>a.docs-sourcelink:not(:last-child){margin-right:0}.tags.has-addons .tag,.tags.has-addons .content kbd,.content .tags.has-addons kbd,.tags.has-addons .docstring>section>a.docs-sourcelink{margin-right:0}.tags.has-addons .tag:not(:first-child),.tags.has-addons .content kbd:not(:first-child),.content .tags.has-addons kbd:not(:first-child),.tags.has-addons .docstring>section>a.docs-sourcelink:not(:first-child){margin-left:0;border-top-left-radius:0;border-bottom-left-radius:0}.tags.has-addons .tag:not(:last-child),.tags.has-addons .content kbd:not(:last-child),.content .tags.has-addons kbd:not(:last-child),.tags.has-addons .docstring>section>a.docs-sourcelink:not(:last-child){border-top-right-radius:0;border-bottom-right-radius:0}.tag:not(body),.content kbd:not(body),.docstring>section>a.docs-sourcelink:not(body){align-items:center;background-color:#f5f5f5;border-radius:4px;color:#222;display:inline-flex;font-size:.75rem;height:2em;justify-content:center;line-height:1.5;padding-left:0.75em;padding-right:0.75em;white-space:nowrap}.tag:not(body) .delete,.content kbd:not(body) .delete,.docstring>section>a.docs-sourcelink:not(body) .delete{margin-left:.25rem;margin-right:-.375rem}.tag.is-white:not(body),.content kbd.is-white:not(body),.docstring>section>a.docs-sourcelink.is-white:not(body){background-color:#fff;color:#0a0a0a}.tag.is-black:not(body),.content kbd.is-black:not(body),.docstring>section>a.docs-sourcelink.is-black:not(body){background-color:#0a0a0a;color:#fff}.tag.is-light:not(body),.content kbd.is-light:not(body),.docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.tag.is-dark:not(body),.content kbd:not(body),.docstring>section>a.docs-sourcelink.is-dark:not(body),.content .docstring>section>kbd:not(body){background-color:#363636;color:#fff}.tag.is-primary:not(body),.content kbd.is-primary:not(body),.docstring>section>a.docs-sourcelink:not(body){background-color:#4eb5de;color:#fff}.tag.is-primary.is-light:not(body),.content kbd.is-primary.is-light:not(body),.docstring>section>a.docs-sourcelink.is-light:not(body){background-color:#eef8fc;color:#1a6d8e}.tag.is-link:not(body),.content kbd.is-link:not(body),.docstring>section>a.docs-sourcelink.is-link:not(body){background-color:#2e63b8;color:#fff}.tag.is-link.is-light:not(body),.content kbd.is-link.is-light:not(body),.docstring>section>a.docs-sourcelink.is-link.is-light:not(body){background-color:#eff3fb;color:#3169c4}.tag.is-info:not(body),.content kbd.is-info:not(body),.docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#3c5dcd;color:#fff}.tag.is-info.is-light:not(body),.content kbd.is-info.is-light:not(body),.docstring>section>a.docs-sourcelink.is-info.is-light:not(body){background-color:#eff2fb;color:#3253c3}.tag.is-success:not(body),.content kbd.is-success:not(body),.docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#259a12;color:#fff}.tag.is-success.is-light:not(body),.content kbd.is-success.is-light:not(body),.docstring>section>a.docs-sourcelink.is-success.is-light:not(body){background-color:#effded;color:#2ec016}.tag.is-warning:not(body),.content kbd.is-warning:not(body),.docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#a98800;color:#fff}.tag.is-warning.is-light:not(body),.content kbd.is-warning.is-light:not(body),.docstring>section>a.docs-sourcelink.is-warning.is-light:not(body){background-color:#fffbeb;color:#cca400}.tag.is-danger:not(body),.content kbd.is-danger:not(body),.docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#cb3c33;color:#fff}.tag.is-danger.is-light:not(body),.content kbd.is-danger.is-light:not(body),.docstring>section>a.docs-sourcelink.is-danger.is-light:not(body){background-color:#fbefef;color:#c03930}.tag.is-normal:not(body),.content kbd.is-normal:not(body),.docstring>section>a.docs-sourcelink.is-normal:not(body){font-size:.75rem}.tag.is-medium:not(body),.content kbd.is-medium:not(body),.docstring>section>a.docs-sourcelink.is-medium:not(body){font-size:1rem}.tag.is-large:not(body),.content kbd.is-large:not(body),.docstring>section>a.docs-sourcelink.is-large:not(body){font-size:1.25rem}.tag:not(body) .icon:first-child:not(:last-child),.content kbd:not(body) .icon:first-child:not(:last-child),.docstring>section>a.docs-sourcelink:not(body) .icon:first-child:not(:last-child){margin-left:-.375em;margin-right:.1875em}.tag:not(body) .icon:last-child:not(:first-child),.content kbd:not(body) .icon:last-child:not(:first-child),.docstring>section>a.docs-sourcelink:not(body) .icon:last-child:not(:first-child){margin-left:.1875em;margin-right:-.375em}.tag:not(body) .icon:first-child:last-child,.content kbd:not(body) .icon:first-child:last-child,.docstring>section>a.docs-sourcelink:not(body) .icon:first-child:last-child{margin-left:-.375em;margin-right:-.375em}.tag.is-delete:not(body),.content kbd.is-delete:not(body),.docstring>section>a.docs-sourcelink.is-delete:not(body){margin-left:1px;padding:0;position:relative;width:2em}.tag.is-delete:not(body)::before,.content kbd.is-delete:not(body)::before,.docstring>section>a.docs-sourcelink.is-delete:not(body)::before,.tag.is-delete:not(body)::after,.content kbd.is-delete:not(body)::after,.docstring>section>a.docs-sourcelink.is-delete:not(body)::after{background-color:currentColor;content:"";display:block;left:50%;position:absolute;top:50%;transform:translateX(-50%) translateY(-50%) rotate(45deg);transform-origin:center center}.tag.is-delete:not(body)::before,.content kbd.is-delete:not(body)::before,.docstring>section>a.docs-sourcelink.is-delete:not(body)::before{height:1px;width:50%}.tag.is-delete:not(body)::after,.content kbd.is-delete:not(body)::after,.docstring>section>a.docs-sourcelink.is-delete:not(body)::after{height:50%;width:1px}.tag.is-delete:not(body):hover,.content kbd.is-delete:not(body):hover,.docstring>section>a.docs-sourcelink.is-delete:not(body):hover,.tag.is-delete:not(body):focus,.content kbd.is-delete:not(body):focus,.docstring>section>a.docs-sourcelink.is-delete:not(body):focus{background-color:#e8e8e8}.tag.is-delete:not(body):active,.content kbd.is-delete:not(body):active,.docstring>section>a.docs-sourcelink.is-delete:not(body):active{background-color:#dbdbdb}.tag.is-rounded:not(body),#documenter .docs-sidebar form.docs-search>input:not(body),.content kbd.is-rounded:not(body),#documenter .docs-sidebar .content form.docs-search>input:not(body),.docstring>section>a.docs-sourcelink.is-rounded:not(body){border-radius:9999px}a.tag:hover,.docstring>section>a.docs-sourcelink:hover{text-decoration:underline}.title,.subtitle{word-break:break-word}.title em,.title span,.subtitle em,.subtitle span{font-weight:inherit}.title sub,.subtitle sub{font-size:.75em}.title sup,.subtitle sup{font-size:.75em}.title .tag,.title .content kbd,.content .title kbd,.title .docstring>section>a.docs-sourcelink,.subtitle .tag,.subtitle .content kbd,.content .subtitle kbd,.subtitle .docstring>section>a.docs-sourcelink{vertical-align:middle}.title{color:#222;font-size:2rem;font-weight:600;line-height:1.125}.title strong{color:inherit;font-weight:inherit}.title:not(.is-spaced)+.subtitle{margin-top:-1.25rem}.title.is-1{font-size:3rem}.title.is-2{font-size:2.5rem}.title.is-3{font-size:2rem}.title.is-4{font-size:1.5rem}.title.is-5{font-size:1.25rem}.title.is-6{font-size:1rem}.title.is-7{font-size:.75rem}.subtitle{color:#222;font-size:1.25rem;font-weight:400;line-height:1.25}.subtitle strong{color:#222;font-weight:600}.subtitle:not(.is-spaced)+.title{margin-top:-1.25rem}.subtitle.is-1{font-size:3rem}.subtitle.is-2{font-size:2.5rem}.subtitle.is-3{font-size:2rem}.subtitle.is-4{font-size:1.5rem}.subtitle.is-5{font-size:1.25rem}.subtitle.is-6{font-size:1rem}.subtitle.is-7{font-size:.75rem}.heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}.number{align-items:center;background-color:#f5f5f5;border-radius:9999px;display:inline-flex;font-size:1.25rem;height:2em;justify-content:center;margin-right:1.5rem;min-width:2.5em;padding:0.25rem 0.5rem;text-align:center;vertical-align:top}.select select,.textarea,.input,#documenter .docs-sidebar form.docs-search>input{background-color:#fff;border-color:#dbdbdb;border-radius:4px;color:#222}.select select::-moz-placeholder,.textarea::-moz-placeholder,.input::-moz-placeholder,#documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:#707070}.select select::-webkit-input-placeholder,.textarea::-webkit-input-placeholder,.input::-webkit-input-placeholder,#documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:#707070}.select select:-moz-placeholder,.textarea:-moz-placeholder,.input:-moz-placeholder,#documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:#707070}.select select:-ms-input-placeholder,.textarea:-ms-input-placeholder,.input:-ms-input-placeholder,#documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:#707070}.select select:hover,.textarea:hover,.input:hover,#documenter .docs-sidebar form.docs-search>input:hover,.select select.is-hovered,.is-hovered.textarea,.is-hovered.input,#documenter .docs-sidebar form.docs-search>input.is-hovered{border-color:#b5b5b5}.select select:focus,.textarea:focus,.input:focus,#documenter .docs-sidebar form.docs-search>input:focus,.select select.is-focused,.is-focused.textarea,.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.select select:active,.textarea:active,.input:active,#documenter .docs-sidebar form.docs-search>input:active,.select select.is-active,.is-active.textarea,.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{border-color:#2e63b8;box-shadow:0 0 0 0.125em rgba(46,99,184,0.25)}.select select[disabled],.textarea[disabled],.input[disabled],#documenter .docs-sidebar form.docs-search>input[disabled],fieldset[disabled] .select select,.select fieldset[disabled] select,fieldset[disabled] .textarea,fieldset[disabled] .input,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input{background-color:#f5f5f5;border-color:#f5f5f5;box-shadow:none;color:#6b6b6b}.select select[disabled]::-moz-placeholder,.textarea[disabled]::-moz-placeholder,.input[disabled]::-moz-placeholder,#documenter .docs-sidebar form.docs-search>input[disabled]::-moz-placeholder,fieldset[disabled] .select select::-moz-placeholder,.select fieldset[disabled] select::-moz-placeholder,fieldset[disabled] .textarea::-moz-placeholder,fieldset[disabled] .input::-moz-placeholder,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input::-moz-placeholder,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input::-moz-placeholder{color:rgba(107,107,107,0.3)}.select select[disabled]::-webkit-input-placeholder,.textarea[disabled]::-webkit-input-placeholder,.input[disabled]::-webkit-input-placeholder,#documenter .docs-sidebar form.docs-search>input[disabled]::-webkit-input-placeholder,fieldset[disabled] .select select::-webkit-input-placeholder,.select fieldset[disabled] select::-webkit-input-placeholder,fieldset[disabled] .textarea::-webkit-input-placeholder,fieldset[disabled] .input::-webkit-input-placeholder,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input::-webkit-input-placeholder{color:rgba(107,107,107,0.3)}.select select[disabled]:-moz-placeholder,.textarea[disabled]:-moz-placeholder,.input[disabled]:-moz-placeholder,#documenter .docs-sidebar form.docs-search>input[disabled]:-moz-placeholder,fieldset[disabled] .select select:-moz-placeholder,.select fieldset[disabled] select:-moz-placeholder,fieldset[disabled] .textarea:-moz-placeholder,fieldset[disabled] .input:-moz-placeholder,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input:-moz-placeholder,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input:-moz-placeholder{color:rgba(107,107,107,0.3)}.select select[disabled]:-ms-input-placeholder,.textarea[disabled]:-ms-input-placeholder,.input[disabled]:-ms-input-placeholder,#documenter .docs-sidebar form.docs-search>input[disabled]:-ms-input-placeholder,fieldset[disabled] .select select:-ms-input-placeholder,.select fieldset[disabled] select:-ms-input-placeholder,fieldset[disabled] .textarea:-ms-input-placeholder,fieldset[disabled] .input:-ms-input-placeholder,fieldset[disabled] #documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder,#documenter .docs-sidebar fieldset[disabled] form.docs-search>input:-ms-input-placeholder{color:rgba(107,107,107,0.3)}.textarea,.input,#documenter .docs-sidebar form.docs-search>input{box-shadow:inset 0 0.0625em 0.125em rgba(10,10,10,0.05);max-width:100%;width:100%}.textarea[readonly],.input[readonly],#documenter .docs-sidebar form.docs-search>input[readonly]{box-shadow:none}.is-white.textarea,.is-white.input,#documenter .docs-sidebar form.docs-search>input.is-white{border-color:#fff}.is-white.textarea:focus,.is-white.input:focus,#documenter .docs-sidebar form.docs-search>input.is-white:focus,.is-white.is-focused.textarea,.is-white.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-white.textarea:active,.is-white.input:active,#documenter .docs-sidebar form.docs-search>input.is-white:active,.is-white.is-active.textarea,.is-white.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}.is-black.textarea,.is-black.input,#documenter .docs-sidebar form.docs-search>input.is-black{border-color:#0a0a0a}.is-black.textarea:focus,.is-black.input:focus,#documenter .docs-sidebar form.docs-search>input.is-black:focus,.is-black.is-focused.textarea,.is-black.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-black.textarea:active,.is-black.input:active,#documenter .docs-sidebar form.docs-search>input.is-black:active,.is-black.is-active.textarea,.is-black.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}.is-light.textarea,.is-light.input,#documenter .docs-sidebar form.docs-search>input.is-light{border-color:#f5f5f5}.is-light.textarea:focus,.is-light.input:focus,#documenter .docs-sidebar form.docs-search>input.is-light:focus,.is-light.is-focused.textarea,.is-light.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-light.textarea:active,.is-light.input:active,#documenter .docs-sidebar form.docs-search>input.is-light:active,.is-light.is-active.textarea,.is-light.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}.is-dark.textarea,.content kbd.textarea,.is-dark.input,#documenter .docs-sidebar form.docs-search>input.is-dark,.content kbd.input{border-color:#363636}.is-dark.textarea:focus,.content kbd.textarea:focus,.is-dark.input:focus,#documenter .docs-sidebar form.docs-search>input.is-dark:focus,.content kbd.input:focus,.is-dark.is-focused.textarea,.content kbd.is-focused.textarea,.is-dark.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.content kbd.is-focused.input,#documenter .docs-sidebar .content form.docs-search>input.is-focused,.is-dark.textarea:active,.content kbd.textarea:active,.is-dark.input:active,#documenter .docs-sidebar form.docs-search>input.is-dark:active,.content kbd.input:active,.is-dark.is-active.textarea,.content kbd.is-active.textarea,.is-dark.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active,.content kbd.is-active.input,#documenter .docs-sidebar .content form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(54,54,54,0.25)}.is-primary.textarea,.docstring>section>a.textarea.docs-sourcelink,.is-primary.input,#documenter .docs-sidebar form.docs-search>input.is-primary,.docstring>section>a.input.docs-sourcelink{border-color:#4eb5de}.is-primary.textarea:focus,.docstring>section>a.textarea.docs-sourcelink:focus,.is-primary.input:focus,#documenter .docs-sidebar form.docs-search>input.is-primary:focus,.docstring>section>a.input.docs-sourcelink:focus,.is-primary.is-focused.textarea,.docstring>section>a.is-focused.textarea.docs-sourcelink,.is-primary.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.docstring>section>a.is-focused.input.docs-sourcelink,.is-primary.textarea:active,.docstring>section>a.textarea.docs-sourcelink:active,.is-primary.input:active,#documenter .docs-sidebar form.docs-search>input.is-primary:active,.docstring>section>a.input.docs-sourcelink:active,.is-primary.is-active.textarea,.docstring>section>a.is-active.textarea.docs-sourcelink,.is-primary.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active,.docstring>section>a.is-active.input.docs-sourcelink{box-shadow:0 0 0 0.125em rgba(78,181,222,0.25)}.is-link.textarea,.is-link.input,#documenter .docs-sidebar form.docs-search>input.is-link{border-color:#2e63b8}.is-link.textarea:focus,.is-link.input:focus,#documenter .docs-sidebar form.docs-search>input.is-link:focus,.is-link.is-focused.textarea,.is-link.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-link.textarea:active,.is-link.input:active,#documenter .docs-sidebar form.docs-search>input.is-link:active,.is-link.is-active.textarea,.is-link.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(46,99,184,0.25)}.is-info.textarea,.is-info.input,#documenter .docs-sidebar form.docs-search>input.is-info{border-color:#3c5dcd}.is-info.textarea:focus,.is-info.input:focus,#documenter .docs-sidebar form.docs-search>input.is-info:focus,.is-info.is-focused.textarea,.is-info.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-info.textarea:active,.is-info.input:active,#documenter .docs-sidebar form.docs-search>input.is-info:active,.is-info.is-active.textarea,.is-info.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}.is-success.textarea,.is-success.input,#documenter .docs-sidebar form.docs-search>input.is-success{border-color:#259a12}.is-success.textarea:focus,.is-success.input:focus,#documenter .docs-sidebar form.docs-search>input.is-success:focus,.is-success.is-focused.textarea,.is-success.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-success.textarea:active,.is-success.input:active,#documenter .docs-sidebar form.docs-search>input.is-success:active,.is-success.is-active.textarea,.is-success.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}.is-warning.textarea,.is-warning.input,#documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#a98800}.is-warning.textarea:focus,.is-warning.input:focus,#documenter .docs-sidebar form.docs-search>input.is-warning:focus,.is-warning.is-focused.textarea,.is-warning.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-warning.textarea:active,.is-warning.input:active,#documenter .docs-sidebar form.docs-search>input.is-warning:active,.is-warning.is-active.textarea,.is-warning.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(169,136,0,0.25)}.is-danger.textarea,.is-danger.input,#documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#cb3c33}.is-danger.textarea:focus,.is-danger.input:focus,#documenter .docs-sidebar form.docs-search>input.is-danger:focus,.is-danger.is-focused.textarea,.is-danger.is-focused.input,#documenter .docs-sidebar form.docs-search>input.is-focused,.is-danger.textarea:active,.is-danger.input:active,#documenter .docs-sidebar form.docs-search>input.is-danger:active,.is-danger.is-active.textarea,.is-danger.is-active.input,#documenter .docs-sidebar form.docs-search>input.is-active{box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}.is-small.textarea,.is-small.input,#documenter .docs-sidebar form.docs-search>input{border-radius:2px;font-size:.75rem}.is-medium.textarea,.is-medium.input,#documenter .docs-sidebar form.docs-search>input.is-medium{font-size:1.25rem}.is-large.textarea,.is-large.input,#documenter .docs-sidebar form.docs-search>input.is-large{font-size:1.5rem}.is-fullwidth.textarea,.is-fullwidth.input,#documenter .docs-sidebar form.docs-search>input.is-fullwidth{display:block;width:100%}.is-inline.textarea,.is-inline.input,#documenter .docs-sidebar form.docs-search>input.is-inline{display:inline;width:auto}.input.is-rounded,#documenter .docs-sidebar form.docs-search>input{border-radius:9999px;padding-left:calc(calc(0.75em - 1px) + 0.375em);padding-right:calc(calc(0.75em - 1px) + 0.375em)}.input.is-static,#documenter .docs-sidebar form.docs-search>input.is-static{background-color:transparent;border-color:transparent;box-shadow:none;padding-left:0;padding-right:0}.textarea{display:block;max-width:100%;min-width:100%;padding:calc(0.75em - 1px);resize:vertical}.textarea:not([rows]){max-height:40em;min-height:8em}.textarea[rows]{height:initial}.textarea.has-fixed-size{resize:none}.radio,.checkbox{cursor:pointer;display:inline-block;line-height:1.25;position:relative}.radio input,.checkbox input{cursor:pointer}.radio:hover,.checkbox:hover{color:#222}.radio[disabled],.checkbox[disabled],fieldset[disabled] .radio,fieldset[disabled] .checkbox,.radio input[disabled],.checkbox input[disabled]{color:#6b6b6b;cursor:not-allowed}.radio+.radio{margin-left:.5em}.select{display:inline-block;max-width:100%;position:relative;vertical-align:top}.select:not(.is-multiple){height:2.5em}.select:not(.is-multiple):not(.is-loading)::after{border-color:#2e63b8;right:1.125em;z-index:4}.select.is-rounded select,#documenter .docs-sidebar form.docs-search>input.select select{border-radius:9999px;padding-left:1em}.select select{cursor:pointer;display:block;font-size:1em;max-width:100%;outline:none}.select select::-ms-expand{display:none}.select select[disabled]:hover,fieldset[disabled] .select select:hover{border-color:#f5f5f5}.select select:not([multiple]){padding-right:2.5em}.select select[multiple]{height:auto;padding:0}.select select[multiple] option{padding:0.5em 1em}.select:not(.is-multiple):not(.is-loading):hover::after{border-color:#222}.select.is-white:not(:hover)::after{border-color:#fff}.select.is-white select{border-color:#fff}.select.is-white select:hover,.select.is-white select.is-hovered{border-color:#f2f2f2}.select.is-white select:focus,.select.is-white select.is-focused,.select.is-white select:active,.select.is-white select.is-active{box-shadow:0 0 0 0.125em rgba(255,255,255,0.25)}.select.is-black:not(:hover)::after{border-color:#0a0a0a}.select.is-black select{border-color:#0a0a0a}.select.is-black select:hover,.select.is-black select.is-hovered{border-color:#000}.select.is-black select:focus,.select.is-black select.is-focused,.select.is-black select:active,.select.is-black select.is-active{box-shadow:0 0 0 0.125em rgba(10,10,10,0.25)}.select.is-light:not(:hover)::after{border-color:#f5f5f5}.select.is-light select{border-color:#f5f5f5}.select.is-light select:hover,.select.is-light select.is-hovered{border-color:#e8e8e8}.select.is-light select:focus,.select.is-light select.is-focused,.select.is-light select:active,.select.is-light select.is-active{box-shadow:0 0 0 0.125em rgba(245,245,245,0.25)}.select.is-dark:not(:hover)::after,.content kbd.select:not(:hover)::after{border-color:#363636}.select.is-dark select,.content kbd.select select{border-color:#363636}.select.is-dark select:hover,.content kbd.select select:hover,.select.is-dark select.is-hovered,.content kbd.select select.is-hovered{border-color:#292929}.select.is-dark select:focus,.content kbd.select select:focus,.select.is-dark select.is-focused,.content kbd.select select.is-focused,.select.is-dark select:active,.content kbd.select select:active,.select.is-dark select.is-active,.content kbd.select select.is-active{box-shadow:0 0 0 0.125em rgba(54,54,54,0.25)}.select.is-primary:not(:hover)::after,.docstring>section>a.select.docs-sourcelink:not(:hover)::after{border-color:#4eb5de}.select.is-primary select,.docstring>section>a.select.docs-sourcelink select{border-color:#4eb5de}.select.is-primary select:hover,.docstring>section>a.select.docs-sourcelink select:hover,.select.is-primary select.is-hovered,.docstring>section>a.select.docs-sourcelink select.is-hovered{border-color:#39acda}.select.is-primary select:focus,.docstring>section>a.select.docs-sourcelink select:focus,.select.is-primary select.is-focused,.docstring>section>a.select.docs-sourcelink select.is-focused,.select.is-primary select:active,.docstring>section>a.select.docs-sourcelink select:active,.select.is-primary select.is-active,.docstring>section>a.select.docs-sourcelink select.is-active{box-shadow:0 0 0 0.125em rgba(78,181,222,0.25)}.select.is-link:not(:hover)::after{border-color:#2e63b8}.select.is-link select{border-color:#2e63b8}.select.is-link select:hover,.select.is-link select.is-hovered{border-color:#2958a4}.select.is-link select:focus,.select.is-link select.is-focused,.select.is-link select:active,.select.is-link select.is-active{box-shadow:0 0 0 0.125em rgba(46,99,184,0.25)}.select.is-info:not(:hover)::after{border-color:#3c5dcd}.select.is-info select{border-color:#3c5dcd}.select.is-info select:hover,.select.is-info select.is-hovered{border-color:#3151bf}.select.is-info select:focus,.select.is-info select.is-focused,.select.is-info select:active,.select.is-info select.is-active{box-shadow:0 0 0 0.125em rgba(60,93,205,0.25)}.select.is-success:not(:hover)::after{border-color:#259a12}.select.is-success select{border-color:#259a12}.select.is-success select:hover,.select.is-success select.is-hovered{border-color:#20830f}.select.is-success select:focus,.select.is-success select.is-focused,.select.is-success select:active,.select.is-success select.is-active{box-shadow:0 0 0 0.125em rgba(37,154,18,0.25)}.select.is-warning:not(:hover)::after{border-color:#a98800}.select.is-warning select{border-color:#a98800}.select.is-warning select:hover,.select.is-warning select.is-hovered{border-color:#8f7300}.select.is-warning select:focus,.select.is-warning select.is-focused,.select.is-warning select:active,.select.is-warning select.is-active{box-shadow:0 0 0 0.125em rgba(169,136,0,0.25)}.select.is-danger:not(:hover)::after{border-color:#cb3c33}.select.is-danger select{border-color:#cb3c33}.select.is-danger select:hover,.select.is-danger select.is-hovered{border-color:#b7362e}.select.is-danger select:focus,.select.is-danger select.is-focused,.select.is-danger select:active,.select.is-danger select.is-active{box-shadow:0 0 0 0.125em rgba(203,60,51,0.25)}.select.is-small,#documenter .docs-sidebar form.docs-search>input.select{border-radius:2px;font-size:.75rem}.select.is-medium{font-size:1.25rem}.select.is-large{font-size:1.5rem}.select.is-disabled::after{border-color:#6b6b6b !important;opacity:0.5}.select.is-fullwidth{width:100%}.select.is-fullwidth select{width:100%}.select.is-loading::after{margin-top:0;position:absolute;right:.625em;top:0.625em;transform:none}.select.is-loading.is-small:after,#documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}.select.is-loading.is-medium:after{font-size:1.25rem}.select.is-loading.is-large:after{font-size:1.5rem}.file{align-items:stretch;display:flex;justify-content:flex-start;position:relative}.file.is-white .file-cta{background-color:#fff;border-color:transparent;color:#0a0a0a}.file.is-white:hover .file-cta,.file.is-white.is-hovered .file-cta{background-color:#f9f9f9;border-color:transparent;color:#0a0a0a}.file.is-white:focus .file-cta,.file.is-white.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,255,255,0.25);color:#0a0a0a}.file.is-white:active .file-cta,.file.is-white.is-active .file-cta{background-color:#f2f2f2;border-color:transparent;color:#0a0a0a}.file.is-black .file-cta{background-color:#0a0a0a;border-color:transparent;color:#fff}.file.is-black:hover .file-cta,.file.is-black.is-hovered .file-cta{background-color:#040404;border-color:transparent;color:#fff}.file.is-black:focus .file-cta,.file.is-black.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(10,10,10,0.25);color:#fff}.file.is-black:active .file-cta,.file.is-black.is-active .file-cta{background-color:#000;border-color:transparent;color:#fff}.file.is-light .file-cta{background-color:#f5f5f5;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-light:hover .file-cta,.file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-light:focus .file-cta,.file.is-light.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(245,245,245,0.25);color:rgba(0,0,0,0.7)}.file.is-light:active .file-cta,.file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-dark .file-cta,.content kbd.file .file-cta{background-color:#363636;border-color:transparent;color:#fff}.file.is-dark:hover .file-cta,.content kbd.file:hover .file-cta,.file.is-dark.is-hovered .file-cta,.content kbd.file.is-hovered .file-cta{background-color:#2f2f2f;border-color:transparent;color:#fff}.file.is-dark:focus .file-cta,.content kbd.file:focus .file-cta,.file.is-dark.is-focused .file-cta,.content kbd.file.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(54,54,54,0.25);color:#fff}.file.is-dark:active .file-cta,.content kbd.file:active .file-cta,.file.is-dark.is-active .file-cta,.content kbd.file.is-active .file-cta{background-color:#292929;border-color:transparent;color:#fff}.file.is-primary .file-cta,.docstring>section>a.file.docs-sourcelink .file-cta{background-color:#4eb5de;border-color:transparent;color:#fff}.file.is-primary:hover .file-cta,.docstring>section>a.file.docs-sourcelink:hover .file-cta,.file.is-primary.is-hovered .file-cta,.docstring>section>a.file.is-hovered.docs-sourcelink .file-cta{background-color:#43b1dc;border-color:transparent;color:#fff}.file.is-primary:focus .file-cta,.docstring>section>a.file.docs-sourcelink:focus .file-cta,.file.is-primary.is-focused .file-cta,.docstring>section>a.file.is-focused.docs-sourcelink .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(78,181,222,0.25);color:#fff}.file.is-primary:active .file-cta,.docstring>section>a.file.docs-sourcelink:active .file-cta,.file.is-primary.is-active .file-cta,.docstring>section>a.file.is-active.docs-sourcelink .file-cta{background-color:#39acda;border-color:transparent;color:#fff}.file.is-link .file-cta{background-color:#2e63b8;border-color:transparent;color:#fff}.file.is-link:hover .file-cta,.file.is-link.is-hovered .file-cta{background-color:#2b5eae;border-color:transparent;color:#fff}.file.is-link:focus .file-cta,.file.is-link.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(46,99,184,0.25);color:#fff}.file.is-link:active .file-cta,.file.is-link.is-active .file-cta{background-color:#2958a4;border-color:transparent;color:#fff}.file.is-info .file-cta{background-color:#3c5dcd;border-color:transparent;color:#fff}.file.is-info:hover .file-cta,.file.is-info.is-hovered .file-cta{background-color:#3355c9;border-color:transparent;color:#fff}.file.is-info:focus .file-cta,.file.is-info.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(60,93,205,0.25);color:#fff}.file.is-info:active .file-cta,.file.is-info.is-active .file-cta{background-color:#3151bf;border-color:transparent;color:#fff}.file.is-success .file-cta{background-color:#259a12;border-color:transparent;color:#fff}.file.is-success:hover .file-cta,.file.is-success.is-hovered .file-cta{background-color:#228f11;border-color:transparent;color:#fff}.file.is-success:focus .file-cta,.file.is-success.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(37,154,18,0.25);color:#fff}.file.is-success:active .file-cta,.file.is-success.is-active .file-cta{background-color:#20830f;border-color:transparent;color:#fff}.file.is-warning .file-cta{background-color:#a98800;border-color:transparent;color:#fff}.file.is-warning:hover .file-cta,.file.is-warning.is-hovered .file-cta{background-color:#9c7d00;border-color:transparent;color:#fff}.file.is-warning:focus .file-cta,.file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(169,136,0,0.25);color:#fff}.file.is-warning:active .file-cta,.file.is-warning.is-active .file-cta{background-color:#8f7300;border-color:transparent;color:#fff}.file.is-danger .file-cta{background-color:#cb3c33;border-color:transparent;color:#fff}.file.is-danger:hover .file-cta,.file.is-danger.is-hovered .file-cta{background-color:#c13930;border-color:transparent;color:#fff}.file.is-danger:focus .file-cta,.file.is-danger.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(203,60,51,0.25);color:#fff}.file.is-danger:active .file-cta,.file.is-danger.is-active .file-cta{background-color:#b7362e;border-color:transparent;color:#fff}.file.is-small,#documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}.file.is-normal{font-size:1rem}.file.is-medium{font-size:1.25rem}.file.is-medium .file-icon .fa{font-size:21px}.file.is-large{font-size:1.5rem}.file.is-large .file-icon .fa{font-size:28px}.file.has-name .file-cta{border-bottom-right-radius:0;border-top-right-radius:0}.file.has-name .file-name{border-bottom-left-radius:0;border-top-left-radius:0}.file.has-name.is-empty .file-cta{border-radius:4px}.file.has-name.is-empty .file-name{display:none}.file.is-boxed .file-label{flex-direction:column}.file.is-boxed .file-cta{flex-direction:column;height:auto;padding:1em 3em}.file.is-boxed .file-name{border-width:0 1px 1px}.file.is-boxed .file-icon{height:1.5em;width:1.5em}.file.is-boxed .file-icon .fa{font-size:21px}.file.is-boxed.is-small .file-icon .fa,#documenter .docs-sidebar form.docs-search>input.is-boxed .file-icon .fa{font-size:14px}.file.is-boxed.is-medium .file-icon .fa{font-size:28px}.file.is-boxed.is-large .file-icon .fa{font-size:35px}.file.is-boxed.has-name .file-cta{border-radius:4px 4px 0 0}.file.is-boxed.has-name .file-name{border-radius:0 0 4px 4px;border-width:0 1px 1px}.file.is-centered{justify-content:center}.file.is-fullwidth .file-label{width:100%}.file.is-fullwidth .file-name{flex-grow:1;max-width:none}.file.is-right{justify-content:flex-end}.file.is-right .file-cta{border-radius:0 4px 4px 0}.file.is-right .file-name{border-radius:4px 0 0 4px;border-width:1px 0 1px 1px;order:-1}.file-label{align-items:stretch;display:flex;cursor:pointer;justify-content:flex-start;overflow:hidden;position:relative}.file-label:hover .file-cta{background-color:#eee;color:#222}.file-label:hover .file-name{border-color:#d5d5d5}.file-label:active .file-cta{background-color:#e8e8e8;color:#222}.file-label:active .file-name{border-color:#cfcfcf}.file-input{height:100%;left:0;opacity:0;outline:none;position:absolute;top:0;width:100%}.file-cta,.file-name{border-color:#dbdbdb;border-radius:4px;font-size:1em;padding-left:1em;padding-right:1em;white-space:nowrap}.file-cta{background-color:#f5f5f5;color:#222}.file-name{border-color:#dbdbdb;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:inherit;text-overflow:ellipsis}.file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:.5em;width:1em}.file-icon .fa{font-size:14px}.label{color:#222;display:block;font-size:1rem;font-weight:700}.label:not(:last-child){margin-bottom:0.5em}.label.is-small,#documenter .docs-sidebar form.docs-search>input.label{font-size:.75rem}.label.is-medium{font-size:1.25rem}.label.is-large{font-size:1.5rem}.help{display:block;font-size:.75rem;margin-top:0.25rem}.help.is-white{color:#fff}.help.is-black{color:#0a0a0a}.help.is-light{color:#f5f5f5}.help.is-dark,.content kbd.help{color:#363636}.help.is-primary,.docstring>section>a.help.docs-sourcelink{color:#4eb5de}.help.is-link{color:#2e63b8}.help.is-info{color:#3c5dcd}.help.is-success{color:#259a12}.help.is-warning{color:#a98800}.help.is-danger{color:#cb3c33}.field:not(:last-child){margin-bottom:0.75rem}.field.has-addons{display:flex;justify-content:flex-start}.field.has-addons .control:not(:last-child){margin-right:-1px}.field.has-addons .control:not(:first-child):not(:last-child) .button,.field.has-addons .control:not(:first-child):not(:last-child) .input,.field.has-addons .control:not(:first-child):not(:last-child) #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar .field.has-addons .control:not(:first-child):not(:last-child) form.docs-search>input,.field.has-addons .control:not(:first-child):not(:last-child) .select select{border-radius:0}.field.has-addons .control:first-child:not(:only-child) .button,.field.has-addons .control:first-child:not(:only-child) .input,.field.has-addons .control:first-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar .field.has-addons .control:first-child:not(:only-child) form.docs-search>input,.field.has-addons .control:first-child:not(:only-child) .select select{border-bottom-right-radius:0;border-top-right-radius:0}.field.has-addons .control:last-child:not(:only-child) .button,.field.has-addons .control:last-child:not(:only-child) .input,.field.has-addons .control:last-child:not(:only-child) #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar .field.has-addons .control:last-child:not(:only-child) form.docs-search>input,.field.has-addons .control:last-child:not(:only-child) .select select{border-bottom-left-radius:0;border-top-left-radius:0}.field.has-addons .control .button:not([disabled]):hover,.field.has-addons .control .button.is-hovered:not([disabled]),.field.has-addons .control .input:not([disabled]):hover,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):hover,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):hover,.field.has-addons .control .input.is-hovered:not([disabled]),.field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-hovered:not([disabled]),#documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-hovered:not([disabled]),.field.has-addons .control .select select:not([disabled]):hover,.field.has-addons .control .select select.is-hovered:not([disabled]){z-index:2}.field.has-addons .control .button:not([disabled]):focus,.field.has-addons .control .button.is-focused:not([disabled]),.field.has-addons .control .button:not([disabled]):active,.field.has-addons .control .button.is-active:not([disabled]),.field.has-addons .control .input:not([disabled]):focus,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus,.field.has-addons .control .input.is-focused:not([disabled]),.field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]),#documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]),.field.has-addons .control .input:not([disabled]):active,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active,.field.has-addons .control .input.is-active:not([disabled]),.field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]),#documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]),.field.has-addons .control .select select:not([disabled]):focus,.field.has-addons .control .select select.is-focused:not([disabled]),.field.has-addons .control .select select:not([disabled]):active,.field.has-addons .control .select select.is-active:not([disabled]){z-index:3}.field.has-addons .control .button:not([disabled]):focus:hover,.field.has-addons .control .button.is-focused:not([disabled]):hover,.field.has-addons .control .button:not([disabled]):active:hover,.field.has-addons .control .button.is-active:not([disabled]):hover,.field.has-addons .control .input:not([disabled]):focus:hover,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):focus:hover,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):focus:hover,.field.has-addons .control .input.is-focused:not([disabled]):hover,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-focused:not([disabled]):hover,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-focused:not([disabled]):hover,.field.has-addons .control .input:not([disabled]):active:hover,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input:not([disabled]):active:hover,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input:not([disabled]):active:hover,.field.has-addons .control .input.is-active:not([disabled]):hover,.field.has-addons .control #documenter .docs-sidebar form.docs-search>input.is-active:not([disabled]):hover,#documenter .docs-sidebar .field.has-addons .control form.docs-search>input.is-active:not([disabled]):hover,.field.has-addons .control .select select:not([disabled]):focus:hover,.field.has-addons .control .select select.is-focused:not([disabled]):hover,.field.has-addons .control .select select:not([disabled]):active:hover,.field.has-addons .control .select select.is-active:not([disabled]):hover{z-index:4}.field.has-addons .control.is-expanded{flex-grow:1;flex-shrink:1}.field.has-addons.has-addons-centered{justify-content:center}.field.has-addons.has-addons-right{justify-content:flex-end}.field.has-addons.has-addons-fullwidth .control{flex-grow:1;flex-shrink:0}.field.is-grouped{display:flex;justify-content:flex-start}.field.is-grouped>.control{flex-shrink:0}.field.is-grouped>.control:not(:last-child){margin-bottom:0;margin-right:.75rem}.field.is-grouped>.control.is-expanded{flex-grow:1;flex-shrink:1}.field.is-grouped.is-grouped-centered{justify-content:center}.field.is-grouped.is-grouped-right{justify-content:flex-end}.field.is-grouped.is-grouped-multiline{flex-wrap:wrap}.field.is-grouped.is-grouped-multiline>.control:last-child,.field.is-grouped.is-grouped-multiline>.control:not(:last-child){margin-bottom:0.75rem}.field.is-grouped.is-grouped-multiline:last-child{margin-bottom:-0.75rem}.field.is-grouped.is-grouped-multiline:not(:last-child){margin-bottom:0}@media screen and (min-width: 769px),print{.field.is-horizontal{display:flex}}.field-label .label{font-size:inherit}@media screen and (max-width: 768px){.field-label{margin-bottom:0.5rem}}@media screen and (min-width: 769px),print{.field-label{flex-basis:0;flex-grow:1;flex-shrink:0;margin-right:1.5rem;text-align:right}.field-label.is-small,#documenter .docs-sidebar form.docs-search>input.field-label{font-size:.75rem;padding-top:0.375em}.field-label.is-normal{padding-top:0.375em}.field-label.is-medium{font-size:1.25rem;padding-top:0.375em}.field-label.is-large{font-size:1.5rem;padding-top:0.375em}}.field-body .field .field{margin-bottom:0}@media screen and (min-width: 769px),print{.field-body{display:flex;flex-basis:0;flex-grow:5;flex-shrink:1}.field-body .field{margin-bottom:0}.field-body>.field{flex-shrink:1}.field-body>.field:not(.is-narrow){flex-grow:1}.field-body>.field:not(:last-child){margin-right:.75rem}}.control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:inherit}.control.has-icons-left .input:focus~.icon,.control.has-icons-left #documenter .docs-sidebar form.docs-search>input:focus~.icon,#documenter .docs-sidebar .control.has-icons-left form.docs-search>input:focus~.icon,.control.has-icons-left .select:focus~.icon,.control.has-icons-right .input:focus~.icon,.control.has-icons-right #documenter .docs-sidebar form.docs-search>input:focus~.icon,#documenter .docs-sidebar .control.has-icons-right form.docs-search>input:focus~.icon,.control.has-icons-right .select:focus~.icon{color:#222}.control.has-icons-left .input.is-small~.icon,.control.has-icons-left #documenter .docs-sidebar form.docs-search>input~.icon,#documenter .docs-sidebar .control.has-icons-left form.docs-search>input~.icon,.control.has-icons-left .select.is-small~.icon,.control.has-icons-right .input.is-small~.icon,.control.has-icons-right #documenter .docs-sidebar form.docs-search>input~.icon,#documenter .docs-sidebar .control.has-icons-right form.docs-search>input~.icon,.control.has-icons-right .select.is-small~.icon{font-size:.75rem}.control.has-icons-left .input.is-medium~.icon,.control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,#documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-medium~.icon,.control.has-icons-left .select.is-medium~.icon,.control.has-icons-right .input.is-medium~.icon,.control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-medium~.icon,#documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-medium~.icon,.control.has-icons-right .select.is-medium~.icon{font-size:1.25rem}.control.has-icons-left .input.is-large~.icon,.control.has-icons-left #documenter .docs-sidebar form.docs-search>input.is-large~.icon,#documenter .docs-sidebar .control.has-icons-left form.docs-search>input.is-large~.icon,.control.has-icons-left .select.is-large~.icon,.control.has-icons-right .input.is-large~.icon,.control.has-icons-right #documenter .docs-sidebar form.docs-search>input.is-large~.icon,#documenter .docs-sidebar .control.has-icons-right form.docs-search>input.is-large~.icon,.control.has-icons-right .select.is-large~.icon{font-size:1.5rem}.control.has-icons-left .icon,.control.has-icons-right .icon{color:#dbdbdb;height:2.5em;pointer-events:none;position:absolute;top:0;width:2.5em;z-index:4}.control.has-icons-left .input,.control.has-icons-left #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar .control.has-icons-left form.docs-search>input,.control.has-icons-left .select select{padding-left:2.5em}.control.has-icons-left .icon.is-left{left:0}.control.has-icons-right .input,.control.has-icons-right #documenter .docs-sidebar form.docs-search>input,#documenter .docs-sidebar .control.has-icons-right form.docs-search>input,.control.has-icons-right .select select{padding-right:2.5em}.control.has-icons-right .icon.is-right{right:0}.control.is-loading::after{position:absolute !important;right:.625em;top:0.625em;z-index:4}.control.is-loading.is-small:after,#documenter .docs-sidebar form.docs-search>input.is-loading:after{font-size:.75rem}.control.is-loading.is-medium:after{font-size:1.25rem}.control.is-loading.is-large:after{font-size:1.5rem}.breadcrumb{font-size:1rem;white-space:nowrap}.breadcrumb a{align-items:center;color:#2e63b8;display:flex;justify-content:center;padding:0 .75em}.breadcrumb a:hover{color:#363636}.breadcrumb li{align-items:center;display:flex}.breadcrumb li:first-child a{padding-left:0}.breadcrumb li.is-active a{color:#222;cursor:default;pointer-events:none}.breadcrumb li+li::before{color:#b5b5b5;content:"\0002f"}.breadcrumb ul,.breadcrumb ol{align-items:flex-start;display:flex;flex-wrap:wrap;justify-content:flex-start}.breadcrumb .icon:first-child{margin-right:.5em}.breadcrumb .icon:last-child{margin-left:.5em}.breadcrumb.is-centered ol,.breadcrumb.is-centered ul{justify-content:center}.breadcrumb.is-right ol,.breadcrumb.is-right ul{justify-content:flex-end}.breadcrumb.is-small,#documenter .docs-sidebar form.docs-search>input.breadcrumb{font-size:.75rem}.breadcrumb.is-medium{font-size:1.25rem}.breadcrumb.is-large{font-size:1.5rem}.breadcrumb.has-arrow-separator li+li::before{content:"\02192"}.breadcrumb.has-bullet-separator li+li::before{content:"\02022"}.breadcrumb.has-dot-separator li+li::before{content:"\000b7"}.breadcrumb.has-succeeds-separator li+li::before{content:"\0227B"}.card{background-color:#fff;border-radius:.25rem;box-shadow:#bbb;color:#222;max-width:100%;position:relative}.card-footer:first-child,.card-content:first-child,.card-header:first-child{border-top-left-radius:.25rem;border-top-right-radius:.25rem}.card-footer:last-child,.card-content:last-child,.card-header:last-child{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}.card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);display:flex}.card-header-title{align-items:center;color:#222;display:flex;flex-grow:1;font-weight:700;padding:0.75rem 1rem}.card-header-title.is-centered{justify-content:center}.card-header-icon{-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;color:currentColor;font-family:inherit;font-size:1em;margin:0;padding:0;align-items:center;cursor:pointer;display:flex;justify-content:center;padding:0.75rem 1rem}.card-image{display:block;position:relative}.card-image:first-child img{border-top-left-radius:.25rem;border-top-right-radius:.25rem}.card-image:last-child img{border-bottom-left-radius:.25rem;border-bottom-right-radius:.25rem}.card-content{background-color:rgba(0,0,0,0);padding:1.5rem}.card-footer{background-color:rgba(0,0,0,0);border-top:1px solid #ededed;align-items:stretch;display:flex}.card-footer-item{align-items:center;display:flex;flex-basis:0;flex-grow:1;flex-shrink:0;justify-content:center;padding:.75rem}.card-footer-item:not(:last-child){border-right:1px solid #ededed}.card .media:not(:last-child){margin-bottom:1.5rem}.dropdown{display:inline-flex;position:relative;vertical-align:top}.dropdown.is-active .dropdown-menu,.dropdown.is-hoverable:hover .dropdown-menu{display:block}.dropdown.is-right .dropdown-menu{left:auto;right:0}.dropdown.is-up .dropdown-menu{bottom:100%;padding-bottom:4px;padding-top:initial;top:auto}.dropdown-menu{display:none;left:0;min-width:12rem;padding-top:4px;position:absolute;top:100%;z-index:20}.dropdown-content{background-color:#fff;border-radius:4px;box-shadow:#bbb;padding-bottom:.5rem;padding-top:.5rem}.dropdown-item{color:#222;display:block;font-size:0.875rem;line-height:1.5;padding:0.375rem 1rem;position:relative}a.dropdown-item,button.dropdown-item{padding-right:3rem;text-align:inherit;white-space:nowrap;width:100%}a.dropdown-item:hover,button.dropdown-item:hover{background-color:#f5f5f5;color:#0a0a0a}a.dropdown-item.is-active,button.dropdown-item.is-active{background-color:#2e63b8;color:#fff}.dropdown-divider{background-color:#ededed;border:none;display:block;height:1px;margin:0.5rem 0}.level{align-items:center;justify-content:space-between}.level code{border-radius:4px}.level img{display:inline-block;vertical-align:top}.level.is-mobile{display:flex}.level.is-mobile .level-left,.level.is-mobile .level-right{display:flex}.level.is-mobile .level-left+.level-right{margin-top:0}.level.is-mobile .level-item:not(:last-child){margin-bottom:0;margin-right:.75rem}.level.is-mobile .level-item:not(.is-narrow){flex-grow:1}@media screen and (min-width: 769px),print{.level{display:flex}.level>.level-item:not(.is-narrow){flex-grow:1}}.level-item{align-items:center;display:flex;flex-basis:auto;flex-grow:0;flex-shrink:0;justify-content:center}.level-item .title,.level-item .subtitle{margin-bottom:0}@media screen and (max-width: 768px){.level-item:not(:last-child){margin-bottom:.75rem}}.level-left,.level-right{flex-basis:auto;flex-grow:0;flex-shrink:0}.level-left .level-item.is-flexible,.level-right .level-item.is-flexible{flex-grow:1}@media screen and (min-width: 769px),print{.level-left .level-item:not(:last-child),.level-right .level-item:not(:last-child){margin-right:.75rem}}.level-left{align-items:center;justify-content:flex-start}@media screen and (max-width: 768px){.level-left+.level-right{margin-top:1.5rem}}@media screen and (min-width: 769px),print{.level-left{display:flex}}.level-right{align-items:center;justify-content:flex-end}@media screen and (min-width: 769px),print{.level-right{display:flex}}.media{align-items:flex-start;display:flex;text-align:inherit}.media .content:not(:last-child){margin-bottom:.75rem}.media .media{border-top:1px solid rgba(219,219,219,0.5);display:flex;padding-top:.75rem}.media .media .content:not(:last-child),.media .media .control:not(:last-child){margin-bottom:.5rem}.media .media .media{padding-top:.5rem}.media .media .media+.media{margin-top:.5rem}.media+.media{border-top:1px solid rgba(219,219,219,0.5);margin-top:1rem;padding-top:1rem}.media.is-large+.media{margin-top:1.5rem;padding-top:1.5rem}.media-left,.media-right{flex-basis:auto;flex-grow:0;flex-shrink:0}.media-left{margin-right:1rem}.media-right{margin-left:1rem}.media-content{flex-basis:auto;flex-grow:1;flex-shrink:1;text-align:inherit}@media screen and (max-width: 768px){.media-content{overflow-x:auto}}.menu{font-size:1rem}.menu.is-small,#documenter .docs-sidebar form.docs-search>input.menu{font-size:.75rem}.menu.is-medium{font-size:1.25rem}.menu.is-large{font-size:1.5rem}.menu-list{line-height:1.25}.menu-list a{border-radius:2px;color:#222;display:block;padding:0.5em 0.75em}.menu-list a:hover{background-color:#f5f5f5;color:#222}.menu-list a.is-active{background-color:#2e63b8;color:#fff}.menu-list li ul{border-left:1px solid #dbdbdb;margin:.75em;padding-left:.75em}.menu-label{color:#6b6b6b;font-size:.75em;letter-spacing:.1em;text-transform:uppercase}.menu-label:not(:first-child){margin-top:1em}.menu-label:not(:last-child){margin-bottom:1em}.message{background-color:#f5f5f5;border-radius:4px;font-size:1rem}.message strong{color:currentColor}.message a:not(.button):not(.tag):not(.dropdown-item){color:currentColor;text-decoration:underline}.message.is-small,#documenter .docs-sidebar form.docs-search>input.message{font-size:.75rem}.message.is-medium{font-size:1.25rem}.message.is-large{font-size:1.5rem}.message.is-white{background-color:#fff}.message.is-white .message-header{background-color:#fff;color:#0a0a0a}.message.is-white .message-body{border-color:#fff}.message.is-black{background-color:#fafafa}.message.is-black .message-header{background-color:#0a0a0a;color:#fff}.message.is-black .message-body{border-color:#0a0a0a}.message.is-light{background-color:#fafafa}.message.is-light .message-header{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.message.is-light .message-body{border-color:#f5f5f5}.message.is-dark,.content kbd.message{background-color:#fafafa}.message.is-dark .message-header,.content kbd.message .message-header{background-color:#363636;color:#fff}.message.is-dark .message-body,.content kbd.message .message-body{border-color:#363636}.message.is-primary,.docstring>section>a.message.docs-sourcelink{background-color:#eef8fc}.message.is-primary .message-header,.docstring>section>a.message.docs-sourcelink .message-header{background-color:#4eb5de;color:#fff}.message.is-primary .message-body,.docstring>section>a.message.docs-sourcelink .message-body{border-color:#4eb5de;color:#1a6d8e}.message.is-link{background-color:#eff3fb}.message.is-link .message-header{background-color:#2e63b8;color:#fff}.message.is-link .message-body{border-color:#2e63b8;color:#3169c4}.message.is-info{background-color:#eff2fb}.message.is-info .message-header{background-color:#3c5dcd;color:#fff}.message.is-info .message-body{border-color:#3c5dcd;color:#3253c3}.message.is-success{background-color:#effded}.message.is-success .message-header{background-color:#259a12;color:#fff}.message.is-success .message-body{border-color:#259a12;color:#2ec016}.message.is-warning{background-color:#fffbeb}.message.is-warning .message-header{background-color:#a98800;color:#fff}.message.is-warning .message-body{border-color:#a98800;color:#cca400}.message.is-danger{background-color:#fbefef}.message.is-danger .message-header{background-color:#cb3c33;color:#fff}.message.is-danger .message-body{border-color:#cb3c33;color:#c03930}.message-header{align-items:center;background-color:#222;border-radius:4px 4px 0 0;color:#fff;display:flex;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.75em 1em;position:relative}.message-header .delete{flex-grow:0;flex-shrink:0;margin-left:.75em}.message-header+.message-body{border-width:0;border-top-left-radius:0;border-top-right-radius:0}.message-body{border-color:#dbdbdb;border-radius:4px;border-style:solid;border-width:0 0 0 4px;color:#222;padding:1.25em 1.5em}.message-body code,.message-body pre{background-color:#fff}.message-body pre code{background-color:rgba(0,0,0,0)}.modal{align-items:center;display:none;flex-direction:column;justify-content:center;overflow:hidden;position:fixed;z-index:40}.modal.is-active{display:flex}.modal-background{background-color:rgba(10,10,10,0.86)}.modal-content,.modal-card{margin:0 20px;max-height:calc(100vh - 160px);overflow:auto;position:relative;width:100%}@media screen and (min-width: 769px){.modal-content,.modal-card{margin:0 auto;max-height:calc(100vh - 40px);width:640px}}.modal-close{background:none;height:40px;position:fixed;right:20px;top:20px;width:40px}.modal-card{display:flex;flex-direction:column;max-height:calc(100vh - 40px);overflow:hidden;-ms-overflow-y:visible}.modal-card-head,.modal-card-foot{align-items:center;background-color:#f5f5f5;display:flex;flex-shrink:0;justify-content:flex-start;padding:20px;position:relative}.modal-card-head{border-bottom:1px solid #dbdbdb;border-top-left-radius:6px;border-top-right-radius:6px}.modal-card-title{color:#222;flex-grow:1;flex-shrink:0;font-size:1.5rem;line-height:1}.modal-card-foot{border-bottom-left-radius:6px;border-bottom-right-radius:6px;border-top:1px solid #dbdbdb}.modal-card-foot .button:not(:last-child){margin-right:.5em}.modal-card-body{-webkit-overflow-scrolling:touch;background-color:#fff;flex-grow:1;flex-shrink:1;overflow:auto;padding:20px}.navbar{background-color:#fff;min-height:3.25rem;position:relative;z-index:30}.navbar.is-white{background-color:#fff;color:#0a0a0a}.navbar.is-white .navbar-brand>.navbar-item,.navbar.is-white .navbar-brand .navbar-link{color:#0a0a0a}.navbar.is-white .navbar-brand>a.navbar-item:focus,.navbar.is-white .navbar-brand>a.navbar-item:hover,.navbar.is-white .navbar-brand>a.navbar-item.is-active,.navbar.is-white .navbar-brand .navbar-link:focus,.navbar.is-white .navbar-brand .navbar-link:hover,.navbar.is-white .navbar-brand .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}.navbar.is-white .navbar-brand .navbar-link::after{border-color:#0a0a0a}.navbar.is-white .navbar-burger{color:#0a0a0a}@media screen and (min-width: 1056px){.navbar.is-white .navbar-start>.navbar-item,.navbar.is-white .navbar-start .navbar-link,.navbar.is-white .navbar-end>.navbar-item,.navbar.is-white .navbar-end .navbar-link{color:#0a0a0a}.navbar.is-white .navbar-start>a.navbar-item:focus,.navbar.is-white .navbar-start>a.navbar-item:hover,.navbar.is-white .navbar-start>a.navbar-item.is-active,.navbar.is-white .navbar-start .navbar-link:focus,.navbar.is-white .navbar-start .navbar-link:hover,.navbar.is-white .navbar-start .navbar-link.is-active,.navbar.is-white .navbar-end>a.navbar-item:focus,.navbar.is-white .navbar-end>a.navbar-item:hover,.navbar.is-white .navbar-end>a.navbar-item.is-active,.navbar.is-white .navbar-end .navbar-link:focus,.navbar.is-white .navbar-end .navbar-link:hover,.navbar.is-white .navbar-end .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}.navbar.is-white .navbar-start .navbar-link::after,.navbar.is-white .navbar-end .navbar-link::after{border-color:#0a0a0a}.navbar.is-white .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-white .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-white .navbar-item.has-dropdown.is-active .navbar-link{background-color:#f2f2f2;color:#0a0a0a}.navbar.is-white .navbar-dropdown a.navbar-item.is-active{background-color:#fff;color:#0a0a0a}}.navbar.is-black{background-color:#0a0a0a;color:#fff}.navbar.is-black .navbar-brand>.navbar-item,.navbar.is-black .navbar-brand .navbar-link{color:#fff}.navbar.is-black .navbar-brand>a.navbar-item:focus,.navbar.is-black .navbar-brand>a.navbar-item:hover,.navbar.is-black .navbar-brand>a.navbar-item.is-active,.navbar.is-black .navbar-brand .navbar-link:focus,.navbar.is-black .navbar-brand .navbar-link:hover,.navbar.is-black .navbar-brand .navbar-link.is-active{background-color:#000;color:#fff}.navbar.is-black .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-black .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-black .navbar-start>.navbar-item,.navbar.is-black .navbar-start .navbar-link,.navbar.is-black .navbar-end>.navbar-item,.navbar.is-black .navbar-end .navbar-link{color:#fff}.navbar.is-black .navbar-start>a.navbar-item:focus,.navbar.is-black .navbar-start>a.navbar-item:hover,.navbar.is-black .navbar-start>a.navbar-item.is-active,.navbar.is-black .navbar-start .navbar-link:focus,.navbar.is-black .navbar-start .navbar-link:hover,.navbar.is-black .navbar-start .navbar-link.is-active,.navbar.is-black .navbar-end>a.navbar-item:focus,.navbar.is-black .navbar-end>a.navbar-item:hover,.navbar.is-black .navbar-end>a.navbar-item.is-active,.navbar.is-black .navbar-end .navbar-link:focus,.navbar.is-black .navbar-end .navbar-link:hover,.navbar.is-black .navbar-end .navbar-link.is-active{background-color:#000;color:#fff}.navbar.is-black .navbar-start .navbar-link::after,.navbar.is-black .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-black .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-black .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-black .navbar-item.has-dropdown.is-active .navbar-link{background-color:#000;color:#fff}.navbar.is-black .navbar-dropdown a.navbar-item.is-active{background-color:#0a0a0a;color:#fff}}.navbar.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-brand>.navbar-item,.navbar.is-light .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-brand>a.navbar-item:focus,.navbar.is-light .navbar-brand>a.navbar-item:hover,.navbar.is-light .navbar-brand>a.navbar-item.is-active,.navbar.is-light .navbar-brand .navbar-link:focus,.navbar.is-light .navbar-brand .navbar-link:hover,.navbar.is-light .navbar-brand .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-burger{color:rgba(0,0,0,0.7)}@media screen and (min-width: 1056px){.navbar.is-light .navbar-start>.navbar-item,.navbar.is-light .navbar-start .navbar-link,.navbar.is-light .navbar-end>.navbar-item,.navbar.is-light .navbar-end .navbar-link{color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-start>a.navbar-item:focus,.navbar.is-light .navbar-start>a.navbar-item:hover,.navbar.is-light .navbar-start>a.navbar-item.is-active,.navbar.is-light .navbar-start .navbar-link:focus,.navbar.is-light .navbar-start .navbar-link:hover,.navbar.is-light .navbar-start .navbar-link.is-active,.navbar.is-light .navbar-end>a.navbar-item:focus,.navbar.is-light .navbar-end>a.navbar-item:hover,.navbar.is-light .navbar-end>a.navbar-item.is-active,.navbar.is-light .navbar-end .navbar-link:focus,.navbar.is-light .navbar-end .navbar-link:hover,.navbar.is-light .navbar-end .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-start .navbar-link::after,.navbar.is-light .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-light .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-light .navbar-item.has-dropdown.is-active .navbar-link{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}.navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}}.navbar.is-dark,.content kbd.navbar{background-color:#363636;color:#fff}.navbar.is-dark .navbar-brand>.navbar-item,.content kbd.navbar .navbar-brand>.navbar-item,.navbar.is-dark .navbar-brand .navbar-link,.content kbd.navbar .navbar-brand .navbar-link{color:#fff}.navbar.is-dark .navbar-brand>a.navbar-item:focus,.content kbd.navbar .navbar-brand>a.navbar-item:focus,.navbar.is-dark .navbar-brand>a.navbar-item:hover,.content kbd.navbar .navbar-brand>a.navbar-item:hover,.navbar.is-dark .navbar-brand>a.navbar-item.is-active,.content kbd.navbar .navbar-brand>a.navbar-item.is-active,.navbar.is-dark .navbar-brand .navbar-link:focus,.content kbd.navbar .navbar-brand .navbar-link:focus,.navbar.is-dark .navbar-brand .navbar-link:hover,.content kbd.navbar .navbar-brand .navbar-link:hover,.navbar.is-dark .navbar-brand .navbar-link.is-active,.content kbd.navbar .navbar-brand .navbar-link.is-active{background-color:#292929;color:#fff}.navbar.is-dark .navbar-brand .navbar-link::after,.content kbd.navbar .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-dark .navbar-burger,.content kbd.navbar .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-dark .navbar-start>.navbar-item,.content kbd.navbar .navbar-start>.navbar-item,.navbar.is-dark .navbar-start .navbar-link,.content kbd.navbar .navbar-start .navbar-link,.navbar.is-dark .navbar-end>.navbar-item,.content kbd.navbar .navbar-end>.navbar-item,.navbar.is-dark .navbar-end .navbar-link,.content kbd.navbar .navbar-end .navbar-link{color:#fff}.navbar.is-dark .navbar-start>a.navbar-item:focus,.content kbd.navbar .navbar-start>a.navbar-item:focus,.navbar.is-dark .navbar-start>a.navbar-item:hover,.content kbd.navbar .navbar-start>a.navbar-item:hover,.navbar.is-dark .navbar-start>a.navbar-item.is-active,.content kbd.navbar .navbar-start>a.navbar-item.is-active,.navbar.is-dark .navbar-start .navbar-link:focus,.content kbd.navbar .navbar-start .navbar-link:focus,.navbar.is-dark .navbar-start .navbar-link:hover,.content kbd.navbar .navbar-start .navbar-link:hover,.navbar.is-dark .navbar-start .navbar-link.is-active,.content kbd.navbar .navbar-start .navbar-link.is-active,.navbar.is-dark .navbar-end>a.navbar-item:focus,.content kbd.navbar .navbar-end>a.navbar-item:focus,.navbar.is-dark .navbar-end>a.navbar-item:hover,.content kbd.navbar .navbar-end>a.navbar-item:hover,.navbar.is-dark .navbar-end>a.navbar-item.is-active,.content kbd.navbar .navbar-end>a.navbar-item.is-active,.navbar.is-dark .navbar-end .navbar-link:focus,.content kbd.navbar .navbar-end .navbar-link:focus,.navbar.is-dark .navbar-end .navbar-link:hover,.content kbd.navbar .navbar-end .navbar-link:hover,.navbar.is-dark .navbar-end .navbar-link.is-active,.content kbd.navbar .navbar-end .navbar-link.is-active{background-color:#292929;color:#fff}.navbar.is-dark .navbar-start .navbar-link::after,.content kbd.navbar .navbar-start .navbar-link::after,.navbar.is-dark .navbar-end .navbar-link::after,.content kbd.navbar .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-dark .navbar-item.has-dropdown:focus .navbar-link,.content kbd.navbar .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-dark .navbar-item.has-dropdown:hover .navbar-link,.content kbd.navbar .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-dark .navbar-item.has-dropdown.is-active .navbar-link,.content kbd.navbar .navbar-item.has-dropdown.is-active .navbar-link{background-color:#292929;color:#fff}.navbar.is-dark .navbar-dropdown a.navbar-item.is-active,.content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#363636;color:#fff}}.navbar.is-primary,.docstring>section>a.navbar.docs-sourcelink{background-color:#4eb5de;color:#fff}.navbar.is-primary .navbar-brand>.navbar-item,.docstring>section>a.navbar.docs-sourcelink .navbar-brand>.navbar-item,.navbar.is-primary .navbar-brand .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link{color:#fff}.navbar.is-primary .navbar-brand>a.navbar-item:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:focus,.navbar.is-primary .navbar-brand>a.navbar-item:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item:hover,.navbar.is-primary .navbar-brand>a.navbar-item.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-brand>a.navbar-item.is-active,.navbar.is-primary .navbar-brand .navbar-link:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:focus,.navbar.is-primary .navbar-brand .navbar-link:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link:hover,.navbar.is-primary .navbar-brand .navbar-link.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link.is-active{background-color:#39acda;color:#fff}.navbar.is-primary .navbar-brand .navbar-link::after,.docstring>section>a.navbar.docs-sourcelink .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-primary .navbar-burger,.docstring>section>a.navbar.docs-sourcelink .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-primary .navbar-start>.navbar-item,.docstring>section>a.navbar.docs-sourcelink .navbar-start>.navbar-item,.navbar.is-primary .navbar-start .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link,.navbar.is-primary .navbar-end>.navbar-item,.docstring>section>a.navbar.docs-sourcelink .navbar-end>.navbar-item,.navbar.is-primary .navbar-end .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link{color:#fff}.navbar.is-primary .navbar-start>a.navbar-item:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:focus,.navbar.is-primary .navbar-start>a.navbar-item:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item:hover,.navbar.is-primary .navbar-start>a.navbar-item.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-start>a.navbar-item.is-active,.navbar.is-primary .navbar-start .navbar-link:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:focus,.navbar.is-primary .navbar-start .navbar-link:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link:hover,.navbar.is-primary .navbar-start .navbar-link.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link.is-active,.navbar.is-primary .navbar-end>a.navbar-item:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:focus,.navbar.is-primary .navbar-end>a.navbar-item:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item:hover,.navbar.is-primary .navbar-end>a.navbar-item.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-end>a.navbar-item.is-active,.navbar.is-primary .navbar-end .navbar-link:focus,.docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:focus,.navbar.is-primary .navbar-end .navbar-link:hover,.docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link:hover,.navbar.is-primary .navbar-end .navbar-link.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link.is-active{background-color:#39acda;color:#fff}.navbar.is-primary .navbar-start .navbar-link::after,.docstring>section>a.navbar.docs-sourcelink .navbar-start .navbar-link::after,.navbar.is-primary .navbar-end .navbar-link::after,.docstring>section>a.navbar.docs-sourcelink .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-primary .navbar-item.has-dropdown:focus .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-primary .navbar-item.has-dropdown:hover .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-primary .navbar-item.has-dropdown.is-active .navbar-link,.docstring>section>a.navbar.docs-sourcelink .navbar-item.has-dropdown.is-active .navbar-link{background-color:#39acda;color:#fff}.navbar.is-primary .navbar-dropdown a.navbar-item.is-active,.docstring>section>a.navbar.docs-sourcelink .navbar-dropdown a.navbar-item.is-active{background-color:#4eb5de;color:#fff}}.navbar.is-link{background-color:#2e63b8;color:#fff}.navbar.is-link .navbar-brand>.navbar-item,.navbar.is-link .navbar-brand .navbar-link{color:#fff}.navbar.is-link .navbar-brand>a.navbar-item:focus,.navbar.is-link .navbar-brand>a.navbar-item:hover,.navbar.is-link .navbar-brand>a.navbar-item.is-active,.navbar.is-link .navbar-brand .navbar-link:focus,.navbar.is-link .navbar-brand .navbar-link:hover,.navbar.is-link .navbar-brand .navbar-link.is-active{background-color:#2958a4;color:#fff}.navbar.is-link .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-link .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-link .navbar-start>.navbar-item,.navbar.is-link .navbar-start .navbar-link,.navbar.is-link .navbar-end>.navbar-item,.navbar.is-link .navbar-end .navbar-link{color:#fff}.navbar.is-link .navbar-start>a.navbar-item:focus,.navbar.is-link .navbar-start>a.navbar-item:hover,.navbar.is-link .navbar-start>a.navbar-item.is-active,.navbar.is-link .navbar-start .navbar-link:focus,.navbar.is-link .navbar-start .navbar-link:hover,.navbar.is-link .navbar-start .navbar-link.is-active,.navbar.is-link .navbar-end>a.navbar-item:focus,.navbar.is-link .navbar-end>a.navbar-item:hover,.navbar.is-link .navbar-end>a.navbar-item.is-active,.navbar.is-link .navbar-end .navbar-link:focus,.navbar.is-link .navbar-end .navbar-link:hover,.navbar.is-link .navbar-end .navbar-link.is-active{background-color:#2958a4;color:#fff}.navbar.is-link .navbar-start .navbar-link::after,.navbar.is-link .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-link .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-link .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-link .navbar-item.has-dropdown.is-active .navbar-link{background-color:#2958a4;color:#fff}.navbar.is-link .navbar-dropdown a.navbar-item.is-active{background-color:#2e63b8;color:#fff}}.navbar.is-info{background-color:#3c5dcd;color:#fff}.navbar.is-info .navbar-brand>.navbar-item,.navbar.is-info .navbar-brand .navbar-link{color:#fff}.navbar.is-info .navbar-brand>a.navbar-item:focus,.navbar.is-info .navbar-brand>a.navbar-item:hover,.navbar.is-info .navbar-brand>a.navbar-item.is-active,.navbar.is-info .navbar-brand .navbar-link:focus,.navbar.is-info .navbar-brand .navbar-link:hover,.navbar.is-info .navbar-brand .navbar-link.is-active{background-color:#3151bf;color:#fff}.navbar.is-info .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-info .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-info .navbar-start>.navbar-item,.navbar.is-info .navbar-start .navbar-link,.navbar.is-info .navbar-end>.navbar-item,.navbar.is-info .navbar-end .navbar-link{color:#fff}.navbar.is-info .navbar-start>a.navbar-item:focus,.navbar.is-info .navbar-start>a.navbar-item:hover,.navbar.is-info .navbar-start>a.navbar-item.is-active,.navbar.is-info .navbar-start .navbar-link:focus,.navbar.is-info .navbar-start .navbar-link:hover,.navbar.is-info .navbar-start .navbar-link.is-active,.navbar.is-info .navbar-end>a.navbar-item:focus,.navbar.is-info .navbar-end>a.navbar-item:hover,.navbar.is-info .navbar-end>a.navbar-item.is-active,.navbar.is-info .navbar-end .navbar-link:focus,.navbar.is-info .navbar-end .navbar-link:hover,.navbar.is-info .navbar-end .navbar-link.is-active{background-color:#3151bf;color:#fff}.navbar.is-info .navbar-start .navbar-link::after,.navbar.is-info .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-info .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-info .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-info .navbar-item.has-dropdown.is-active .navbar-link{background-color:#3151bf;color:#fff}.navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#3c5dcd;color:#fff}}.navbar.is-success{background-color:#259a12;color:#fff}.navbar.is-success .navbar-brand>.navbar-item,.navbar.is-success .navbar-brand .navbar-link{color:#fff}.navbar.is-success .navbar-brand>a.navbar-item:focus,.navbar.is-success .navbar-brand>a.navbar-item:hover,.navbar.is-success .navbar-brand>a.navbar-item.is-active,.navbar.is-success .navbar-brand .navbar-link:focus,.navbar.is-success .navbar-brand .navbar-link:hover,.navbar.is-success .navbar-brand .navbar-link.is-active{background-color:#20830f;color:#fff}.navbar.is-success .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-success .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-success .navbar-start>.navbar-item,.navbar.is-success .navbar-start .navbar-link,.navbar.is-success .navbar-end>.navbar-item,.navbar.is-success .navbar-end .navbar-link{color:#fff}.navbar.is-success .navbar-start>a.navbar-item:focus,.navbar.is-success .navbar-start>a.navbar-item:hover,.navbar.is-success .navbar-start>a.navbar-item.is-active,.navbar.is-success .navbar-start .navbar-link:focus,.navbar.is-success .navbar-start .navbar-link:hover,.navbar.is-success .navbar-start .navbar-link.is-active,.navbar.is-success .navbar-end>a.navbar-item:focus,.navbar.is-success .navbar-end>a.navbar-item:hover,.navbar.is-success .navbar-end>a.navbar-item.is-active,.navbar.is-success .navbar-end .navbar-link:focus,.navbar.is-success .navbar-end .navbar-link:hover,.navbar.is-success .navbar-end .navbar-link.is-active{background-color:#20830f;color:#fff}.navbar.is-success .navbar-start .navbar-link::after,.navbar.is-success .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-success .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-success .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-success .navbar-item.has-dropdown.is-active .navbar-link{background-color:#20830f;color:#fff}.navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#259a12;color:#fff}}.navbar.is-warning{background-color:#a98800;color:#fff}.navbar.is-warning .navbar-brand>.navbar-item,.navbar.is-warning .navbar-brand .navbar-link{color:#fff}.navbar.is-warning .navbar-brand>a.navbar-item:focus,.navbar.is-warning .navbar-brand>a.navbar-item:hover,.navbar.is-warning .navbar-brand>a.navbar-item.is-active,.navbar.is-warning .navbar-brand .navbar-link:focus,.navbar.is-warning .navbar-brand .navbar-link:hover,.navbar.is-warning .navbar-brand .navbar-link.is-active{background-color:#8f7300;color:#fff}.navbar.is-warning .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-warning .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-warning .navbar-start>.navbar-item,.navbar.is-warning .navbar-start .navbar-link,.navbar.is-warning .navbar-end>.navbar-item,.navbar.is-warning .navbar-end .navbar-link{color:#fff}.navbar.is-warning .navbar-start>a.navbar-item:focus,.navbar.is-warning .navbar-start>a.navbar-item:hover,.navbar.is-warning .navbar-start>a.navbar-item.is-active,.navbar.is-warning .navbar-start .navbar-link:focus,.navbar.is-warning .navbar-start .navbar-link:hover,.navbar.is-warning .navbar-start .navbar-link.is-active,.navbar.is-warning .navbar-end>a.navbar-item:focus,.navbar.is-warning .navbar-end>a.navbar-item:hover,.navbar.is-warning .navbar-end>a.navbar-item.is-active,.navbar.is-warning .navbar-end .navbar-link:focus,.navbar.is-warning .navbar-end .navbar-link:hover,.navbar.is-warning .navbar-end .navbar-link.is-active{background-color:#8f7300;color:#fff}.navbar.is-warning .navbar-start .navbar-link::after,.navbar.is-warning .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-warning .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-warning .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-warning .navbar-item.has-dropdown.is-active .navbar-link{background-color:#8f7300;color:#fff}.navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#a98800;color:#fff}}.navbar.is-danger{background-color:#cb3c33;color:#fff}.navbar.is-danger .navbar-brand>.navbar-item,.navbar.is-danger .navbar-brand .navbar-link{color:#fff}.navbar.is-danger .navbar-brand>a.navbar-item:focus,.navbar.is-danger .navbar-brand>a.navbar-item:hover,.navbar.is-danger .navbar-brand>a.navbar-item.is-active,.navbar.is-danger .navbar-brand .navbar-link:focus,.navbar.is-danger .navbar-brand .navbar-link:hover,.navbar.is-danger .navbar-brand .navbar-link.is-active{background-color:#b7362e;color:#fff}.navbar.is-danger .navbar-brand .navbar-link::after{border-color:#fff}.navbar.is-danger .navbar-burger{color:#fff}@media screen and (min-width: 1056px){.navbar.is-danger .navbar-start>.navbar-item,.navbar.is-danger .navbar-start .navbar-link,.navbar.is-danger .navbar-end>.navbar-item,.navbar.is-danger .navbar-end .navbar-link{color:#fff}.navbar.is-danger .navbar-start>a.navbar-item:focus,.navbar.is-danger .navbar-start>a.navbar-item:hover,.navbar.is-danger .navbar-start>a.navbar-item.is-active,.navbar.is-danger .navbar-start .navbar-link:focus,.navbar.is-danger .navbar-start .navbar-link:hover,.navbar.is-danger .navbar-start .navbar-link.is-active,.navbar.is-danger .navbar-end>a.navbar-item:focus,.navbar.is-danger .navbar-end>a.navbar-item:hover,.navbar.is-danger .navbar-end>a.navbar-item.is-active,.navbar.is-danger .navbar-end .navbar-link:focus,.navbar.is-danger .navbar-end .navbar-link:hover,.navbar.is-danger .navbar-end .navbar-link.is-active{background-color:#b7362e;color:#fff}.navbar.is-danger .navbar-start .navbar-link::after,.navbar.is-danger .navbar-end .navbar-link::after{border-color:#fff}.navbar.is-danger .navbar-item.has-dropdown:focus .navbar-link,.navbar.is-danger .navbar-item.has-dropdown:hover .navbar-link,.navbar.is-danger .navbar-item.has-dropdown.is-active .navbar-link{background-color:#b7362e;color:#fff}.navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#cb3c33;color:#fff}}.navbar>.container{align-items:stretch;display:flex;min-height:3.25rem;width:100%}.navbar.has-shadow{box-shadow:0 2px 0 0 #f5f5f5}.navbar.is-fixed-bottom,.navbar.is-fixed-top{left:0;position:fixed;right:0;z-index:30}.navbar.is-fixed-bottom{bottom:0}.navbar.is-fixed-bottom.has-shadow{box-shadow:0 -2px 0 0 #f5f5f5}.navbar.is-fixed-top{top:0}html.has-navbar-fixed-top,body.has-navbar-fixed-top{padding-top:3.25rem}html.has-navbar-fixed-bottom,body.has-navbar-fixed-bottom{padding-bottom:3.25rem}.navbar-brand,.navbar-tabs{align-items:stretch;display:flex;flex-shrink:0;min-height:3.25rem}.navbar-brand a.navbar-item:focus,.navbar-brand a.navbar-item:hover{background-color:transparent}.navbar-tabs{-webkit-overflow-scrolling:touch;max-width:100vw;overflow-x:auto;overflow-y:hidden}.navbar-burger{color:#222;-moz-appearance:none;-webkit-appearance:none;appearance:none;background:none;border:none;cursor:pointer;display:block;height:3.25rem;position:relative;width:3.25rem;margin-left:auto}.navbar-burger span{background-color:currentColor;display:block;height:1px;left:calc(50% - 8px);position:absolute;transform-origin:center;transition-duration:86ms;transition-property:background-color, opacity, transform;transition-timing-function:ease-out;width:16px}.navbar-burger span:nth-child(1){top:calc(50% - 6px)}.navbar-burger span:nth-child(2){top:calc(50% - 1px)}.navbar-burger span:nth-child(3){top:calc(50% + 4px)}.navbar-burger:hover{background-color:rgba(0,0,0,0.05)}.navbar-burger.is-active span:nth-child(1){transform:translateY(5px) rotate(45deg)}.navbar-burger.is-active span:nth-child(2){opacity:0}.navbar-burger.is-active span:nth-child(3){transform:translateY(-5px) rotate(-45deg)}.navbar-menu{display:none}.navbar-item,.navbar-link{color:#222;display:block;line-height:1.5;padding:0.5rem 0.75rem;position:relative}.navbar-item .icon:only-child,.navbar-link .icon:only-child{margin-left:-0.25rem;margin-right:-0.25rem}a.navbar-item,.navbar-link{cursor:pointer}a.navbar-item:focus,a.navbar-item:focus-within,a.navbar-item:hover,a.navbar-item.is-active,.navbar-link:focus,.navbar-link:focus-within,.navbar-link:hover,.navbar-link.is-active{background-color:#fafafa;color:#2e63b8}.navbar-item{flex-grow:0;flex-shrink:0}.navbar-item img{max-height:1.75rem}.navbar-item.has-dropdown{padding:0}.navbar-item.is-expanded{flex-grow:1;flex-shrink:1}.navbar-item.is-tab{border-bottom:1px solid transparent;min-height:3.25rem;padding-bottom:calc(0.5rem - 1px)}.navbar-item.is-tab:focus,.navbar-item.is-tab:hover{background-color:rgba(0,0,0,0);border-bottom-color:#2e63b8}.navbar-item.is-tab.is-active{background-color:rgba(0,0,0,0);border-bottom-color:#2e63b8;border-bottom-style:solid;border-bottom-width:3px;color:#2e63b8;padding-bottom:calc(0.5rem - 3px)}.navbar-content{flex-grow:1;flex-shrink:1}.navbar-link:not(.is-arrowless){padding-right:2.5em}.navbar-link:not(.is-arrowless)::after{border-color:#2e63b8;margin-top:-0.375em;right:1.125em}.navbar-dropdown{font-size:0.875rem;padding-bottom:0.5rem;padding-top:0.5rem}.navbar-dropdown .navbar-item{padding-left:1.5rem;padding-right:1.5rem}.navbar-divider{background-color:#f5f5f5;border:none;display:none;height:2px;margin:0.5rem 0}@media screen and (max-width: 1055px){.navbar>.container{display:block}.navbar-brand .navbar-item,.navbar-tabs .navbar-item{align-items:center;display:flex}.navbar-link::after{display:none}.navbar-menu{background-color:#fff;box-shadow:0 8px 16px rgba(10,10,10,0.1);padding:0.5rem 0}.navbar-menu.is-active{display:block}.navbar.is-fixed-bottom-touch,.navbar.is-fixed-top-touch{left:0;position:fixed;right:0;z-index:30}.navbar.is-fixed-bottom-touch{bottom:0}.navbar.is-fixed-bottom-touch.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}.navbar.is-fixed-top-touch{top:0}.navbar.is-fixed-top .navbar-menu,.navbar.is-fixed-top-touch .navbar-menu{-webkit-overflow-scrolling:touch;max-height:calc(100vh - 3.25rem);overflow:auto}html.has-navbar-fixed-top-touch,body.has-navbar-fixed-top-touch{padding-top:3.25rem}html.has-navbar-fixed-bottom-touch,body.has-navbar-fixed-bottom-touch{padding-bottom:3.25rem}}@media screen and (min-width: 1056px){.navbar,.navbar-menu,.navbar-start,.navbar-end{align-items:stretch;display:flex}.navbar{min-height:3.25rem}.navbar.is-spaced{padding:1rem 2rem}.navbar.is-spaced .navbar-start,.navbar.is-spaced .navbar-end{align-items:center}.navbar.is-spaced a.navbar-item,.navbar.is-spaced .navbar-link{border-radius:4px}.navbar.is-transparent a.navbar-item:focus,.navbar.is-transparent a.navbar-item:hover,.navbar.is-transparent a.navbar-item.is-active,.navbar.is-transparent .navbar-link:focus,.navbar.is-transparent .navbar-link:hover,.navbar.is-transparent .navbar-link.is-active{background-color:transparent !important}.navbar.is-transparent .navbar-item.has-dropdown.is-active .navbar-link,.navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus .navbar-link,.navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:focus-within .navbar-link,.navbar.is-transparent .navbar-item.has-dropdown.is-hoverable:hover .navbar-link{background-color:transparent !important}.navbar.is-transparent .navbar-dropdown a.navbar-item:focus,.navbar.is-transparent .navbar-dropdown a.navbar-item:hover{background-color:#f5f5f5;color:#0a0a0a}.navbar.is-transparent .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:#2e63b8}.navbar-burger{display:none}.navbar-item,.navbar-link{align-items:center;display:flex}.navbar-item.has-dropdown{align-items:stretch}.navbar-item.has-dropdown-up .navbar-link::after{transform:rotate(135deg) translate(0.25em, -0.25em)}.navbar-item.has-dropdown-up .navbar-dropdown{border-bottom:2px solid #dbdbdb;border-radius:6px 6px 0 0;border-top:none;bottom:100%;box-shadow:0 -8px 8px rgba(10,10,10,0.1);top:auto}.navbar-item.is-active .navbar-dropdown,.navbar-item.is-hoverable:focus .navbar-dropdown,.navbar-item.is-hoverable:focus-within .navbar-dropdown,.navbar-item.is-hoverable:hover .navbar-dropdown{display:block}.navbar.is-spaced .navbar-item.is-active .navbar-dropdown,.navbar-item.is-active .navbar-dropdown.is-boxed,.navbar.is-spaced .navbar-item.is-hoverable:focus .navbar-dropdown,.navbar-item.is-hoverable:focus .navbar-dropdown.is-boxed,.navbar.is-spaced .navbar-item.is-hoverable:focus-within .navbar-dropdown,.navbar-item.is-hoverable:focus-within .navbar-dropdown.is-boxed,.navbar.is-spaced .navbar-item.is-hoverable:hover .navbar-dropdown,.navbar-item.is-hoverable:hover .navbar-dropdown.is-boxed{opacity:1;pointer-events:auto;transform:translateY(0)}.navbar-menu{flex-grow:1;flex-shrink:0}.navbar-start{justify-content:flex-start;margin-right:auto}.navbar-end{justify-content:flex-end;margin-left:auto}.navbar-dropdown{background-color:#fff;border-bottom-left-radius:6px;border-bottom-right-radius:6px;border-top:2px solid #dbdbdb;box-shadow:0 8px 8px rgba(10,10,10,0.1);display:none;font-size:0.875rem;left:0;min-width:100%;position:absolute;top:100%;z-index:20}.navbar-dropdown .navbar-item{padding:0.375rem 1rem;white-space:nowrap}.navbar-dropdown a.navbar-item{padding-right:3rem}.navbar-dropdown a.navbar-item:focus,.navbar-dropdown a.navbar-item:hover{background-color:#f5f5f5;color:#0a0a0a}.navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:#2e63b8}.navbar.is-spaced .navbar-dropdown,.navbar-dropdown.is-boxed{border-radius:6px;border-top:none;box-shadow:0 8px 8px rgba(10,10,10,0.1), 0 0 0 1px rgba(10,10,10,0.1);display:block;opacity:0;pointer-events:none;top:calc(100% + (-4px));transform:translateY(-5px);transition-duration:86ms;transition-property:opacity, transform}.navbar-dropdown.is-right{left:auto;right:0}.navbar-divider{display:block}.navbar>.container .navbar-brand,.container>.navbar .navbar-brand{margin-left:-.75rem}.navbar>.container .navbar-menu,.container>.navbar .navbar-menu{margin-right:-.75rem}.navbar.is-fixed-bottom-desktop,.navbar.is-fixed-top-desktop{left:0;position:fixed;right:0;z-index:30}.navbar.is-fixed-bottom-desktop{bottom:0}.navbar.is-fixed-bottom-desktop.has-shadow{box-shadow:0 -2px 3px rgba(10,10,10,0.1)}.navbar.is-fixed-top-desktop{top:0}html.has-navbar-fixed-top-desktop,body.has-navbar-fixed-top-desktop{padding-top:3.25rem}html.has-navbar-fixed-bottom-desktop,body.has-navbar-fixed-bottom-desktop{padding-bottom:3.25rem}html.has-spaced-navbar-fixed-top,body.has-spaced-navbar-fixed-top{padding-top:5.25rem}html.has-spaced-navbar-fixed-bottom,body.has-spaced-navbar-fixed-bottom{padding-bottom:5.25rem}a.navbar-item.is-active,.navbar-link.is-active{color:#0a0a0a}a.navbar-item.is-active:not(:focus):not(:hover),.navbar-link.is-active:not(:focus):not(:hover){background-color:rgba(0,0,0,0)}.navbar-item.has-dropdown:focus .navbar-link,.navbar-item.has-dropdown:hover .navbar-link,.navbar-item.has-dropdown.is-active .navbar-link{background-color:#fafafa}}.hero.is-fullheight-with-navbar{min-height:calc(100vh - 3.25rem)}.pagination{font-size:1rem;margin:-.25rem}.pagination.is-small,#documenter .docs-sidebar form.docs-search>input.pagination{font-size:.75rem}.pagination.is-medium{font-size:1.25rem}.pagination.is-large{font-size:1.5rem}.pagination.is-rounded .pagination-previous,#documenter .docs-sidebar form.docs-search>input.pagination .pagination-previous,.pagination.is-rounded .pagination-next,#documenter .docs-sidebar form.docs-search>input.pagination .pagination-next{padding-left:1em;padding-right:1em;border-radius:9999px}.pagination.is-rounded .pagination-link,#documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:9999px}.pagination,.pagination-list{align-items:center;display:flex;justify-content:center;text-align:center}.pagination-previous,.pagination-next,.pagination-link,.pagination-ellipsis{font-size:1em;justify-content:center;margin:.25rem;padding-left:.5em;padding-right:.5em;text-align:center}.pagination-previous,.pagination-next,.pagination-link{border-color:#dbdbdb;color:#222;min-width:2.5em}.pagination-previous:hover,.pagination-next:hover,.pagination-link:hover{border-color:#b5b5b5;color:#363636}.pagination-previous:focus,.pagination-next:focus,.pagination-link:focus{border-color:#3c5dcd}.pagination-previous:active,.pagination-next:active,.pagination-link:active{box-shadow:inset 0 1px 2px rgba(10,10,10,0.2)}.pagination-previous[disabled],.pagination-previous.is-disabled,.pagination-next[disabled],.pagination-next.is-disabled,.pagination-link[disabled],.pagination-link.is-disabled{background-color:#dbdbdb;border-color:#dbdbdb;box-shadow:none;color:#6b6b6b;opacity:0.5}.pagination-previous,.pagination-next{padding-left:.75em;padding-right:.75em;white-space:nowrap}.pagination-link.is-current{background-color:#2e63b8;border-color:#2e63b8;color:#fff}.pagination-ellipsis{color:#b5b5b5;pointer-events:none}.pagination-list{flex-wrap:wrap}.pagination-list li{list-style:none}@media screen and (max-width: 768px){.pagination{flex-wrap:wrap}.pagination-previous,.pagination-next{flex-grow:1;flex-shrink:1}.pagination-list li{flex-grow:1;flex-shrink:1}}@media screen and (min-width: 769px),print{.pagination-list{flex-grow:1;flex-shrink:1;justify-content:flex-start;order:1}.pagination-previous,.pagination-next,.pagination-link,.pagination-ellipsis{margin-bottom:0;margin-top:0}.pagination-previous{order:2}.pagination-next{order:3}.pagination{justify-content:space-between;margin-bottom:0;margin-top:0}.pagination.is-centered .pagination-previous{order:1}.pagination.is-centered .pagination-list{justify-content:center;order:2}.pagination.is-centered .pagination-next{order:3}.pagination.is-right .pagination-previous{order:1}.pagination.is-right .pagination-next{order:2}.pagination.is-right .pagination-list{justify-content:flex-end;order:3}}.panel{border-radius:6px;box-shadow:#bbb;font-size:1rem}.panel:not(:last-child){margin-bottom:1.5rem}.panel.is-white .panel-heading{background-color:#fff;color:#0a0a0a}.panel.is-white .panel-tabs a.is-active{border-bottom-color:#fff}.panel.is-white .panel-block.is-active .panel-icon{color:#fff}.panel.is-black .panel-heading{background-color:#0a0a0a;color:#fff}.panel.is-black .panel-tabs a.is-active{border-bottom-color:#0a0a0a}.panel.is-black .panel-block.is-active .panel-icon{color:#0a0a0a}.panel.is-light .panel-heading{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.panel.is-light .panel-tabs a.is-active{border-bottom-color:#f5f5f5}.panel.is-light .panel-block.is-active .panel-icon{color:#f5f5f5}.panel.is-dark .panel-heading,.content kbd.panel .panel-heading{background-color:#363636;color:#fff}.panel.is-dark .panel-tabs a.is-active,.content kbd.panel .panel-tabs a.is-active{border-bottom-color:#363636}.panel.is-dark .panel-block.is-active .panel-icon,.content kbd.panel .panel-block.is-active .panel-icon{color:#363636}.panel.is-primary .panel-heading,.docstring>section>a.panel.docs-sourcelink .panel-heading{background-color:#4eb5de;color:#fff}.panel.is-primary .panel-tabs a.is-active,.docstring>section>a.panel.docs-sourcelink .panel-tabs a.is-active{border-bottom-color:#4eb5de}.panel.is-primary .panel-block.is-active .panel-icon,.docstring>section>a.panel.docs-sourcelink .panel-block.is-active .panel-icon{color:#4eb5de}.panel.is-link .panel-heading{background-color:#2e63b8;color:#fff}.panel.is-link .panel-tabs a.is-active{border-bottom-color:#2e63b8}.panel.is-link .panel-block.is-active .panel-icon{color:#2e63b8}.panel.is-info .panel-heading{background-color:#3c5dcd;color:#fff}.panel.is-info .panel-tabs a.is-active{border-bottom-color:#3c5dcd}.panel.is-info .panel-block.is-active .panel-icon{color:#3c5dcd}.panel.is-success .panel-heading{background-color:#259a12;color:#fff}.panel.is-success .panel-tabs a.is-active{border-bottom-color:#259a12}.panel.is-success .panel-block.is-active .panel-icon{color:#259a12}.panel.is-warning .panel-heading{background-color:#a98800;color:#fff}.panel.is-warning .panel-tabs a.is-active{border-bottom-color:#a98800}.panel.is-warning .panel-block.is-active .panel-icon{color:#a98800}.panel.is-danger .panel-heading{background-color:#cb3c33;color:#fff}.panel.is-danger .panel-tabs a.is-active{border-bottom-color:#cb3c33}.panel.is-danger .panel-block.is-active .panel-icon{color:#cb3c33}.panel-tabs:not(:last-child),.panel-block:not(:last-child){border-bottom:1px solid #ededed}.panel-heading{background-color:#ededed;border-radius:6px 6px 0 0;color:#222;font-size:1.25em;font-weight:700;line-height:1.25;padding:0.75em 1em}.panel-tabs{align-items:flex-end;display:flex;font-size:.875em;justify-content:center}.panel-tabs a{border-bottom:1px solid #dbdbdb;margin-bottom:-1px;padding:0.5em}.panel-tabs a.is-active{border-bottom-color:#4a4a4a;color:#363636}.panel-list a{color:#222}.panel-list a:hover{color:#2e63b8}.panel-block{align-items:center;color:#222;display:flex;justify-content:flex-start;padding:0.5em 0.75em}.panel-block input[type="checkbox"]{margin-right:.75em}.panel-block>.control{flex-grow:1;flex-shrink:1;width:100%}.panel-block.is-wrapped{flex-wrap:wrap}.panel-block.is-active{border-left-color:#2e63b8;color:#363636}.panel-block.is-active .panel-icon{color:#2e63b8}.panel-block:last-child{border-bottom-left-radius:6px;border-bottom-right-radius:6px}a.panel-block,label.panel-block{cursor:pointer}a.panel-block:hover,label.panel-block:hover{background-color:#f5f5f5}.panel-icon{display:inline-block;font-size:14px;height:1em;line-height:1em;text-align:center;vertical-align:top;width:1em;color:#6b6b6b;margin-right:.75em}.panel-icon .fa{font-size:inherit;line-height:inherit}.tabs{-webkit-overflow-scrolling:touch;align-items:stretch;display:flex;font-size:1rem;justify-content:space-between;overflow:hidden;overflow-x:auto;white-space:nowrap}.tabs a{align-items:center;border-bottom-color:#dbdbdb;border-bottom-style:solid;border-bottom-width:1px;color:#222;display:flex;justify-content:center;margin-bottom:-1px;padding:0.5em 1em;vertical-align:top}.tabs a:hover{border-bottom-color:#222;color:#222}.tabs li{display:block}.tabs li.is-active a{border-bottom-color:#2e63b8;color:#2e63b8}.tabs ul{align-items:center;border-bottom-color:#dbdbdb;border-bottom-style:solid;border-bottom-width:1px;display:flex;flex-grow:1;flex-shrink:0;justify-content:flex-start}.tabs ul.is-left{padding-right:0.75em}.tabs ul.is-center{flex:none;justify-content:center;padding-left:0.75em;padding-right:0.75em}.tabs ul.is-right{justify-content:flex-end;padding-left:0.75em}.tabs .icon:first-child{margin-right:.5em}.tabs .icon:last-child{margin-left:.5em}.tabs.is-centered ul{justify-content:center}.tabs.is-right ul{justify-content:flex-end}.tabs.is-boxed a{border:1px solid transparent;border-radius:4px 4px 0 0}.tabs.is-boxed a:hover{background-color:#f5f5f5;border-bottom-color:#dbdbdb}.tabs.is-boxed li.is-active a{background-color:#fff;border-color:#dbdbdb;border-bottom-color:rgba(0,0,0,0) !important}.tabs.is-fullwidth li{flex-grow:1;flex-shrink:0}.tabs.is-toggle a{border-color:#dbdbdb;border-style:solid;border-width:1px;margin-bottom:0;position:relative}.tabs.is-toggle a:hover{background-color:#f5f5f5;border-color:#b5b5b5;z-index:2}.tabs.is-toggle li+li{margin-left:-1px}.tabs.is-toggle li:first-child a{border-top-left-radius:4px;border-bottom-left-radius:4px}.tabs.is-toggle li:last-child a{border-top-right-radius:4px;border-bottom-right-radius:4px}.tabs.is-toggle li.is-active a{background-color:#2e63b8;border-color:#2e63b8;color:#fff;z-index:1}.tabs.is-toggle ul{border-bottom:none}.tabs.is-toggle.is-toggle-rounded li:first-child a{border-bottom-left-radius:9999px;border-top-left-radius:9999px;padding-left:1.25em}.tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:9999px;border-top-right-radius:9999px;padding-right:1.25em}.tabs.is-small,#documenter .docs-sidebar form.docs-search>input.tabs{font-size:.75rem}.tabs.is-medium{font-size:1.25rem}.tabs.is-large{font-size:1.5rem}.column{display:block;flex-basis:0;flex-grow:1;flex-shrink:1;padding:.75rem}.columns.is-mobile>.column.is-narrow{flex:none;width:unset}.columns.is-mobile>.column.is-full{flex:none;width:100%}.columns.is-mobile>.column.is-three-quarters{flex:none;width:75%}.columns.is-mobile>.column.is-two-thirds{flex:none;width:66.6666%}.columns.is-mobile>.column.is-half{flex:none;width:50%}.columns.is-mobile>.column.is-one-third{flex:none;width:33.3333%}.columns.is-mobile>.column.is-one-quarter{flex:none;width:25%}.columns.is-mobile>.column.is-one-fifth{flex:none;width:20%}.columns.is-mobile>.column.is-two-fifths{flex:none;width:40%}.columns.is-mobile>.column.is-three-fifths{flex:none;width:60%}.columns.is-mobile>.column.is-four-fifths{flex:none;width:80%}.columns.is-mobile>.column.is-offset-three-quarters{margin-left:75%}.columns.is-mobile>.column.is-offset-two-thirds{margin-left:66.6666%}.columns.is-mobile>.column.is-offset-half{margin-left:50%}.columns.is-mobile>.column.is-offset-one-third{margin-left:33.3333%}.columns.is-mobile>.column.is-offset-one-quarter{margin-left:25%}.columns.is-mobile>.column.is-offset-one-fifth{margin-left:20%}.columns.is-mobile>.column.is-offset-two-fifths{margin-left:40%}.columns.is-mobile>.column.is-offset-three-fifths{margin-left:60%}.columns.is-mobile>.column.is-offset-four-fifths{margin-left:80%}.columns.is-mobile>.column.is-0{flex:none;width:0%}.columns.is-mobile>.column.is-offset-0{margin-left:0%}.columns.is-mobile>.column.is-1{flex:none;width:8.33333337%}.columns.is-mobile>.column.is-offset-1{margin-left:8.33333337%}.columns.is-mobile>.column.is-2{flex:none;width:16.66666674%}.columns.is-mobile>.column.is-offset-2{margin-left:16.66666674%}.columns.is-mobile>.column.is-3{flex:none;width:25%}.columns.is-mobile>.column.is-offset-3{margin-left:25%}.columns.is-mobile>.column.is-4{flex:none;width:33.33333337%}.columns.is-mobile>.column.is-offset-4{margin-left:33.33333337%}.columns.is-mobile>.column.is-5{flex:none;width:41.66666674%}.columns.is-mobile>.column.is-offset-5{margin-left:41.66666674%}.columns.is-mobile>.column.is-6{flex:none;width:50%}.columns.is-mobile>.column.is-offset-6{margin-left:50%}.columns.is-mobile>.column.is-7{flex:none;width:58.33333337%}.columns.is-mobile>.column.is-offset-7{margin-left:58.33333337%}.columns.is-mobile>.column.is-8{flex:none;width:66.66666674%}.columns.is-mobile>.column.is-offset-8{margin-left:66.66666674%}.columns.is-mobile>.column.is-9{flex:none;width:75%}.columns.is-mobile>.column.is-offset-9{margin-left:75%}.columns.is-mobile>.column.is-10{flex:none;width:83.33333337%}.columns.is-mobile>.column.is-offset-10{margin-left:83.33333337%}.columns.is-mobile>.column.is-11{flex:none;width:91.66666674%}.columns.is-mobile>.column.is-offset-11{margin-left:91.66666674%}.columns.is-mobile>.column.is-12{flex:none;width:100%}.columns.is-mobile>.column.is-offset-12{margin-left:100%}@media screen and (max-width: 768px){.column.is-narrow-mobile{flex:none;width:unset}.column.is-full-mobile{flex:none;width:100%}.column.is-three-quarters-mobile{flex:none;width:75%}.column.is-two-thirds-mobile{flex:none;width:66.6666%}.column.is-half-mobile{flex:none;width:50%}.column.is-one-third-mobile{flex:none;width:33.3333%}.column.is-one-quarter-mobile{flex:none;width:25%}.column.is-one-fifth-mobile{flex:none;width:20%}.column.is-two-fifths-mobile{flex:none;width:40%}.column.is-three-fifths-mobile{flex:none;width:60%}.column.is-four-fifths-mobile{flex:none;width:80%}.column.is-offset-three-quarters-mobile{margin-left:75%}.column.is-offset-two-thirds-mobile{margin-left:66.6666%}.column.is-offset-half-mobile{margin-left:50%}.column.is-offset-one-third-mobile{margin-left:33.3333%}.column.is-offset-one-quarter-mobile{margin-left:25%}.column.is-offset-one-fifth-mobile{margin-left:20%}.column.is-offset-two-fifths-mobile{margin-left:40%}.column.is-offset-three-fifths-mobile{margin-left:60%}.column.is-offset-four-fifths-mobile{margin-left:80%}.column.is-0-mobile{flex:none;width:0%}.column.is-offset-0-mobile{margin-left:0%}.column.is-1-mobile{flex:none;width:8.33333337%}.column.is-offset-1-mobile{margin-left:8.33333337%}.column.is-2-mobile{flex:none;width:16.66666674%}.column.is-offset-2-mobile{margin-left:16.66666674%}.column.is-3-mobile{flex:none;width:25%}.column.is-offset-3-mobile{margin-left:25%}.column.is-4-mobile{flex:none;width:33.33333337%}.column.is-offset-4-mobile{margin-left:33.33333337%}.column.is-5-mobile{flex:none;width:41.66666674%}.column.is-offset-5-mobile{margin-left:41.66666674%}.column.is-6-mobile{flex:none;width:50%}.column.is-offset-6-mobile{margin-left:50%}.column.is-7-mobile{flex:none;width:58.33333337%}.column.is-offset-7-mobile{margin-left:58.33333337%}.column.is-8-mobile{flex:none;width:66.66666674%}.column.is-offset-8-mobile{margin-left:66.66666674%}.column.is-9-mobile{flex:none;width:75%}.column.is-offset-9-mobile{margin-left:75%}.column.is-10-mobile{flex:none;width:83.33333337%}.column.is-offset-10-mobile{margin-left:83.33333337%}.column.is-11-mobile{flex:none;width:91.66666674%}.column.is-offset-11-mobile{margin-left:91.66666674%}.column.is-12-mobile{flex:none;width:100%}.column.is-offset-12-mobile{margin-left:100%}}@media screen and (min-width: 769px),print{.column.is-narrow,.column.is-narrow-tablet{flex:none;width:unset}.column.is-full,.column.is-full-tablet{flex:none;width:100%}.column.is-three-quarters,.column.is-three-quarters-tablet{flex:none;width:75%}.column.is-two-thirds,.column.is-two-thirds-tablet{flex:none;width:66.6666%}.column.is-half,.column.is-half-tablet{flex:none;width:50%}.column.is-one-third,.column.is-one-third-tablet{flex:none;width:33.3333%}.column.is-one-quarter,.column.is-one-quarter-tablet{flex:none;width:25%}.column.is-one-fifth,.column.is-one-fifth-tablet{flex:none;width:20%}.column.is-two-fifths,.column.is-two-fifths-tablet{flex:none;width:40%}.column.is-three-fifths,.column.is-three-fifths-tablet{flex:none;width:60%}.column.is-four-fifths,.column.is-four-fifths-tablet{flex:none;width:80%}.column.is-offset-three-quarters,.column.is-offset-three-quarters-tablet{margin-left:75%}.column.is-offset-two-thirds,.column.is-offset-two-thirds-tablet{margin-left:66.6666%}.column.is-offset-half,.column.is-offset-half-tablet{margin-left:50%}.column.is-offset-one-third,.column.is-offset-one-third-tablet{margin-left:33.3333%}.column.is-offset-one-quarter,.column.is-offset-one-quarter-tablet{margin-left:25%}.column.is-offset-one-fifth,.column.is-offset-one-fifth-tablet{margin-left:20%}.column.is-offset-two-fifths,.column.is-offset-two-fifths-tablet{margin-left:40%}.column.is-offset-three-fifths,.column.is-offset-three-fifths-tablet{margin-left:60%}.column.is-offset-four-fifths,.column.is-offset-four-fifths-tablet{margin-left:80%}.column.is-0,.column.is-0-tablet{flex:none;width:0%}.column.is-offset-0,.column.is-offset-0-tablet{margin-left:0%}.column.is-1,.column.is-1-tablet{flex:none;width:8.33333337%}.column.is-offset-1,.column.is-offset-1-tablet{margin-left:8.33333337%}.column.is-2,.column.is-2-tablet{flex:none;width:16.66666674%}.column.is-offset-2,.column.is-offset-2-tablet{margin-left:16.66666674%}.column.is-3,.column.is-3-tablet{flex:none;width:25%}.column.is-offset-3,.column.is-offset-3-tablet{margin-left:25%}.column.is-4,.column.is-4-tablet{flex:none;width:33.33333337%}.column.is-offset-4,.column.is-offset-4-tablet{margin-left:33.33333337%}.column.is-5,.column.is-5-tablet{flex:none;width:41.66666674%}.column.is-offset-5,.column.is-offset-5-tablet{margin-left:41.66666674%}.column.is-6,.column.is-6-tablet{flex:none;width:50%}.column.is-offset-6,.column.is-offset-6-tablet{margin-left:50%}.column.is-7,.column.is-7-tablet{flex:none;width:58.33333337%}.column.is-offset-7,.column.is-offset-7-tablet{margin-left:58.33333337%}.column.is-8,.column.is-8-tablet{flex:none;width:66.66666674%}.column.is-offset-8,.column.is-offset-8-tablet{margin-left:66.66666674%}.column.is-9,.column.is-9-tablet{flex:none;width:75%}.column.is-offset-9,.column.is-offset-9-tablet{margin-left:75%}.column.is-10,.column.is-10-tablet{flex:none;width:83.33333337%}.column.is-offset-10,.column.is-offset-10-tablet{margin-left:83.33333337%}.column.is-11,.column.is-11-tablet{flex:none;width:91.66666674%}.column.is-offset-11,.column.is-offset-11-tablet{margin-left:91.66666674%}.column.is-12,.column.is-12-tablet{flex:none;width:100%}.column.is-offset-12,.column.is-offset-12-tablet{margin-left:100%}}@media screen and (max-width: 1055px){.column.is-narrow-touch{flex:none;width:unset}.column.is-full-touch{flex:none;width:100%}.column.is-three-quarters-touch{flex:none;width:75%}.column.is-two-thirds-touch{flex:none;width:66.6666%}.column.is-half-touch{flex:none;width:50%}.column.is-one-third-touch{flex:none;width:33.3333%}.column.is-one-quarter-touch{flex:none;width:25%}.column.is-one-fifth-touch{flex:none;width:20%}.column.is-two-fifths-touch{flex:none;width:40%}.column.is-three-fifths-touch{flex:none;width:60%}.column.is-four-fifths-touch{flex:none;width:80%}.column.is-offset-three-quarters-touch{margin-left:75%}.column.is-offset-two-thirds-touch{margin-left:66.6666%}.column.is-offset-half-touch{margin-left:50%}.column.is-offset-one-third-touch{margin-left:33.3333%}.column.is-offset-one-quarter-touch{margin-left:25%}.column.is-offset-one-fifth-touch{margin-left:20%}.column.is-offset-two-fifths-touch{margin-left:40%}.column.is-offset-three-fifths-touch{margin-left:60%}.column.is-offset-four-fifths-touch{margin-left:80%}.column.is-0-touch{flex:none;width:0%}.column.is-offset-0-touch{margin-left:0%}.column.is-1-touch{flex:none;width:8.33333337%}.column.is-offset-1-touch{margin-left:8.33333337%}.column.is-2-touch{flex:none;width:16.66666674%}.column.is-offset-2-touch{margin-left:16.66666674%}.column.is-3-touch{flex:none;width:25%}.column.is-offset-3-touch{margin-left:25%}.column.is-4-touch{flex:none;width:33.33333337%}.column.is-offset-4-touch{margin-left:33.33333337%}.column.is-5-touch{flex:none;width:41.66666674%}.column.is-offset-5-touch{margin-left:41.66666674%}.column.is-6-touch{flex:none;width:50%}.column.is-offset-6-touch{margin-left:50%}.column.is-7-touch{flex:none;width:58.33333337%}.column.is-offset-7-touch{margin-left:58.33333337%}.column.is-8-touch{flex:none;width:66.66666674%}.column.is-offset-8-touch{margin-left:66.66666674%}.column.is-9-touch{flex:none;width:75%}.column.is-offset-9-touch{margin-left:75%}.column.is-10-touch{flex:none;width:83.33333337%}.column.is-offset-10-touch{margin-left:83.33333337%}.column.is-11-touch{flex:none;width:91.66666674%}.column.is-offset-11-touch{margin-left:91.66666674%}.column.is-12-touch{flex:none;width:100%}.column.is-offset-12-touch{margin-left:100%}}@media screen and (min-width: 1056px){.column.is-narrow-desktop{flex:none;width:unset}.column.is-full-desktop{flex:none;width:100%}.column.is-three-quarters-desktop{flex:none;width:75%}.column.is-two-thirds-desktop{flex:none;width:66.6666%}.column.is-half-desktop{flex:none;width:50%}.column.is-one-third-desktop{flex:none;width:33.3333%}.column.is-one-quarter-desktop{flex:none;width:25%}.column.is-one-fifth-desktop{flex:none;width:20%}.column.is-two-fifths-desktop{flex:none;width:40%}.column.is-three-fifths-desktop{flex:none;width:60%}.column.is-four-fifths-desktop{flex:none;width:80%}.column.is-offset-three-quarters-desktop{margin-left:75%}.column.is-offset-two-thirds-desktop{margin-left:66.6666%}.column.is-offset-half-desktop{margin-left:50%}.column.is-offset-one-third-desktop{margin-left:33.3333%}.column.is-offset-one-quarter-desktop{margin-left:25%}.column.is-offset-one-fifth-desktop{margin-left:20%}.column.is-offset-two-fifths-desktop{margin-left:40%}.column.is-offset-three-fifths-desktop{margin-left:60%}.column.is-offset-four-fifths-desktop{margin-left:80%}.column.is-0-desktop{flex:none;width:0%}.column.is-offset-0-desktop{margin-left:0%}.column.is-1-desktop{flex:none;width:8.33333337%}.column.is-offset-1-desktop{margin-left:8.33333337%}.column.is-2-desktop{flex:none;width:16.66666674%}.column.is-offset-2-desktop{margin-left:16.66666674%}.column.is-3-desktop{flex:none;width:25%}.column.is-offset-3-desktop{margin-left:25%}.column.is-4-desktop{flex:none;width:33.33333337%}.column.is-offset-4-desktop{margin-left:33.33333337%}.column.is-5-desktop{flex:none;width:41.66666674%}.column.is-offset-5-desktop{margin-left:41.66666674%}.column.is-6-desktop{flex:none;width:50%}.column.is-offset-6-desktop{margin-left:50%}.column.is-7-desktop{flex:none;width:58.33333337%}.column.is-offset-7-desktop{margin-left:58.33333337%}.column.is-8-desktop{flex:none;width:66.66666674%}.column.is-offset-8-desktop{margin-left:66.66666674%}.column.is-9-desktop{flex:none;width:75%}.column.is-offset-9-desktop{margin-left:75%}.column.is-10-desktop{flex:none;width:83.33333337%}.column.is-offset-10-desktop{margin-left:83.33333337%}.column.is-11-desktop{flex:none;width:91.66666674%}.column.is-offset-11-desktop{margin-left:91.66666674%}.column.is-12-desktop{flex:none;width:100%}.column.is-offset-12-desktop{margin-left:100%}}@media screen and (min-width: 1216px){.column.is-narrow-widescreen{flex:none;width:unset}.column.is-full-widescreen{flex:none;width:100%}.column.is-three-quarters-widescreen{flex:none;width:75%}.column.is-two-thirds-widescreen{flex:none;width:66.6666%}.column.is-half-widescreen{flex:none;width:50%}.column.is-one-third-widescreen{flex:none;width:33.3333%}.column.is-one-quarter-widescreen{flex:none;width:25%}.column.is-one-fifth-widescreen{flex:none;width:20%}.column.is-two-fifths-widescreen{flex:none;width:40%}.column.is-three-fifths-widescreen{flex:none;width:60%}.column.is-four-fifths-widescreen{flex:none;width:80%}.column.is-offset-three-quarters-widescreen{margin-left:75%}.column.is-offset-two-thirds-widescreen{margin-left:66.6666%}.column.is-offset-half-widescreen{margin-left:50%}.column.is-offset-one-third-widescreen{margin-left:33.3333%}.column.is-offset-one-quarter-widescreen{margin-left:25%}.column.is-offset-one-fifth-widescreen{margin-left:20%}.column.is-offset-two-fifths-widescreen{margin-left:40%}.column.is-offset-three-fifths-widescreen{margin-left:60%}.column.is-offset-four-fifths-widescreen{margin-left:80%}.column.is-0-widescreen{flex:none;width:0%}.column.is-offset-0-widescreen{margin-left:0%}.column.is-1-widescreen{flex:none;width:8.33333337%}.column.is-offset-1-widescreen{margin-left:8.33333337%}.column.is-2-widescreen{flex:none;width:16.66666674%}.column.is-offset-2-widescreen{margin-left:16.66666674%}.column.is-3-widescreen{flex:none;width:25%}.column.is-offset-3-widescreen{margin-left:25%}.column.is-4-widescreen{flex:none;width:33.33333337%}.column.is-offset-4-widescreen{margin-left:33.33333337%}.column.is-5-widescreen{flex:none;width:41.66666674%}.column.is-offset-5-widescreen{margin-left:41.66666674%}.column.is-6-widescreen{flex:none;width:50%}.column.is-offset-6-widescreen{margin-left:50%}.column.is-7-widescreen{flex:none;width:58.33333337%}.column.is-offset-7-widescreen{margin-left:58.33333337%}.column.is-8-widescreen{flex:none;width:66.66666674%}.column.is-offset-8-widescreen{margin-left:66.66666674%}.column.is-9-widescreen{flex:none;width:75%}.column.is-offset-9-widescreen{margin-left:75%}.column.is-10-widescreen{flex:none;width:83.33333337%}.column.is-offset-10-widescreen{margin-left:83.33333337%}.column.is-11-widescreen{flex:none;width:91.66666674%}.column.is-offset-11-widescreen{margin-left:91.66666674%}.column.is-12-widescreen{flex:none;width:100%}.column.is-offset-12-widescreen{margin-left:100%}}@media screen and (min-width: 1408px){.column.is-narrow-fullhd{flex:none;width:unset}.column.is-full-fullhd{flex:none;width:100%}.column.is-three-quarters-fullhd{flex:none;width:75%}.column.is-two-thirds-fullhd{flex:none;width:66.6666%}.column.is-half-fullhd{flex:none;width:50%}.column.is-one-third-fullhd{flex:none;width:33.3333%}.column.is-one-quarter-fullhd{flex:none;width:25%}.column.is-one-fifth-fullhd{flex:none;width:20%}.column.is-two-fifths-fullhd{flex:none;width:40%}.column.is-three-fifths-fullhd{flex:none;width:60%}.column.is-four-fifths-fullhd{flex:none;width:80%}.column.is-offset-three-quarters-fullhd{margin-left:75%}.column.is-offset-two-thirds-fullhd{margin-left:66.6666%}.column.is-offset-half-fullhd{margin-left:50%}.column.is-offset-one-third-fullhd{margin-left:33.3333%}.column.is-offset-one-quarter-fullhd{margin-left:25%}.column.is-offset-one-fifth-fullhd{margin-left:20%}.column.is-offset-two-fifths-fullhd{margin-left:40%}.column.is-offset-three-fifths-fullhd{margin-left:60%}.column.is-offset-four-fifths-fullhd{margin-left:80%}.column.is-0-fullhd{flex:none;width:0%}.column.is-offset-0-fullhd{margin-left:0%}.column.is-1-fullhd{flex:none;width:8.33333337%}.column.is-offset-1-fullhd{margin-left:8.33333337%}.column.is-2-fullhd{flex:none;width:16.66666674%}.column.is-offset-2-fullhd{margin-left:16.66666674%}.column.is-3-fullhd{flex:none;width:25%}.column.is-offset-3-fullhd{margin-left:25%}.column.is-4-fullhd{flex:none;width:33.33333337%}.column.is-offset-4-fullhd{margin-left:33.33333337%}.column.is-5-fullhd{flex:none;width:41.66666674%}.column.is-offset-5-fullhd{margin-left:41.66666674%}.column.is-6-fullhd{flex:none;width:50%}.column.is-offset-6-fullhd{margin-left:50%}.column.is-7-fullhd{flex:none;width:58.33333337%}.column.is-offset-7-fullhd{margin-left:58.33333337%}.column.is-8-fullhd{flex:none;width:66.66666674%}.column.is-offset-8-fullhd{margin-left:66.66666674%}.column.is-9-fullhd{flex:none;width:75%}.column.is-offset-9-fullhd{margin-left:75%}.column.is-10-fullhd{flex:none;width:83.33333337%}.column.is-offset-10-fullhd{margin-left:83.33333337%}.column.is-11-fullhd{flex:none;width:91.66666674%}.column.is-offset-11-fullhd{margin-left:91.66666674%}.column.is-12-fullhd{flex:none;width:100%}.column.is-offset-12-fullhd{margin-left:100%}}.columns{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}.columns:last-child{margin-bottom:-.75rem}.columns:not(:last-child){margin-bottom:calc(1.5rem - .75rem)}.columns.is-centered{justify-content:center}.columns.is-gapless{margin-left:0;margin-right:0;margin-top:0}.columns.is-gapless>.column{margin:0;padding:0 !important}.columns.is-gapless:not(:last-child){margin-bottom:1.5rem}.columns.is-gapless:last-child{margin-bottom:0}.columns.is-mobile{display:flex}.columns.is-multiline{flex-wrap:wrap}.columns.is-vcentered{align-items:center}@media screen and (min-width: 769px),print{.columns:not(.is-desktop){display:flex}}@media screen and (min-width: 1056px){.columns.is-desktop{display:flex}}.columns.is-variable{--columnGap: 0.75rem;margin-left:calc(-1 * var(--columnGap));margin-right:calc(-1 * var(--columnGap))}.columns.is-variable>.column{padding-left:var(--columnGap);padding-right:var(--columnGap)}.columns.is-variable.is-0{--columnGap: 0rem}@media screen and (max-width: 768px){.columns.is-variable.is-0-mobile{--columnGap: 0rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-0-tablet{--columnGap: 0rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-0-tablet-only{--columnGap: 0rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-0-touch{--columnGap: 0rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-0-desktop{--columnGap: 0rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-0-desktop-only{--columnGap: 0rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-0-widescreen{--columnGap: 0rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-0-widescreen-only{--columnGap: 0rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-0-fullhd{--columnGap: 0rem}}.columns.is-variable.is-1{--columnGap: .25rem}@media screen and (max-width: 768px){.columns.is-variable.is-1-mobile{--columnGap: .25rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-1-tablet{--columnGap: .25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-1-tablet-only{--columnGap: .25rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-1-touch{--columnGap: .25rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-1-desktop{--columnGap: .25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-1-desktop-only{--columnGap: .25rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-1-widescreen{--columnGap: .25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-1-widescreen-only{--columnGap: .25rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-1-fullhd{--columnGap: .25rem}}.columns.is-variable.is-2{--columnGap: .5rem}@media screen and (max-width: 768px){.columns.is-variable.is-2-mobile{--columnGap: .5rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-2-tablet{--columnGap: .5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-2-tablet-only{--columnGap: .5rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-2-touch{--columnGap: .5rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-2-desktop{--columnGap: .5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-2-desktop-only{--columnGap: .5rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-2-widescreen{--columnGap: .5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-2-widescreen-only{--columnGap: .5rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-2-fullhd{--columnGap: .5rem}}.columns.is-variable.is-3{--columnGap: .75rem}@media screen and (max-width: 768px){.columns.is-variable.is-3-mobile{--columnGap: .75rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-3-tablet{--columnGap: .75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-3-tablet-only{--columnGap: .75rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-3-touch{--columnGap: .75rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-3-desktop{--columnGap: .75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-3-desktop-only{--columnGap: .75rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-3-widescreen{--columnGap: .75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-3-widescreen-only{--columnGap: .75rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-3-fullhd{--columnGap: .75rem}}.columns.is-variable.is-4{--columnGap: 1rem}@media screen and (max-width: 768px){.columns.is-variable.is-4-mobile{--columnGap: 1rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-4-tablet{--columnGap: 1rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-4-tablet-only{--columnGap: 1rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-4-touch{--columnGap: 1rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-4-desktop{--columnGap: 1rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-4-desktop-only{--columnGap: 1rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-4-widescreen{--columnGap: 1rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-4-widescreen-only{--columnGap: 1rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-4-fullhd{--columnGap: 1rem}}.columns.is-variable.is-5{--columnGap: 1.25rem}@media screen and (max-width: 768px){.columns.is-variable.is-5-mobile{--columnGap: 1.25rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-5-tablet{--columnGap: 1.25rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-5-tablet-only{--columnGap: 1.25rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-5-touch{--columnGap: 1.25rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-5-desktop{--columnGap: 1.25rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-5-desktop-only{--columnGap: 1.25rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-5-widescreen{--columnGap: 1.25rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-5-widescreen-only{--columnGap: 1.25rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-5-fullhd{--columnGap: 1.25rem}}.columns.is-variable.is-6{--columnGap: 1.5rem}@media screen and (max-width: 768px){.columns.is-variable.is-6-mobile{--columnGap: 1.5rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-6-tablet{--columnGap: 1.5rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-6-tablet-only{--columnGap: 1.5rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-6-touch{--columnGap: 1.5rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-6-desktop{--columnGap: 1.5rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-6-desktop-only{--columnGap: 1.5rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-6-widescreen{--columnGap: 1.5rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-6-widescreen-only{--columnGap: 1.5rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-6-fullhd{--columnGap: 1.5rem}}.columns.is-variable.is-7{--columnGap: 1.75rem}@media screen and (max-width: 768px){.columns.is-variable.is-7-mobile{--columnGap: 1.75rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-7-tablet{--columnGap: 1.75rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-7-tablet-only{--columnGap: 1.75rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-7-touch{--columnGap: 1.75rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-7-desktop{--columnGap: 1.75rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-7-desktop-only{--columnGap: 1.75rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-7-widescreen{--columnGap: 1.75rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-7-widescreen-only{--columnGap: 1.75rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-7-fullhd{--columnGap: 1.75rem}}.columns.is-variable.is-8{--columnGap: 2rem}@media screen and (max-width: 768px){.columns.is-variable.is-8-mobile{--columnGap: 2rem}}@media screen and (min-width: 769px),print{.columns.is-variable.is-8-tablet{--columnGap: 2rem}}@media screen and (min-width: 769px) and (max-width: 1055px){.columns.is-variable.is-8-tablet-only{--columnGap: 2rem}}@media screen and (max-width: 1055px){.columns.is-variable.is-8-touch{--columnGap: 2rem}}@media screen and (min-width: 1056px){.columns.is-variable.is-8-desktop{--columnGap: 2rem}}@media screen and (min-width: 1056px) and (max-width: 1215px){.columns.is-variable.is-8-desktop-only{--columnGap: 2rem}}@media screen and (min-width: 1216px){.columns.is-variable.is-8-widescreen{--columnGap: 2rem}}@media screen and (min-width: 1216px) and (max-width: 1407px){.columns.is-variable.is-8-widescreen-only{--columnGap: 2rem}}@media screen and (min-width: 1408px){.columns.is-variable.is-8-fullhd{--columnGap: 2rem}}.tile{align-items:stretch;display:block;flex-basis:0;flex-grow:1;flex-shrink:1;min-height:min-content}.tile.is-ancestor{margin-left:-.75rem;margin-right:-.75rem;margin-top:-.75rem}.tile.is-ancestor:last-child{margin-bottom:-.75rem}.tile.is-ancestor:not(:last-child){margin-bottom:.75rem}.tile.is-child{margin:0 !important}.tile.is-parent{padding:.75rem}.tile.is-vertical{flex-direction:column}.tile.is-vertical>.tile.is-child:not(:last-child){margin-bottom:1.5rem !important}@media screen and (min-width: 769px),print{.tile:not(.is-child){display:flex}.tile.is-1{flex:none;width:8.33333337%}.tile.is-2{flex:none;width:16.66666674%}.tile.is-3{flex:none;width:25%}.tile.is-4{flex:none;width:33.33333337%}.tile.is-5{flex:none;width:41.66666674%}.tile.is-6{flex:none;width:50%}.tile.is-7{flex:none;width:58.33333337%}.tile.is-8{flex:none;width:66.66666674%}.tile.is-9{flex:none;width:75%}.tile.is-10{flex:none;width:83.33333337%}.tile.is-11{flex:none;width:91.66666674%}.tile.is-12{flex:none;width:100%}}.hero{align-items:stretch;display:flex;flex-direction:column;justify-content:space-between}.hero .navbar{background:none}.hero .tabs ul{border-bottom:none}.hero.is-white{background-color:#fff;color:#0a0a0a}.hero.is-white a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-white strong{color:inherit}.hero.is-white .title{color:#0a0a0a}.hero.is-white .subtitle{color:rgba(10,10,10,0.9)}.hero.is-white .subtitle a:not(.button),.hero.is-white .subtitle strong{color:#0a0a0a}@media screen and (max-width: 1055px){.hero.is-white .navbar-menu{background-color:#fff}}.hero.is-white .navbar-item,.hero.is-white .navbar-link{color:rgba(10,10,10,0.7)}.hero.is-white a.navbar-item:hover,.hero.is-white a.navbar-item.is-active,.hero.is-white .navbar-link:hover,.hero.is-white .navbar-link.is-active{background-color:#f2f2f2;color:#0a0a0a}.hero.is-white .tabs a{color:#0a0a0a;opacity:0.9}.hero.is-white .tabs a:hover{opacity:1}.hero.is-white .tabs li.is-active a{color:#fff !important;opacity:1}.hero.is-white .tabs.is-boxed a,.hero.is-white .tabs.is-toggle a{color:#0a0a0a}.hero.is-white .tabs.is-boxed a:hover,.hero.is-white .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-white .tabs.is-boxed li.is-active a,.hero.is-white .tabs.is-boxed li.is-active a:hover,.hero.is-white .tabs.is-toggle li.is-active a,.hero.is-white .tabs.is-toggle li.is-active a:hover{background-color:#0a0a0a;border-color:#0a0a0a;color:#fff}.hero.is-white.is-bold{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}@media screen and (max-width: 768px){.hero.is-white.is-bold .navbar-menu{background-image:linear-gradient(141deg, #e8e3e4 0%, #fff 71%, #fff 100%)}}.hero.is-black{background-color:#0a0a0a;color:#fff}.hero.is-black a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-black strong{color:inherit}.hero.is-black .title{color:#fff}.hero.is-black .subtitle{color:rgba(255,255,255,0.9)}.hero.is-black .subtitle a:not(.button),.hero.is-black .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-black .navbar-menu{background-color:#0a0a0a}}.hero.is-black .navbar-item,.hero.is-black .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-black a.navbar-item:hover,.hero.is-black a.navbar-item.is-active,.hero.is-black .navbar-link:hover,.hero.is-black .navbar-link.is-active{background-color:#000;color:#fff}.hero.is-black .tabs a{color:#fff;opacity:0.9}.hero.is-black .tabs a:hover{opacity:1}.hero.is-black .tabs li.is-active a{color:#0a0a0a !important;opacity:1}.hero.is-black .tabs.is-boxed a,.hero.is-black .tabs.is-toggle a{color:#fff}.hero.is-black .tabs.is-boxed a:hover,.hero.is-black .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-black .tabs.is-boxed li.is-active a,.hero.is-black .tabs.is-boxed li.is-active a:hover,.hero.is-black .tabs.is-toggle li.is-active a,.hero.is-black .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#0a0a0a}.hero.is-black.is-bold{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}@media screen and (max-width: 768px){.hero.is-black.is-bold .navbar-menu{background-image:linear-gradient(141deg, #000 0%, #0a0a0a 71%, #181616 100%)}}.hero.is-light{background-color:#f5f5f5;color:rgba(0,0,0,0.7)}.hero.is-light a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-light strong{color:inherit}.hero.is-light .title{color:rgba(0,0,0,0.7)}.hero.is-light .subtitle{color:rgba(0,0,0,0.9)}.hero.is-light .subtitle a:not(.button),.hero.is-light .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){.hero.is-light .navbar-menu{background-color:#f5f5f5}}.hero.is-light .navbar-item,.hero.is-light .navbar-link{color:rgba(0,0,0,0.7)}.hero.is-light a.navbar-item:hover,.hero.is-light a.navbar-item.is-active,.hero.is-light .navbar-link:hover,.hero.is-light .navbar-link.is-active{background-color:#e8e8e8;color:rgba(0,0,0,0.7)}.hero.is-light .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}.hero.is-light .tabs a:hover{opacity:1}.hero.is-light .tabs li.is-active a{color:#f5f5f5 !important;opacity:1}.hero.is-light .tabs.is-boxed a,.hero.is-light .tabs.is-toggle a{color:rgba(0,0,0,0.7)}.hero.is-light .tabs.is-boxed a:hover,.hero.is-light .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-light .tabs.is-boxed li.is-active a,.hero.is-light .tabs.is-boxed li.is-active a:hover,.hero.is-light .tabs.is-toggle li.is-active a,.hero.is-light .tabs.is-toggle li.is-active a:hover{background-color:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#f5f5f5}.hero.is-light.is-bold{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}@media screen and (max-width: 768px){.hero.is-light.is-bold .navbar-menu{background-image:linear-gradient(141deg, #dfd8d9 0%, #f5f5f5 71%, #fff 100%)}}.hero.is-dark,.content kbd.hero{background-color:#363636;color:#fff}.hero.is-dark a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.content kbd.hero a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-dark strong,.content kbd.hero strong{color:inherit}.hero.is-dark .title,.content kbd.hero .title{color:#fff}.hero.is-dark .subtitle,.content kbd.hero .subtitle{color:rgba(255,255,255,0.9)}.hero.is-dark .subtitle a:not(.button),.content kbd.hero .subtitle a:not(.button),.hero.is-dark .subtitle strong,.content kbd.hero .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-dark .navbar-menu,.content kbd.hero .navbar-menu{background-color:#363636}}.hero.is-dark .navbar-item,.content kbd.hero .navbar-item,.hero.is-dark .navbar-link,.content kbd.hero .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-dark a.navbar-item:hover,.content kbd.hero a.navbar-item:hover,.hero.is-dark a.navbar-item.is-active,.content kbd.hero a.navbar-item.is-active,.hero.is-dark .navbar-link:hover,.content kbd.hero .navbar-link:hover,.hero.is-dark .navbar-link.is-active,.content kbd.hero .navbar-link.is-active{background-color:#292929;color:#fff}.hero.is-dark .tabs a,.content kbd.hero .tabs a{color:#fff;opacity:0.9}.hero.is-dark .tabs a:hover,.content kbd.hero .tabs a:hover{opacity:1}.hero.is-dark .tabs li.is-active a,.content kbd.hero .tabs li.is-active a{color:#363636 !important;opacity:1}.hero.is-dark .tabs.is-boxed a,.content kbd.hero .tabs.is-boxed a,.hero.is-dark .tabs.is-toggle a,.content kbd.hero .tabs.is-toggle a{color:#fff}.hero.is-dark .tabs.is-boxed a:hover,.content kbd.hero .tabs.is-boxed a:hover,.hero.is-dark .tabs.is-toggle a:hover,.content kbd.hero .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-dark .tabs.is-boxed li.is-active a,.content kbd.hero .tabs.is-boxed li.is-active a,.hero.is-dark .tabs.is-boxed li.is-active a:hover,.hero.is-dark .tabs.is-toggle li.is-active a,.content kbd.hero .tabs.is-toggle li.is-active a,.hero.is-dark .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#363636}.hero.is-dark.is-bold,.content kbd.hero.is-bold{background-image:linear-gradient(141deg, #1f191a 0%, #363636 71%, #46403f 100%)}@media screen and (max-width: 768px){.hero.is-dark.is-bold .navbar-menu,.content kbd.hero.is-bold .navbar-menu{background-image:linear-gradient(141deg, #1f191a 0%, #363636 71%, #46403f 100%)}}.hero.is-primary,.docstring>section>a.hero.docs-sourcelink{background-color:#4eb5de;color:#fff}.hero.is-primary a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.docstring>section>a.hero.docs-sourcelink a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-primary strong,.docstring>section>a.hero.docs-sourcelink strong{color:inherit}.hero.is-primary .title,.docstring>section>a.hero.docs-sourcelink .title{color:#fff}.hero.is-primary .subtitle,.docstring>section>a.hero.docs-sourcelink .subtitle{color:rgba(255,255,255,0.9)}.hero.is-primary .subtitle a:not(.button),.docstring>section>a.hero.docs-sourcelink .subtitle a:not(.button),.hero.is-primary .subtitle strong,.docstring>section>a.hero.docs-sourcelink .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-primary .navbar-menu,.docstring>section>a.hero.docs-sourcelink .navbar-menu{background-color:#4eb5de}}.hero.is-primary .navbar-item,.docstring>section>a.hero.docs-sourcelink .navbar-item,.hero.is-primary .navbar-link,.docstring>section>a.hero.docs-sourcelink .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-primary a.navbar-item:hover,.docstring>section>a.hero.docs-sourcelink a.navbar-item:hover,.hero.is-primary a.navbar-item.is-active,.docstring>section>a.hero.docs-sourcelink a.navbar-item.is-active,.hero.is-primary .navbar-link:hover,.docstring>section>a.hero.docs-sourcelink .navbar-link:hover,.hero.is-primary .navbar-link.is-active,.docstring>section>a.hero.docs-sourcelink .navbar-link.is-active{background-color:#39acda;color:#fff}.hero.is-primary .tabs a,.docstring>section>a.hero.docs-sourcelink .tabs a{color:#fff;opacity:0.9}.hero.is-primary .tabs a:hover,.docstring>section>a.hero.docs-sourcelink .tabs a:hover{opacity:1}.hero.is-primary .tabs li.is-active a,.docstring>section>a.hero.docs-sourcelink .tabs li.is-active a{color:#4eb5de !important;opacity:1}.hero.is-primary .tabs.is-boxed a,.docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a,.hero.is-primary .tabs.is-toggle a,.docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a{color:#fff}.hero.is-primary .tabs.is-boxed a:hover,.docstring>section>a.hero.docs-sourcelink .tabs.is-boxed a:hover,.hero.is-primary .tabs.is-toggle a:hover,.docstring>section>a.hero.docs-sourcelink .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-primary .tabs.is-boxed li.is-active a,.docstring>section>a.hero.docs-sourcelink .tabs.is-boxed li.is-active a,.hero.is-primary .tabs.is-boxed li.is-active a:hover,.hero.is-primary .tabs.is-toggle li.is-active a,.docstring>section>a.hero.docs-sourcelink .tabs.is-toggle li.is-active a,.hero.is-primary .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#4eb5de}.hero.is-primary.is-bold,.docstring>section>a.hero.is-bold.docs-sourcelink{background-image:linear-gradient(141deg, #1bc7de 0%, #4eb5de 71%, #5fa9e7 100%)}@media screen and (max-width: 768px){.hero.is-primary.is-bold .navbar-menu,.docstring>section>a.hero.is-bold.docs-sourcelink .navbar-menu{background-image:linear-gradient(141deg, #1bc7de 0%, #4eb5de 71%, #5fa9e7 100%)}}.hero.is-link{background-color:#2e63b8;color:#fff}.hero.is-link a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-link strong{color:inherit}.hero.is-link .title{color:#fff}.hero.is-link .subtitle{color:rgba(255,255,255,0.9)}.hero.is-link .subtitle a:not(.button),.hero.is-link .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-link .navbar-menu{background-color:#2e63b8}}.hero.is-link .navbar-item,.hero.is-link .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-link a.navbar-item:hover,.hero.is-link a.navbar-item.is-active,.hero.is-link .navbar-link:hover,.hero.is-link .navbar-link.is-active{background-color:#2958a4;color:#fff}.hero.is-link .tabs a{color:#fff;opacity:0.9}.hero.is-link .tabs a:hover{opacity:1}.hero.is-link .tabs li.is-active a{color:#2e63b8 !important;opacity:1}.hero.is-link .tabs.is-boxed a,.hero.is-link .tabs.is-toggle a{color:#fff}.hero.is-link .tabs.is-boxed a:hover,.hero.is-link .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-link .tabs.is-boxed li.is-active a,.hero.is-link .tabs.is-boxed li.is-active a:hover,.hero.is-link .tabs.is-toggle li.is-active a,.hero.is-link .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#2e63b8}.hero.is-link.is-bold{background-image:linear-gradient(141deg, #1b6098 0%, #2e63b8 71%, #2d51d2 100%)}@media screen and (max-width: 768px){.hero.is-link.is-bold .navbar-menu{background-image:linear-gradient(141deg, #1b6098 0%, #2e63b8 71%, #2d51d2 100%)}}.hero.is-info{background-color:#3c5dcd;color:#fff}.hero.is-info a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-info strong{color:inherit}.hero.is-info .title{color:#fff}.hero.is-info .subtitle{color:rgba(255,255,255,0.9)}.hero.is-info .subtitle a:not(.button),.hero.is-info .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-info .navbar-menu{background-color:#3c5dcd}}.hero.is-info .navbar-item,.hero.is-info .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-info a.navbar-item:hover,.hero.is-info a.navbar-item.is-active,.hero.is-info .navbar-link:hover,.hero.is-info .navbar-link.is-active{background-color:#3151bf;color:#fff}.hero.is-info .tabs a{color:#fff;opacity:0.9}.hero.is-info .tabs a:hover{opacity:1}.hero.is-info .tabs li.is-active a{color:#3c5dcd !important;opacity:1}.hero.is-info .tabs.is-boxed a,.hero.is-info .tabs.is-toggle a{color:#fff}.hero.is-info .tabs.is-boxed a:hover,.hero.is-info .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-info .tabs.is-boxed li.is-active a,.hero.is-info .tabs.is-boxed li.is-active a:hover,.hero.is-info .tabs.is-toggle li.is-active a,.hero.is-info .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#3c5dcd}.hero.is-info.is-bold{background-image:linear-gradient(141deg, #215bb5 0%, #3c5dcd 71%, #4b53d8 100%)}@media screen and (max-width: 768px){.hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #215bb5 0%, #3c5dcd 71%, #4b53d8 100%)}}.hero.is-success{background-color:#259a12;color:#fff}.hero.is-success a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-success strong{color:inherit}.hero.is-success .title{color:#fff}.hero.is-success .subtitle{color:rgba(255,255,255,0.9)}.hero.is-success .subtitle a:not(.button),.hero.is-success .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-success .navbar-menu{background-color:#259a12}}.hero.is-success .navbar-item,.hero.is-success .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-success a.navbar-item:hover,.hero.is-success a.navbar-item.is-active,.hero.is-success .navbar-link:hover,.hero.is-success .navbar-link.is-active{background-color:#20830f;color:#fff}.hero.is-success .tabs a{color:#fff;opacity:0.9}.hero.is-success .tabs a:hover{opacity:1}.hero.is-success .tabs li.is-active a{color:#259a12 !important;opacity:1}.hero.is-success .tabs.is-boxed a,.hero.is-success .tabs.is-toggle a{color:#fff}.hero.is-success .tabs.is-boxed a:hover,.hero.is-success .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-success .tabs.is-boxed li.is-active a,.hero.is-success .tabs.is-boxed li.is-active a:hover,.hero.is-success .tabs.is-toggle li.is-active a,.hero.is-success .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#259a12}.hero.is-success.is-bold{background-image:linear-gradient(141deg, #287207 0%, #259a12 71%, #10b614 100%)}@media screen and (max-width: 768px){.hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #287207 0%, #259a12 71%, #10b614 100%)}}.hero.is-warning{background-color:#a98800;color:#fff}.hero.is-warning a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-warning strong{color:inherit}.hero.is-warning .title{color:#fff}.hero.is-warning .subtitle{color:rgba(255,255,255,0.9)}.hero.is-warning .subtitle a:not(.button),.hero.is-warning .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-warning .navbar-menu{background-color:#a98800}}.hero.is-warning .navbar-item,.hero.is-warning .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-warning a.navbar-item:hover,.hero.is-warning a.navbar-item.is-active,.hero.is-warning .navbar-link:hover,.hero.is-warning .navbar-link.is-active{background-color:#8f7300;color:#fff}.hero.is-warning .tabs a{color:#fff;opacity:0.9}.hero.is-warning .tabs a:hover{opacity:1}.hero.is-warning .tabs li.is-active a{color:#a98800 !important;opacity:1}.hero.is-warning .tabs.is-boxed a,.hero.is-warning .tabs.is-toggle a{color:#fff}.hero.is-warning .tabs.is-boxed a:hover,.hero.is-warning .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-warning .tabs.is-boxed li.is-active a,.hero.is-warning .tabs.is-boxed li.is-active a:hover,.hero.is-warning .tabs.is-toggle li.is-active a,.hero.is-warning .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#a98800}.hero.is-warning.is-bold{background-image:linear-gradient(141deg, #764b00 0%, #a98800 71%, #c2bd00 100%)}@media screen and (max-width: 768px){.hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #764b00 0%, #a98800 71%, #c2bd00 100%)}}.hero.is-danger{background-color:#cb3c33;color:#fff}.hero.is-danger a:not(.button):not(.dropdown-item):not(.tag):not(.pagination-link.is-current),.hero.is-danger strong{color:inherit}.hero.is-danger .title{color:#fff}.hero.is-danger .subtitle{color:rgba(255,255,255,0.9)}.hero.is-danger .subtitle a:not(.button),.hero.is-danger .subtitle strong{color:#fff}@media screen and (max-width: 1055px){.hero.is-danger .navbar-menu{background-color:#cb3c33}}.hero.is-danger .navbar-item,.hero.is-danger .navbar-link{color:rgba(255,255,255,0.7)}.hero.is-danger a.navbar-item:hover,.hero.is-danger a.navbar-item.is-active,.hero.is-danger .navbar-link:hover,.hero.is-danger .navbar-link.is-active{background-color:#b7362e;color:#fff}.hero.is-danger .tabs a{color:#fff;opacity:0.9}.hero.is-danger .tabs a:hover{opacity:1}.hero.is-danger .tabs li.is-active a{color:#cb3c33 !important;opacity:1}.hero.is-danger .tabs.is-boxed a,.hero.is-danger .tabs.is-toggle a{color:#fff}.hero.is-danger .tabs.is-boxed a:hover,.hero.is-danger .tabs.is-toggle a:hover{background-color:rgba(10,10,10,0.1)}.hero.is-danger .tabs.is-boxed li.is-active a,.hero.is-danger .tabs.is-boxed li.is-active a:hover,.hero.is-danger .tabs.is-toggle li.is-active a,.hero.is-danger .tabs.is-toggle li.is-active a:hover{background-color:#fff;border-color:#fff;color:#cb3c33}.hero.is-danger.is-bold{background-image:linear-gradient(141deg, #ac1f2e 0%, #cb3c33 71%, #d66341 100%)}@media screen and (max-width: 768px){.hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #ac1f2e 0%, #cb3c33 71%, #d66341 100%)}}.hero.is-small .hero-body,#documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding:1.5rem}@media screen and (min-width: 769px),print{.hero.is-medium .hero-body{padding:9rem 4.5rem}}@media screen and (min-width: 769px),print{.hero.is-large .hero-body{padding:18rem 6rem}}.hero.is-halfheight .hero-body,.hero.is-fullheight .hero-body,.hero.is-fullheight-with-navbar .hero-body{align-items:center;display:flex}.hero.is-halfheight .hero-body>.container,.hero.is-fullheight .hero-body>.container,.hero.is-fullheight-with-navbar .hero-body>.container{flex-grow:1;flex-shrink:1}.hero.is-halfheight{min-height:50vh}.hero.is-fullheight{min-height:100vh}.hero-video{overflow:hidden}.hero-video video{left:50%;min-height:100%;min-width:100%;position:absolute;top:50%;transform:translate3d(-50%, -50%, 0)}.hero-video.is-transparent{opacity:0.3}@media screen and (max-width: 768px){.hero-video{display:none}}.hero-buttons{margin-top:1.5rem}@media screen and (max-width: 768px){.hero-buttons .button{display:flex}.hero-buttons .button:not(:last-child){margin-bottom:0.75rem}}@media screen and (min-width: 769px),print{.hero-buttons{display:flex;justify-content:center}.hero-buttons .button:not(:last-child){margin-right:1.5rem}}.hero-head,.hero-foot{flex-grow:0;flex-shrink:0}.hero-body{flex-grow:1;flex-shrink:0;padding:3rem 1.5rem}@media screen and (min-width: 769px),print{.hero-body{padding:3rem 3rem}}.section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){.section{padding:3rem 3rem}.section.is-medium{padding:9rem 4.5rem}.section.is-large{padding:18rem 6rem}}.footer{background-color:#fafafa;padding:3rem 1.5rem 6rem}h1 .docs-heading-anchor,h1 .docs-heading-anchor:hover,h1 .docs-heading-anchor:visited,h2 .docs-heading-anchor,h2 .docs-heading-anchor:hover,h2 .docs-heading-anchor:visited,h3 .docs-heading-anchor,h3 .docs-heading-anchor:hover,h3 .docs-heading-anchor:visited,h4 .docs-heading-anchor,h4 .docs-heading-anchor:hover,h4 .docs-heading-anchor:visited,h5 .docs-heading-anchor,h5 .docs-heading-anchor:hover,h5 .docs-heading-anchor:visited,h6 .docs-heading-anchor,h6 .docs-heading-anchor:hover,h6 .docs-heading-anchor:visited{color:#222}h1 .docs-heading-anchor-permalink,h2 .docs-heading-anchor-permalink,h3 .docs-heading-anchor-permalink,h4 .docs-heading-anchor-permalink,h5 .docs-heading-anchor-permalink,h6 .docs-heading-anchor-permalink{visibility:hidden;vertical-align:middle;margin-left:0.5em;font-size:0.7rem}h1 .docs-heading-anchor-permalink::before,h2 .docs-heading-anchor-permalink::before,h3 .docs-heading-anchor-permalink::before,h4 .docs-heading-anchor-permalink::before,h5 .docs-heading-anchor-permalink::before,h6 .docs-heading-anchor-permalink::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f0c1"}h1:hover .docs-heading-anchor-permalink,h2:hover .docs-heading-anchor-permalink,h3:hover .docs-heading-anchor-permalink,h4:hover .docs-heading-anchor-permalink,h5:hover .docs-heading-anchor-permalink,h6:hover .docs-heading-anchor-permalink{visibility:visible}.docs-dark-only{display:none !important}pre{position:relative;overflow:hidden}pre code,pre code.hljs{padding:0 .75rem !important;overflow:auto;display:block}pre code:first-of-type,pre code.hljs:first-of-type{padding-top:0.5rem !important}pre code:last-of-type,pre code.hljs:last-of-type{padding-bottom:0.5rem !important}pre .copy-button{opacity:0.2;transition:opacity 0.2s;position:absolute;right:0em;top:0em;padding:0.5em;width:2.5em;height:2.5em;background:transparent;border:none;font-family:"Font Awesome 6 Free";color:#222;cursor:pointer;text-align:center}pre .copy-button:focus,pre .copy-button:hover{opacity:1;background:rgba(34,34,34,0.1);color:#2e63b8}pre .copy-button.success{color:#259a12;opacity:1}pre .copy-button.error{color:#cb3c33;opacity:1}pre:hover .copy-button{opacity:1}.admonition{background-color:#f5f5f5;border-style:solid;border-width:2px;border-color:#4a4a4a;border-radius:4px;font-size:1rem}.admonition strong{color:currentColor}.admonition.is-small,#documenter .docs-sidebar form.docs-search>input.admonition{font-size:.75rem}.admonition.is-medium{font-size:1.25rem}.admonition.is-large{font-size:1.5rem}.admonition.is-default{background-color:#f5f5f5;border-color:#4a4a4a}.admonition.is-default>.admonition-header{background-color:rgba(0,0,0,0);color:#4a4a4a}.admonition.is-default>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-info{background-color:#f5f5f5;border-color:#3c5dcd}.admonition.is-info>.admonition-header{background-color:rgba(0,0,0,0);color:#3c5dcd}.admonition.is-info>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-success{background-color:#f5f5f5;border-color:#259a12}.admonition.is-success>.admonition-header{background-color:rgba(0,0,0,0);color:#259a12}.admonition.is-success>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-warning{background-color:#f5f5f5;border-color:#a98800}.admonition.is-warning>.admonition-header{background-color:rgba(0,0,0,0);color:#a98800}.admonition.is-warning>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-danger{background-color:#f5f5f5;border-color:#cb3c33}.admonition.is-danger>.admonition-header{background-color:rgba(0,0,0,0);color:#cb3c33}.admonition.is-danger>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-compat{background-color:#f5f5f5;border-color:#3489da}.admonition.is-compat>.admonition-header{background-color:rgba(0,0,0,0);color:#3489da}.admonition.is-compat>.admonition-body{color:rgba(0,0,0,0.7)}.admonition-header{color:#4a4a4a;background-color:rgba(0,0,0,0);align-items:center;font-weight:700;justify-content:space-between;line-height:1.25;padding:0.5rem .75rem;position:relative}.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}details.admonition.is-details>.admonition-header{list-style:none}details.admonition.is-details>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f055"}details.admonition.is-details[open]>.admonition-header:before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f056"}.admonition-body{color:#222;padding:0.5rem .75rem}.admonition-body pre{background-color:#f5f5f5}.admonition-body code{background-color:rgba(0,0,0,0.05)}.docstring{margin-bottom:1em;background-color:rgba(0,0,0,0);border:2px solid #dbdbdb;border-radius:4px;box-shadow:2px 2px 3px rgba(10,10,10,0.1);max-width:100%}.docstring>header{cursor:pointer;display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#f5f5f5;box-shadow:0 0.125em 0.25em rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #dbdbdb;overflow:auto}.docstring>header code{background-color:transparent}.docstring>header .docstring-article-toggle-button{min-width:1.1rem;padding:0.2rem 0.2rem 0.2rem 0}.docstring>header .docstring-binding{margin-right:0.3em}.docstring>header .docstring-category{margin-left:0.3em}.docstring>section{position:relative;padding:.75rem .75rem;border-bottom:1px solid #dbdbdb}.docstring>section:last-child{border-bottom:none}.docstring>section>a.docs-sourcelink{transition:opacity 0.3s;opacity:0;position:absolute;right:.375rem;bottom:.375rem}.docstring>section>a.docs-sourcelink:focus{opacity:1 !important}.docstring:hover>section>a.docs-sourcelink{opacity:0.2}.docstring:focus-within>section>a.docs-sourcelink{opacity:0.2}.docstring>section:hover a.docs-sourcelink{opacity:1}.documenter-example-output{background-color:#fff}.outdated-warning-overlay{position:fixed;top:0;left:0;right:0;box-shadow:0 0 10px rgba(0,0,0,0.3);z-index:999;background-color:#f5f5f5;color:rgba(0,0,0,0.7);border-bottom:3px solid rgba(0,0,0,0);padding:10px 35px;text-align:center;font-size:15px}.outdated-warning-overlay .outdated-warning-closer{position:absolute;top:calc(50% - 10px);right:18px;cursor:pointer;width:12px}.outdated-warning-overlay a{color:#2e63b8}.outdated-warning-overlay a:hover{color:#363636}.content pre{border:2px solid #dbdbdb;border-radius:4px}.content code{font-weight:inherit}.content a code{color:#2e63b8}.content a:hover code{color:#363636}.content h1 code,.content h2 code,.content h3 code,.content h4 code,.content h5 code,.content h6 code{color:#222}.content table{display:block;width:initial;max-width:100%;overflow-x:auto}.content blockquote>ul:first-child,.content blockquote>ol:first-child,.content .admonition-body>ul:first-child,.content .admonition-body>ol:first-child{margin-top:0}pre,code{font-variant-ligatures:no-contextual}.breadcrumb a.is-disabled{cursor:default;pointer-events:none}.breadcrumb a.is-disabled,.breadcrumb a.is-disabled:hover{color:#222}.hljs{background:initial !important}.katex .katex-mathml{top:0;right:0}.katex-display,mjx-container,.MathJax_Display{margin:0.5em 0 !important}html{-moz-osx-font-smoothing:auto;-webkit-font-smoothing:auto}li.no-marker{list-style:none}#documenter .docs-main>article{overflow-wrap:break-word}#documenter .docs-main>article .math-container{overflow-x:auto;overflow-y:hidden}@media screen and (min-width: 1056px){#documenter .docs-main{max-width:52rem;margin-left:20rem;padding-right:1rem}}@media screen and (max-width: 1055px){#documenter .docs-main{width:100%}#documenter .docs-main>article{max-width:52rem;margin-left:auto;margin-right:auto;margin-bottom:1rem;padding:0 1rem}#documenter .docs-main>header,#documenter .docs-main>nav{max-width:100%;width:100%;margin:0}}#documenter .docs-main header.docs-navbar{background-color:#fff;border-bottom:1px solid #dbdbdb;z-index:2;min-height:4rem;margin-bottom:1rem;display:flex}#documenter .docs-main header.docs-navbar .breadcrumb{flex-grow:1;overflow-x:hidden}#documenter .docs-main header.docs-navbar .docs-sidebar-button{display:block;font-size:1.5rem;padding-bottom:0.1rem;margin-right:1rem}#documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap;gap:1rem;align-items:center}#documenter .docs-main header.docs-navbar .docs-right .docs-icon,#documenter .docs-main header.docs-navbar .docs-right .docs-label{display:inline-block}#documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}@media screen and (max-width: 1055px){#documenter .docs-main header.docs-navbar .docs-right .docs-navbar-link{margin-left:0.4rem;margin-right:0.4rem}}#documenter .docs-main header.docs-navbar>*{margin:auto 0}@media screen and (max-width: 1055px){#documenter .docs-main header.docs-navbar{position:sticky;top:0;padding:0 1rem;transition-property:top, box-shadow;-webkit-transition-property:top, box-shadow;transition-duration:0.3s;-webkit-transition-duration:0.3s}#documenter .docs-main header.docs-navbar.headroom--not-top{box-shadow:.2rem 0rem .4rem #bbb;transition-duration:0.7s;-webkit-transition-duration:0.7s}#documenter .docs-main header.docs-navbar.headroom--unpinned.headroom--not-top.headroom--not-bottom{top:-4.5rem;transition-duration:0.7s;-webkit-transition-duration:0.7s}}#documenter .docs-main section.footnotes{border-top:1px solid #dbdbdb}#documenter .docs-main section.footnotes li .tag:first-child,#documenter .docs-main section.footnotes li .docstring>section>a.docs-sourcelink:first-child,#documenter .docs-main section.footnotes li .content kbd:first-child,.content #documenter .docs-main section.footnotes li kbd:first-child{margin-right:1em;margin-bottom:0.4em}#documenter .docs-main .docs-footer{display:flex;flex-wrap:wrap;margin-left:0;margin-right:0;border-top:1px solid #dbdbdb;padding-top:1rem;padding-bottom:1rem}@media screen and (max-width: 1055px){#documenter .docs-main .docs-footer{padding-left:1rem;padding-right:1rem}}#documenter .docs-main .docs-footer .docs-footer-nextpage,#documenter .docs-main .docs-footer .docs-footer-prevpage{flex-grow:1}#documenter .docs-main .docs-footer .docs-footer-nextpage{text-align:right}#documenter .docs-main .docs-footer .flexbox-break{flex-basis:100%;height:0}#documenter .docs-main .docs-footer .footer-message{font-size:0.8em;margin:0.5em auto 0 auto;text-align:center}#documenter .docs-sidebar{display:flex;flex-direction:column;color:#0a0a0a;background-color:#f5f5f5;border-right:1px solid #dbdbdb;padding:0;flex:0 0 18rem;z-index:5;font-size:1rem;position:fixed;left:-18rem;width:18rem;height:100%;transition:left 0.3s}#documenter .docs-sidebar.visible{left:0;box-shadow:.4rem 0rem .8rem #bbb}@media screen and (min-width: 1056px){#documenter .docs-sidebar.visible{box-shadow:none}}@media screen and (min-width: 1056px){#documenter .docs-sidebar{left:0;top:0}}#documenter .docs-sidebar .docs-logo{margin-top:1rem;padding:0 1rem}#documenter .docs-sidebar .docs-logo>img{max-height:6rem;margin:auto}#documenter .docs-sidebar .docs-package-name{flex-shrink:0;font-size:1.5rem;font-weight:700;text-align:center;white-space:nowrap;overflow:hidden;padding:0.5rem 0}#documenter .docs-sidebar .docs-package-name .docs-autofit{max-width:16.2rem}#documenter .docs-sidebar .docs-package-name a,#documenter .docs-sidebar .docs-package-name a:hover{color:#0a0a0a}#documenter .docs-sidebar .docs-version-selector{border-top:1px solid #dbdbdb;display:none;padding:0.5rem}#documenter .docs-sidebar .docs-version-selector.visible{display:flex}#documenter .docs-sidebar ul.docs-menu{flex-grow:1;user-select:none;border-top:1px solid #dbdbdb;padding-bottom:1.5rem}#documenter .docs-sidebar ul.docs-menu>li>.tocitem{font-weight:bold}#documenter .docs-sidebar ul.docs-menu>li li{font-size:.95rem;margin-left:1em;border-left:1px solid #dbdbdb}#documenter .docs-sidebar ul.docs-menu input.collapse-toggle{display:none}#documenter .docs-sidebar ul.docs-menu ul.collapsed{display:none}#documenter .docs-sidebar ul.docs-menu input:checked~ul.collapsed{display:block}#documenter .docs-sidebar ul.docs-menu label.tocitem{display:flex}#documenter .docs-sidebar ul.docs-menu label.tocitem .docs-label{flex-grow:2}#documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron{display:inline-block;font-style:normal;font-variant:normal;text-rendering:auto;line-height:1;font-size:.75rem;margin-left:1rem;margin-top:auto;margin-bottom:auto}#documenter .docs-sidebar ul.docs-menu label.tocitem .docs-chevron::before{font-family:"Font Awesome 6 Free";font-weight:900;content:"\f054"}#documenter .docs-sidebar ul.docs-menu input:checked~label.tocitem .docs-chevron::before{content:"\f078"}#documenter .docs-sidebar ul.docs-menu .tocitem{display:block;padding:0.5rem 0.5rem}#documenter .docs-sidebar ul.docs-menu .tocitem,#documenter .docs-sidebar ul.docs-menu .tocitem:hover{color:#0a0a0a;background:#f5f5f5}#documenter .docs-sidebar ul.docs-menu a.tocitem:hover,#documenter .docs-sidebar ul.docs-menu label.tocitem:hover{color:#0a0a0a;background-color:#ebebeb}#documenter .docs-sidebar ul.docs-menu li.is-active{border-top:1px solid #dbdbdb;border-bottom:1px solid #dbdbdb;background-color:#fff}#documenter .docs-sidebar ul.docs-menu li.is-active .tocitem,#documenter .docs-sidebar ul.docs-menu li.is-active .tocitem:hover{background-color:#fff;color:#0a0a0a}#documenter .docs-sidebar ul.docs-menu li.is-active ul.internal .tocitem:hover{background-color:#ebebeb;color:#0a0a0a}#documenter .docs-sidebar ul.docs-menu>li.is-active:first-child{border-top:none}#documenter .docs-sidebar ul.docs-menu ul.internal{margin:0 0.5rem 0.5rem;border-top:1px solid #dbdbdb}#documenter .docs-sidebar ul.docs-menu ul.internal li{font-size:.85rem;border-left:none;margin-left:0;margin-top:0.5rem}#documenter .docs-sidebar ul.docs-menu ul.internal .tocitem{width:100%;padding:0}#documenter .docs-sidebar ul.docs-menu ul.internal .tocitem::before{content:"⚬";margin-right:0.4em}#documenter .docs-sidebar form.docs-search{margin:auto;margin-top:0.5rem;margin-bottom:0.5rem}#documenter .docs-sidebar form.docs-search>input{width:14.4rem}#documenter .docs-sidebar #documenter-search-query{color:#707070;width:14.4rem;box-shadow:inset 0 1px 2px rgba(10,10,10,0.1)}@media screen and (min-width: 1056px){#documenter .docs-sidebar ul.docs-menu{overflow-y:auto;-webkit-overflow-scroll:touch}#documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar{width:.3rem;background:none}#documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#e0e0e0}#documenter .docs-sidebar ul.docs-menu::-webkit-scrollbar-thumb:hover{background:#ccc}}@media screen and (max-width: 1055px){#documenter .docs-sidebar{overflow-y:auto;-webkit-overflow-scroll:touch}#documenter .docs-sidebar::-webkit-scrollbar{width:.3rem;background:none}#documenter .docs-sidebar::-webkit-scrollbar-thumb{border-radius:5px 0px 0px 5px;background:#e0e0e0}#documenter .docs-sidebar::-webkit-scrollbar-thumb:hover{background:#ccc}}kbd.search-modal-key-hints{border-radius:0.25rem;border:1px solid rgba(0,0,0,0.6);box-shadow:0 2px 0 1px rgba(0,0,0,0.6);cursor:default;font-size:0.9rem;line-height:1.5;min-width:0.75rem;text-align:center;padding:0.1rem 0.3rem;position:relative;top:-1px}.search-min-width-50{min-width:50%}.search-min-height-100{min-height:100%}.search-modal-card-body{max-height:calc(100vh - 15rem)}.search-result-link{border-radius:0.7em;transition:all 300ms}.search-result-link:hover,.search-result-link:focus{background-color:rgba(0,128,128,0.1)}.search-result-link .property-search-result-badge,.search-result-link .search-filter{transition:all 300ms}.property-search-result-badge,.search-filter{padding:0.15em 0.5em;font-size:0.8em;font-style:italic;text-transform:none !important;line-height:1.5;color:#f5f5f5;background-color:rgba(51,65,85,0.501961);border-radius:0.6rem}.search-result-link:hover .property-search-result-badge,.search-result-link:hover .search-filter,.search-result-link:focus .property-search-result-badge,.search-result-link:focus .search-filter{color:#f1f5f9;background-color:#333}.search-filter{color:#333;background-color:#f5f5f5;transition:all 300ms}.search-filter:hover,.search-filter:focus{color:#333}.search-filter-selected{color:#f5f5f5;background-color:rgba(139,0,139,0.5)}.search-filter-selected:hover,.search-filter-selected:focus{color:#f5f5f5}.search-result-highlight{background-color:#ffdd57;color:black}.search-divider{border-bottom:1px solid #dbdbdb}.search-result-title{width:85%;color:#333}.search-result-code-title{font-size:0.875rem;font-family:"JuliaMono","SFMono-Regular","Menlo","Consolas","Liberation Mono","DejaVu Sans Mono",monospace}#search-modal .modal-card-body::-webkit-scrollbar,#search-modal .filter-tabs::-webkit-scrollbar{height:10px;width:10px;background-color:transparent}#search-modal .modal-card-body::-webkit-scrollbar-thumb,#search-modal .filter-tabs::-webkit-scrollbar-thumb{background-color:gray;border-radius:1rem}#search-modal .modal-card-body::-webkit-scrollbar-track,#search-modal .filter-tabs::-webkit-scrollbar-track{-webkit-box-shadow:inset 0 0 6px rgba(0,0,0,0.6);background-color:transparent}.w-100{width:100%}.gap-2{gap:0.5rem}.gap-4{gap:1rem}.gap-8{gap:2rem}.ansi span.sgr1{font-weight:bolder}.ansi span.sgr2{font-weight:lighter}.ansi span.sgr3{font-style:italic}.ansi span.sgr4{text-decoration:underline}.ansi span.sgr7{color:#fff;background-color:#222}.ansi span.sgr8{color:transparent}.ansi span.sgr8 span{color:transparent}.ansi span.sgr9{text-decoration:line-through}.ansi span.sgr30{color:#242424}.ansi span.sgr31{color:#a7201f}.ansi span.sgr32{color:#066f00}.ansi span.sgr33{color:#856b00}.ansi span.sgr34{color:#2149b0}.ansi span.sgr35{color:#7d4498}.ansi span.sgr36{color:#007989}.ansi span.sgr37{color:gray}.ansi span.sgr40{background-color:#242424}.ansi span.sgr41{background-color:#a7201f}.ansi span.sgr42{background-color:#066f00}.ansi span.sgr43{background-color:#856b00}.ansi span.sgr44{background-color:#2149b0}.ansi span.sgr45{background-color:#7d4498}.ansi span.sgr46{background-color:#007989}.ansi span.sgr47{background-color:gray}.ansi span.sgr90{color:#616161}.ansi span.sgr91{color:#cb3c33}.ansi span.sgr92{color:#0e8300}.ansi span.sgr93{color:#a98800}.ansi span.sgr94{color:#3c5dcd}.ansi span.sgr95{color:#9256af}.ansi span.sgr96{color:#008fa3}.ansi span.sgr97{color:#f5f5f5}.ansi span.sgr100{background-color:#616161}.ansi span.sgr101{background-color:#cb3c33}.ansi span.sgr102{background-color:#0e8300}.ansi span.sgr103{background-color:#a98800}.ansi span.sgr104{background-color:#3c5dcd}.ansi span.sgr105{background-color:#9256af}.ansi span.sgr106{background-color:#008fa3}.ansi span.sgr107{background-color:#f5f5f5}code.language-julia-repl>span.hljs-meta{color:#066f00;font-weight:bolder}/*! + Theme: Default + Description: Original highlight.js style + Author: (c) Ivan Sagalaev + Maintainer: @highlightjs/core-team + Website: https://highlightjs.org/ + License: see project LICENSE + Touched: 2021 +*/pre code.hljs{display:block;overflow-x:auto;padding:1em}code.hljs{padding:3px 5px}.hljs{background:#F3F3F3;color:#444}.hljs-comment{color:#697070}.hljs-tag,.hljs-punctuation{color:#444a}.hljs-tag .hljs-name,.hljs-tag .hljs-attr{color:#444}.hljs-keyword,.hljs-attribute,.hljs-selector-tag,.hljs-meta .hljs-keyword,.hljs-doctag,.hljs-name{font-weight:bold}.hljs-type,.hljs-string,.hljs-number,.hljs-selector-id,.hljs-selector-class,.hljs-quote,.hljs-template-tag,.hljs-deletion{color:#880000}.hljs-title,.hljs-section{color:#880000;font-weight:bold}.hljs-regexp,.hljs-symbol,.hljs-variable,.hljs-template-variable,.hljs-link,.hljs-selector-attr,.hljs-operator,.hljs-selector-pseudo{color:#ab5656}.hljs-literal{color:#695}.hljs-built_in,.hljs-bullet,.hljs-code,.hljs-addition{color:#397300}.hljs-meta{color:#1f7199}.hljs-meta .hljs-string{color:#38a}.hljs-emphasis{font-style:italic}.hljs-strong{font-weight:bold}.gap-4{gap:1rem} diff --git a/v0.16.1/assets/themeswap.js b/v0.16.1/assets/themeswap.js new file mode 100644 index 000000000..9f5eebe6a --- /dev/null +++ b/v0.16.1/assets/themeswap.js @@ -0,0 +1,84 @@ +// Small function to quickly swap out themes. Gets put into the tag.. +function set_theme_from_local_storage() { + // Initialize the theme to null, which means default + var theme = null; + // If the browser supports the localstorage and is not disabled then try to get the + // documenter theme + if (window.localStorage != null) { + // Get the user-picked theme from localStorage. May be `null`, which means the default + // theme. + theme = window.localStorage.getItem("documenter-theme"); + } + // Check if the users preference is for dark color scheme + var darkPreference = + window.matchMedia("(prefers-color-scheme: dark)").matches === true; + // Initialize a few variables for the loop: + // + // - active: will contain the index of the theme that should be active. Note that there + // is no guarantee that localStorage contains sane values. If `active` stays `null` + // we either could not find the theme or it is the default (primary) theme anyway. + // Either way, we then need to stick to the primary theme. + // + // - disabled: style sheets that should be disabled (i.e. all the theme style sheets + // that are not the currently active theme) + var active = null; + var disabled = []; + var primaryLightTheme = null; + var primaryDarkTheme = null; + for (var i = 0; i < document.styleSheets.length; i++) { + var ss = document.styleSheets[i]; + // The tag of each style sheet is expected to have a data-theme-name attribute + // which must contain the name of the theme. The names in localStorage much match this. + var themename = ss.ownerNode.getAttribute("data-theme-name"); + // attribute not set => non-theme stylesheet => ignore + if (themename === null) continue; + // To distinguish the default (primary) theme, it needs to have the data-theme-primary + // attribute set. + if (ss.ownerNode.getAttribute("data-theme-primary") !== null) { + primaryLightTheme = themename; + } + // Check if the theme is primary dark theme so that we could store its name in darkTheme + if (ss.ownerNode.getAttribute("data-theme-primary-dark") !== null) { + primaryDarkTheme = themename; + } + // If we find a matching theme (and it's not the default), we'll set active to non-null + if (themename === theme) active = i; + // Store the style sheets of inactive themes so that we could disable them + if (themename !== theme) disabled.push(ss); + } + var activeTheme = null; + if (active !== null) { + // If we did find an active theme, we'll (1) add the theme--$(theme) class to + document.getElementsByTagName("html")[0].className = "theme--" + theme; + activeTheme = theme; + } else { + // If we did _not_ find an active theme, then we need to fall back to the primary theme + // which can either be dark or light, depending on the user's OS preference. + var activeTheme = darkPreference ? primaryDarkTheme : primaryLightTheme; + // In case it somehow happens that the relevant primary theme was not found in the + // preceding loop, we abort without doing anything. + if (activeTheme === null) { + console.error("Unable to determine primary theme."); + return; + } + // When switching to the primary light theme, then we must not have a class name + // for the tag. That's only for non-primary or the primary dark theme. + if (darkPreference) { + document.getElementsByTagName("html")[0].className = + "theme--" + activeTheme; + } else { + document.getElementsByTagName("html")[0].className = ""; + } + } + for (var i = 0; i < document.styleSheets.length; i++) { + var ss = document.styleSheets[i]; + // The tag of each style sheet is expected to have a data-theme-name attribute + // which must contain the name of the theme. The names in localStorage much match this. + var themename = ss.ownerNode.getAttribute("data-theme-name"); + // attribute not set => non-theme stylesheet => ignore + if (themename === null) continue; + // we'll disable all the stylesheets, except for the active one + ss.disabled = !(themename == activeTheme); + } +} +set_theme_from_local_storage(); diff --git a/v0.16.1/assets/warner.js b/v0.16.1/assets/warner.js new file mode 100644 index 000000000..3f6f5d008 --- /dev/null +++ b/v0.16.1/assets/warner.js @@ -0,0 +1,52 @@ +function maybeAddWarning() { + // DOCUMENTER_NEWEST is defined in versions.js, DOCUMENTER_CURRENT_VERSION and DOCUMENTER_STABLE + // in siteinfo.js. + // If either of these are undefined something went horribly wrong, so we abort. + if ( + window.DOCUMENTER_NEWEST === undefined || + window.DOCUMENTER_CURRENT_VERSION === undefined || + window.DOCUMENTER_STABLE === undefined + ) { + return; + } + + // Current version is not a version number, so we can't tell if it's the newest version. Abort. + if (!/v(\d+\.)*\d+/.test(window.DOCUMENTER_CURRENT_VERSION)) { + return; + } + + // Current version is newest version, so no need to add a warning. + if (window.DOCUMENTER_NEWEST === window.DOCUMENTER_CURRENT_VERSION) { + return; + } + + // Add a noindex meta tag (unless one exists) so that search engines don't index this version of the docs. + if (document.body.querySelector('meta[name="robots"]') === null) { + const meta = document.createElement("meta"); + meta.name = "robots"; + meta.content = "noindex"; + + document.getElementsByTagName("head")[0].appendChild(meta); + } + + const div = document.createElement("div"); + div.classList.add("outdated-warning-overlay"); + const closer = document.createElement("button"); + closer.classList.add("outdated-warning-closer", "delete"); + closer.addEventListener("click", function () { + document.body.removeChild(div); + }); + const href = window.documenterBaseURL + "/../" + window.DOCUMENTER_STABLE; + div.innerHTML = + 'This documentation is not for the latest stable release, but for either the development version or an older release.
    Click here to go to the documentation for the latest stable release.'; + div.appendChild(closer); + document.body.appendChild(div); +} + +if (document.readyState === "loading") { + document.addEventListener("DOMContentLoaded", maybeAddWarning); +} else { + maybeAddWarning(); +} diff --git a/v0.16.1/common/3b6f9ba4.svg b/v0.16.1/common/3b6f9ba4.svg new file mode 100644 index 000000000..3d4b15742 --- /dev/null +++ b/v0.16.1/common/3b6f9ba4.svg @@ -0,0 +1,45 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/common/8737a707.svg b/v0.16.1/common/8737a707.svg new file mode 100644 index 000000000..27e2a5160 --- /dev/null +++ b/v0.16.1/common/8737a707.svg @@ -0,0 +1,124 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/common/a9f9e818.svg b/v0.16.1/common/a9f9e818.svg new file mode 100644 index 000000000..bc47de8c6 --- /dev/null +++ b/v0.16.1/common/a9f9e818.svg @@ -0,0 +1,46 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/common/b5b1223a.svg b/v0.16.1/common/b5b1223a.svg new file mode 100644 index 000000000..75fddd1c9 --- /dev/null +++ b/v0.16.1/common/b5b1223a.svg @@ -0,0 +1,45 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/common/e40a34be.svg b/v0.16.1/common/e40a34be.svg new file mode 100644 index 000000000..77aff2cc4 --- /dev/null +++ b/v0.16.1/common/e40a34be.svg @@ -0,0 +1,49 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/common/index.html b/v0.16.1/common/index.html new file mode 100644 index 000000000..00dff8956 --- /dev/null +++ b/v0.16.1/common/index.html @@ -0,0 +1,183 @@ + +Interoperability with DifferentialEquations.jl · TaylorIntegration.jl

    Interoperability with DifferentialEquations.jl

    Here, we show an example of interoperability between TaylorIntegration.jl and DifferentialEquations.jl, i.e., how to use TaylorIntegration.jl from the DifferentialEquations ecosystem. The basic requirement is to load OrdinaryDiffEq.jl together with TaylorIntegration.jl, which sets-up the common interface. Below, we shall also use OrdinaryDiffEq.jl to compare the accuracy of TaylorIntegration.jl with respect to high-accuracy methods for non-stiff problems (Vern9 method). While DifferentialEquations offers many macros to simplify certain aspects, we do not rely on them simply because using properly @taylorize improves the performance.

    Note

    Currently, the only keyword arguments supported by DiffEqBase.solve that are implemented in TaylorIntegration.jl are :saveat and :tstops. There is also experimental support for :callback, both discrete and continuous; some examples may be found in test/common.jl. The keyword argument :parse_eqs is available in order to control the use of methods defined via @taylorize.

    The problem we will integrate in this example is the planar circular restricted three-body problem (PCR3BP, also capitalized as PCRTBP). The PCR3BP describes the motion of a body with negligible mass $m_3$ under the gravitational influence of two bodies with masses $m_1$ and $m_2$, such that $m_1 \ge m_2$. It is assumed that $m_3$ is much smaller than the other two masses so it does not influence their motion, and therefore it is simply considered as a massless test particle. The body with the greater mass $m_1$ is referred as the primary, and $m_2$ as the secondary. These bodies are together called the primaries and are assumed to describe Keplerian circular orbits about their center of mass, which is placed at the origin of the reference frame. It is further assumed that the orbit of the third body takes place in the orbital plane of the primaries. A full treatment of the PCR3BP may be found in [1].

    The ratio $\mu = m_2/(m_1+m_2)$ is known as the mass parameter. Using mass units such that $m_1+m_2=1$, we have $m_1=1-\mu$ and $m_2=\mu$. In this example, we assume the mass parameter to have a value $\mu=0.01$.

    using Plots
    +
    +const μ = 0.01

    The Hamiltonian for the PCR3BP in the synodic frame (i.e., a frame which rotates such that the primaries are at rest on the $x$ axis) is

    \[H(x, y, p_x, p_y) = \frac{1}{2}(p_x^2+p_y^2) - (x p_y - y p_x) + V(x, y), \tag{1}\]

    where

    \[V(x, y) = - \frac{1-\mu}{\sqrt{(x-\mu)^2+y^2}} - \frac{\mu}{\sqrt{(x+1-\mu)^2+y^2}}.\tag{2}\]

    is the gravitational potential associated to the primaries. The RHS of Eq. (1) is also known as the Jacobi constant, since it is a preserved quantity of motion in the PCR3BP. We will use this property to check the accuracy of the solutions computed.

    V(x, y) = - (1-μ)/sqrt((x-μ)^2+y^2) - μ/sqrt((x+1-μ)^2+y^2)
    +H(x, y, px, py) = (px^2+py^2)/2 - (x*py-y*px) + V(x, y)
    +H(x) = H(x...)

    The equations of motion for the PCR3BP are

    \[\begin{aligned} + \dot{x} & = p_x + y,\\ + \dot{y} & = p_y - x,\\ + \dot{p_x} & = - \frac{(1-\mu)(x-\mu)}{((x-\mu)^2+y^2)^{3/2}} - \frac{\mu(x+1-\mu)}{((x+1-\mu)^2+y^2)^{3/2}} + p_y,\\ + \dot{p_y} & = - \frac{(1-\mu)y }{((x-\mu)^2+y^2)^{3/2}} - \frac{\mu y }{((x+1-\mu)^2+y^2)^{3/2}} - p_x. +\end{aligned}\]

    We define this system of ODEs in a way that allows the use of the @taylorize macro from TaylorIntegration.jl, which for the present example allows important speed-ups. For more details about the specifics of the use of @taylorize, see this section.

    using TaylorIntegration
    +@taylorize function pcr3bp!(dq, q, param, t)
    +    local μ = param[1]
    +    local onemμ = 1 - μ
    +    x1 = q[1]-μ
    +    x1sq = x1^2
    +    y = q[2]
    +    ysq = y^2
    +    r1_1p5 = (x1sq+ysq)^1.5
    +    x2 = q[1]+onemμ
    +    x2sq = x2^2
    +    r2_1p5 = (x2sq+ysq)^1.5
    +    dq[1] = q[3] + q[2]
    +    dq[2] = q[4] - q[1]
    +    dq[3] = (-((onemμ*x1)/r1_1p5) - ((μ*x2)/r2_1p5)) + q[4]
    +    dq[4] = (-((onemμ*y )/r1_1p5) - ((μ*y )/r2_1p5)) - q[3]
    +    return nothing
    +end

    We shall define the initial conditions $q_0 = (x_0, y_0, p_{x,0}, p_{y,0})$ such that $H(q_0) = J_0$, where $J_0$ is a prescribed value. In order to do this, we select $y_0 = p_{x,0} = 0$ and compute the value of $p_{y,0}$ for which $H(q_0) = J_0$ holds.

    We consider a value for $J_0$ such that the test particle is able to display close encounters with both primaries, but cannot escape to infinity. We may obtain a first approximation to the desired value of $J_0$ if we plot the projection of the zero-velocity curves on the $x$-axis.

    ZVC(x) =  -x^2/2 + V(x, zero(x)) # projection of the zero-velocity curves on the x-axis
    +
    +plot(ZVC, -2:0.001:2, label="zero-vel. curve", legend=:topleft, fmt = :png)
    +plot!([-2, 2], [-1.58, -1.58], label="J0 = -1.58")
    +ylims!(-1.7, -1.45)
    +xlabel!("x")
    +ylabel!("J")
    +title!("Zero-velocity curves (x-axis projection)")
    Example block output

    Notice that the maxima in the plot correspond to the Lagrangian points $L_1$, $L_2$ and $L_3$; below we shall concentrate in the value $J_0 = -1.58$.

    J0 = -1.58

    We define a function py!, which depends on the initial condition $q_0 = (x_0, 0, 0, p_{y,0})$ and the Jacobi constant value $J_0$, such that it computes an adequate value $p_{y,0}$ for which we have $H(q_0)=J_0$ and updates (in-place) the initial condition accordingly.

    function py!(q0, J0)
    +    @assert iszero(q0[2]) && iszero(q0[3]) # q0[2] and q0[3] have to be equal to zero
    +    q0[4] = q0[1] + sqrt( q0[1]^2-2( V(q0[1], q0[2])-J0 ) )
    +    nothing
    +end

    We are now ready to generate an appropriate initial condition.

    q0 = [-0.8, 0.0, 0.0, 0.0]
    +py!(q0, J0)
    +q0
    4-element Vector{Float64}:
    + -0.8
    +  0.0
    +  0.0
    + -0.6276410653920694

    We note that the value of q0 has been updated. We can check that the value of the Hamiltonian evaluated at the initial condition is indeed equal to J0.

    H(q0) == J0
    true

    Following the DifferentialEquations.jl tutorial, we define an ODEProblem for the integration; TaylorIntegration can be used via its common interface bindings with OrdinaryDiffEq.jl; both packages need to be loaded explicitly.

    tspan = (0.0, 2000.0)
    +p = [μ]
    +
    +using OrdinaryDiffEq
    +prob = ODEProblem(pcr3bp!, q0, tspan, p)
    ODEProblem with uType Vector{Float64} and tType Float64. In-place: true
    +timespan: (0.0, 2000.0)
    +u0: 4-element Vector{Float64}:
    + -0.8
    +  0.0
    +  0.0
    + -0.6276410653920694

    We solve prob using a 25-th order Taylor method, with a local absolute tolerance $\epsilon_\mathrm{tol} = 10^{-15}$.

    solT = solve(prob, TaylorMethod(25), abstol=1e-15);
    retcode: Success
    +Interpolation: Taylor series polynomial evaluation
    +t: 19608-element Vector{Float64}:
    +    0.0
    +    0.13196071872716866
    +    0.27014676027774454
    +    0.42393639891281987
    +    0.6040489984083115
    +    0.7470888302887118
    +    0.8537154042859872
    +    0.9339017026636446
    +    0.9948376044666346
    +    1.041388851851968
    +    ⋮
    + 1999.5042725273079
    + 1999.5431825892883
    + 1999.585321353172
    + 1999.6333069204968
    + 1999.6900342956144
    + 1999.7583339712685
    + 1999.841241219841
    + 1999.9430374708056
    + 2000.0
    +u: 19608-element Vector{Vector{Float64}}:
    + [-0.8, 0.0, 0.0, -0.6276410653920694]
    + [-0.7932072459999212, 0.021999013383924005, 0.08140695643428739, -0.6377638461316928]
    + [-0.7711573074953806, 0.04021587810521527, 0.17675113719300067, -0.6688864600381992]
    + [-0.7274049294817609, 0.04873797433924279, 0.30569454759447606, -0.7263176192504541]
    + [-0.6471962297961017, 0.0339035917847401, 0.5097162066272879, -0.8242465081730088]
    + [-0.555741961444557, -0.004539329245841953, 0.7525448101567436, -0.9233378179280098]
    + [-0.4645151896861849, -0.05237933172838659, 1.0331768994048929, -0.99547157889477]
    + [-0.37557401376068666, -0.09959841168708136, 1.3584539352908696, -1.016191194976285]
    + [-0.2895689539623897, -0.13989162192605029, 1.7261635478522546, -0.9558013178409663]
    + [-0.20780076710609213, -0.1693782791151218, 2.1143731596742112, -0.7823572471371022]
    + ⋮
    + [-0.17496376257492635, -0.17162024831531136, 1.3853825963776936, -1.9910183910679593]
    + [-0.12304118303795919, -0.23591024736030314, 1.664519586011635, -1.6072083780763986]
    + [-0.06079568084101738, -0.2910297290272401, 1.7937412752512865, -1.201602071416007]
    + [0.010706160716735615, -0.33799420974483546, 1.8000388400926512, -0.8222349820550685]
    + [0.09036540182670252, -0.3776915547287994, 1.7168539805662775, -0.4948839982771776]
    + [0.1759176142431495, -0.4109734546288778, 1.5764514213719614, -0.2305013931376877]
    + [0.2641294989793357, -0.4393446214896214, 1.4058003373126944, -0.02725826011770835]
    + [0.3515484829667911, -0.46520091680777775, 1.2228269820636821, 0.12590172434120908]
    + [0.39178452468014624, -0.47746330663809045, 1.1343053892122903, 0.1855857869403744]

    As mentioned above, we will now solve the same problem prob with the Vern9 method from OrdinaryDiffEq, which the DifferentialEquations documentation recommends for high-accuracy (i.e., very low tolerance) integrations of non-stiff problems. Note that, besides setting an absolute tolerance abstol=1e-15, we're setting a relative tolerance reltol=1e-15 [2]. We have found that for the current problem this is a good balance between speed and accuracy for the Vern9 method, i.e., the Vern9 integration becomes noticeably slower (although more accurate) if either abstol or reltol are set to lower values.

    using OrdinaryDiffEq
    +
    +solV = solve(prob, Vern9(), abstol=1e-15, reltol=1e-15); #solve `prob` with the `Vern9` method
    retcode: Success
    +Interpolation: specialized 9th order lazy interpolation
    +t: 109969-element Vector{Float64}:
    +    0.0
    +    0.014218880460979355
    +    0.029254985035048104
    +    0.043100405390433874
    +    0.05734634963317922
    +    0.07358281996048438
    +    0.08944879825305627
    +    0.10587664107366627
    +    0.1226246832421739
    +    0.1435160589250072
    +    ⋮
    + 1999.8835158404124
    + 1999.8979213519083
    + 1999.9116672471735
    + 1999.9261589673808
    + 1999.941671239634
    + 1999.9563042419318
    + 1999.9717788474554
    + 1999.987747535878
    + 2000.0
    +u: 109969-element Vector{Vector{Float64}}:
    + [-0.8, 0.0, 0.0, -0.6276410653920694]
    + [-0.7999214879562981, 0.0024498152778736912, 0.00859413588182428, -0.6277599916692193]
    + [-0.7996675843508191, 0.005034208510608978, 0.017696409719266754, -0.6281442610049114]
    + [-0.7992782930574767, 0.007402685037193327, 0.026103506293378813, -0.6287324566601369]
    + [-0.7987218689531319, 0.00982280232842162, 0.034792021624444995, -0.6295711582485729]
    + [-0.797894470875534, 0.012553097170943344, 0.04475750864054082, -0.63081399178736]
    + [-0.7968864732598321, 0.015184680375190484, 0.0545768793929235, -0.6323213310978815]
    + [-0.7956341732152393, 0.017863254033671463, 0.06484608541850159, -0.634183992679585]
    + [-0.7941379505860766, 0.02053692742751024, 0.07544018310964262, -0.636395532591486]
    + [-0.7919590653442087, 0.023777693641981894, 0.08885831570084259, -0.6395904165292945]
    + ⋮
    + [-0.10036556390021033, -0.40881948168063087, 1.3263848652497512, -1.0339244230210929]
    + [-0.08720892823246354, -0.4219534753803598, 1.3306307677028557, -0.9775508905357453]
    + [-0.07478774834940205, -0.43392235178080524, 1.332218341540104, -0.9262738327498371]
    + [-0.0618595087150646, -0.4459796381322718, 1.33164440577699, -0.8748026893703007]
    + [-0.048236112287607984, -0.4582871679437302, 1.328841777142106, -0.8225447583250936]
    + [-0.03560926760707582, -0.46936547175800486, 1.3244363154112246, -0.7758223093021686]
    + [-0.022510911045455013, -0.480556024781558, 1.318210211953628, -0.7289957477163415]
    + [-0.009284187203683182, -0.4915754146264585, 1.3103724961844636, -0.6833061494007471]
    + [0.0006569134087038978, -0.49968918682462987, 1.303542664918598, -0.6499623338440916]

    We plot in the $x-y$ synodic plane the solution obtained with TaylorIntegration:

    plot(solT, vars=(1, 2), linewidth=1, fmt = :png)
    +scatter!([μ, -1+μ], [0,0], leg=false) # positions of the primaries
    +xlims!(-1+μ-0.2, 1+μ+0.2)
    +ylims!(-0.8, 0.8)
    +xlabel!("x")
    +ylabel!("y")
    Example block output

    Note that the orbit obtained displays the expected dynamics: the test particle explores the regions surrounding both primaries, located at the red dots, without escaping to infinity. For comparison, we now plot the orbit corresponding to the solution obtained with the Vern9() integration; note that the scales are identical.

    plot(solV, vars=(1, 2), linewidth=1, fmt = :png)
    +scatter!([μ, -1+μ], [0,0], leg=false) # positions of the primaries
    +xlims!(-1+μ-0.2, 1+μ+0.2)
    +ylims!(-0.8, 0.8)
    +xlabel!("x")
    +ylabel!("y")
    Example block output

    We note that both orbits display the same qualitative features, and also some differences. For instance, the TaylorMethod(25) solution gets closer to the primary than that the Vern9(). We can obtain a quantitative comparison of the validity of both integrations through the preservation of the Jacobi constant:

    ET = H.(solT.u)
    +EV = H.(solV.u)
    +δET = ET .- J0
    +δEV = EV .- J0

    We plot first the value of the Jacobi constant as function of time.

    plot(solT.t, H.(solT.u), label="TaylorMethod(25)", fmt = :png, yformatter = :plain)
    +plot!(solV.t, H.(solV.u), label="Vern9()")
    +xlabel!("t")
    +ylabel!("H")
    Example block output

    In the scale shown we observe that, while both solutions display a preservation of the Jacobi constant to a certain degree, the Vern9() solution suffers sudden jumps during the integration.

    We now plot, in log scale, the abs of the absolute error in the Jacobi constant as a function of time, for both solutions:

    plot(solT.t, abs.(δET), yscale=:log10, label="TaylorMethod(25)", legend=:topleft, fmt = :png, yformatter = :plain)
    +plot!(solV.t, abs.(δEV), label="Vern9()")
    +ylims!(10^-16, 10^-10)
    +xlabel!("t")
    +ylabel!("dE")
    Example block output

    We notice that the Jacobi constant absolute error for the TaylorMethod(25) solution remains bounded below $10^{-13}$ throughout the integration. While the Vern9() solution at the end of the integration time has reached a similar value, it displays a larger Jacobi constant error earlier in time.

    Finally, we comment on the time spent by each integration.

    using BenchmarkTools
    +bT = @benchmark solve($prob, $(TaylorMethod(25)), abstol=1e-15)
    +bV = @benchmark solve($prob, $(Vern9()), abstol=1e-15, reltol=1e-15)
    bT # TaylorMethod(25) benchmark
    BenchmarkTools.Trial: 51 samples with 1 evaluation.
    + Range (minmax):  96.099 ms117.861 ms   GC (min … max): 0.00% … 0.00%
    + Time  (median):     99.151 ms                GC (median):    0.00%
    + Time  (mean ± σ):   99.502 ms ±   3.505 ms   GC (mean ± σ):  0.00% ± 0.00%
    +
    +    ▁                                                          
    +  ▆██▁▁▁▁▁▁▅▆██▃▃▃▃▃▃▃▁▃▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▃ ▁
    +  96.1 ms         Histogram: frequency by time          111 ms <
    +
    + Memory estimate: 8.66 MiB, allocs estimate: 117851.
    bV # Vern9 benchmark
    BenchmarkTools.Trial: 20 samples with 1 evaluation.
    + Range (minmax):  214.910 ms646.478 ms   GC (min … max):  0.00% … 65.40%
    + Time  (median):     232.664 ms                GC (median):     0.00%
    + Time  (mean ± σ):   269.170 ms ±  97.274 ms   GC (mean ± σ):  15.87% ± 17.62%
    +
    +                                                                
    +  ▅▁▁▃▃▃▁▁▃▁▁▁▁▃▁▁▁▁▁▁▁▃▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▁▃ ▁
    +  215 ms           Histogram: frequency by time          646 ms <
    +
    + Memory estimate: 130.11 MiB, allocs estimate: 1319694.

    We notice in this setup, where the TaylorMethod(25) and the Vern9() integrations perform similarly in terms of accuracy, the former performs better in terms of runtime.

    We can tune the abstol and reltol for the Vern9() method we so that performance is similar. Such situation has an accuracy cost, which then makes TaylorIntegration a sensible alternative for high-accuracy integrations of non-stiff ODEs in some cases; see [2].

    Finally, as mentioned above, a crucial way in which TaylorIntegration provides high accuracy at competitive speeds is through the use of the @taylorize macro; see this section for details. Currently, TaylorIntegration supports the use of @taylorize via the common interface with DifferentialEquations only for in-place ODEProblem.

    References and notes

    [1] Murray, Carl D., Stanley F. Dermott. Solar System dynamics. Cambridge University Press, 1999.

    [2] SciMLBenchmarks.jl/DynamicalODE

    diff --git a/v0.16.1/index.html b/v0.16.1/index.html new file mode 100644 index 000000000..1db2c96d7 --- /dev/null +++ b/v0.16.1/index.html @@ -0,0 +1,5 @@ + +Home · TaylorIntegration.jl

    TaylorIntegration.jl

    ODE integration using Taylor's method, and more, in Julia.


    Authors

    • Jorge A. Pérez, Instituto de Ciencias Físicas, Universidad Nacional Autónoma de México (UNAM)
    • Luis Benet, Instituto de Ciencias Físicas, Universidad Nacional Autónoma de México (UNAM)

    License

    TaylorIntegration is licensed under the MIT "Expat" license.

    Installation

    TaylorIntegration.jl is a registered package, and is simply installed by running

    pkg> add TaylorIntegration

    Supporting and citing

    This package is developed as part of academic research. If you would like to help supporting it, please star the repository as such metrics may help us secure funding. If you use this software, we would be grateful if you could cite our work as follows (Bibtex entry can be found here):

    J.A. Pérez-Hernández and L. Benet
    +TaylorIntegration.jl: Taylor Integration in Julia
    +https://github.com/PerezHz/TaylorIntegration.jl
    +DOI:[10.5281/zenodo.2562352](https://doi.org/10.5281/zenodo.2562352)

    Acknowledgments

    We acknowledge financial support from the DGAPA-PAPIIT (UNAM) grant IG-100616. LB acknowledges support through a Cátedra Marcos Moshinsky (2013).

    diff --git a/v0.16.1/jet_transport/index.html b/v0.16.1/jet_transport/index.html new file mode 100644 index 000000000..026c33c2b --- /dev/null +++ b/v0.16.1/jet_transport/index.html @@ -0,0 +1,44 @@ + +Jet transport · TaylorIntegration.jl

    Jet transport

    In this section we describe the jet transport capabilities included in TaylorIntegration.jl. Jet transport is a tool that allows the propagation under the flow of a small neighborhood in phase space around a given initial condition, instead of propagating a single initial condition only.

    To compute the propagation of $\mathbf{x}_0 + \delta \mathbf{x}$, where $\delta \mathbf{x}$ are independent small displacements in phase space around the initial condition $\mathbf{x}_0$, one has to solve high-order variational equations. The idea is to treat $\mathbf{x}_0 + \delta \mathbf{x}$ as a truncated polynomial in the $\delta \mathbf{x}$ variables. The maximum order of this polynomial has to be fixed in advance.

    Jet transport works in general with any ordinary ODE solver, provided the chosen solver supports computations using multi-variate polynomial algebra.

    A simple example

    Following D. Pérez-Palau et al [1], let us consider the differential equations for the harmonic oscillator:

    \[\begin{aligned} +\dot{x} & = y, \\ +\dot{y} & = -x, +\end{aligned}\]

    with the initial condition $\mathbf{x}_0=[x_0, y_0]^T$. We illustrate jet transport techniques using Euler's method

    \[\mathbf{x}_{n+1} = \mathbf{x}_n + h \mathbf{f}(\mathbf{x}_n).\]

    Instead of considering the initial conditions $\mathbf{x}_0$, we consider the time evolution of the polynomial

    \[P_{0,\mathbf{x}_0}(\delta\mathbf{x}) = [x_0+\delta x, y_0 + \delta y]^T,\]

    where $\delta x$ and $\delta y$ are small displacements. Below we concentrate in polynomials of order 1 in $\delta x$ and $\delta y$; since the equations of motion of the harmonic oscillator are linear, there are no higher order terms.

    Using Euler's method we obtain

    \[\begin{aligned} + \mathbf{x}_1 & = + \left( + \begin{array}{c} + x_0 + h y_0 \\ + y_0 - h x_0 + \end{array} + \right) + + \left( + \begin{array}{cc} + 1 & h \\ + -h & 1 + \end{array} + \right) + \left( + \begin{array}{c} + \delta x\\ + \delta y + \end{array} + \right). \\ + \mathbf{x}_2 & = + \left( + \begin{array}{c} + 1-h^2 x_0 + 2 h y_0 \\ + 1-h^2 y_0 - 2 h x_0 + \end{array} + \right) + + \left( + \begin{array}{cc} + 1-h^2 & 2 h \\ + -2 h & 1-h^2 + \end{array} + \right) + \left( + \begin{array}{c} + \delta x\\ + \delta y + \end{array} + \right). +\end{aligned}\]

    The first terms in the expressions for $\mathbf{x}_1$ and $\mathbf{x}_2$ above correspond to the result of an Euler integration step using the initial conditions only. The other terms are the (linear) corrections which involve the small displacements $\delta x$ and $\delta y$.

    In general, for differential equations involving non-linear terms, the resulting expansions in $\delta x$ and $\delta y$ will reflect aspects of the non-linearities of the ODEs. Clearly, jet transport techniques allow to address stability properties beyond the linear case, though memory constraints may play a role. See this example illustrating the implementation for the simple pendulum, and this one illustrating the construction of a Poincaré map with Jet transport techniques.

    References

    [1] D. Pérez-Palau, Josep J. Masdemont, Gerard Gómez, 2015, Celest. Mech. Dyn. Astron. 123, 239.

    diff --git a/v0.16.1/kepler/4ca9fc7b.svg b/v0.16.1/kepler/4ca9fc7b.svg new file mode 100644 index 000000000..d30374b9a --- /dev/null +++ b/v0.16.1/kepler/4ca9fc7b.svg @@ -0,0 +1,48 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/kepler/c569d86a.svg b/v0.16.1/kepler/c569d86a.svg new file mode 100644 index 000000000..cd633fad8 --- /dev/null +++ b/v0.16.1/kepler/c569d86a.svg @@ -0,0 +1,46 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/kepler/fb89632a.svg b/v0.16.1/kepler/fb89632a.svg new file mode 100644 index 000000000..ad6dacca6 --- /dev/null +++ b/v0.16.1/kepler/fb89632a.svg @@ -0,0 +1,50 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/kepler/index.html b/v0.16.1/kepler/index.html new file mode 100644 index 000000000..de293867b --- /dev/null +++ b/v0.16.1/kepler/index.html @@ -0,0 +1,59 @@ + +The Kepler problem · TaylorIntegration.jl

    The Kepler problem

    The Kepler problem corresponds to the study of the motion of two bodies which are influenced by their mutual gravitational attraction. In the center of mass and relative coordinates, the problem is reduced to the motion of one body of mass $m = m_1 m_2 / M$, which we shall refer as particle below, attracted gravitationally by another located at rest at the origin of mass $M=m_1+m_2$.

    In cartesian coordinates, the equations of motion can be written as

    \[\begin{aligned} +\dot{x} & = v_x,\\ +\dot{y} & = v_y,\\ +\dot{v}_x & = - \frac{G M x}{(x^2 + y^2)^{3/2}},\\ +\dot{v}_y & = - \frac{G M y}{(x^2 + y^2)^{3/2}}. +\end{aligned}\]

    For concreteness, we fix $\mu = G M = 1$. The coordinates $x$ and $y$ are the relative coordinates (to the center of mass) of the particle, and $v_x$ and $v_y$ its velocity. The function kepler_eqs! mutates the vectors corresponding to the LHS of the equations of motion.

    function kepler_eqs!(dq, q, params, t)
    +    dq[1] = q[3]
    +    dq[2] = q[4]
    +    rr = ( q[1]^2 + q[2]^2 )^(3/2)
    +    dq[3] = - q[1] / rr
    +    dq[4] = - q[2] / rr
    +end;
    kepler_eqs! (generic function with 1 method)

    For suitable initial conditions (such that the total energy is negative) the solutions are ellipses with one focus at the origin, which can be parameterized in terms of its semi-major axis $a$ and its eccentricity $e$. We set the initial conditions for the particle at periapse, which we locate on the positive x-axis. Using the semimajor axis and the eccentricity, we write them as

    \[\begin{aligned} +x_0 & = a (1-e),\\ +y_0 & = 0,\\ +v_{x_0} & = 0,\\ +v_{y_0} & = \frac{l_z}{x_0} = m \frac{\sqrt{\mu a (1-e^2)}}{x_0}, +\end{aligned}\]

    where $l_z$ is the angular momentum. We set the mass of the particle $m=1$, the semi-major axis $a=1$ and the eccentricity $e=0.8$. Kepler's third law defines the period of the motion as $T= 2\pi a^{3/2}$.

    const mu = 1.0
    +const mass = 1.0
    +const aKep = 1.0
    +const eKep = 0.8;
    0.8

    The initial conditions are then set using ini_cond

    function ini_cond(a, e)
    +    x0  = a*(one(e)-e)
    +    vy0 = mass * sqrt( mu * a * (1-e^2) ) / x0
    +    y0  = zero(vy0)
    +    vx0 = zero(vy0)
    +    return [x0, y0, vx0, vy0]
    +end
    +q0 = ini_cond(aKep, eKep)
    4-element Vector{Float64}:
    + 0.19999999999999996
    + 0.0
    + 0.0
    + 3.0

    We now perform the integration, using a 25 order expansion and absolute tolerance of $10^{-20}$.

    using TaylorIntegration, Plots
    +sol = taylorinteg(kepler_eqs!, q0, 0.0, 10000*2pi, 25, 1.0e-20, maxsteps=700_000);
    +t, q = sol.t, sol.x;
    +t[end], q[end,:]
    (62831.853071795864, [0.20000000000001486, 5.940560592488514e-9, -4.950456454488883e-8, 2.9999999999999])

    We first plot the orbit. (For performance reasons only the first 10000 points are considered.)

    x = view(q, :, 1)
    +y = view(q, :, 2)
    +vx = view(q, :, 3)
    +vy = view(q, :, 4)
    +plot(x[1:10_000], y[1:10_000], legend=false)
    +scatter!([0], [0], shape=:circle, ms=5)
    +xaxis!("x", (-2.0, 0.5))
    +yaxis!("y", (-1.0, 1.0))
    +title!("Fig. 1")
    Example block output

    The following functions allow us to calculate the energy and angular momentum using cartesian coordinates.

    function energy( x, y, vx, vy )
    +    kinetic = 0.5 * (vx*vx + vy*vy)
    +    r = sqrt( x*x + y*y)
    +    potential = - mu * mass / r
    +    return kinetic + potential
    +end
    +lz( x, y, vx, vy ) = mass * ( x*vy - y*vx ) ;
    lz (generic function with 1 method)

    We use the change in energy and angular momentum of the orbit with respect to the initial value of the corresponding quantity as a function of time. These quantities are expressed in units of the local epsilon of the initial energy or angular momentum, respectively. This serves to illustrate the accuracy of the calculation, shown in Figure 2 and 3.

    e0 = energy(q0...)
    +δE = (energy.(x,y,vx,vy) .- e0) ./ eps(e0)
    +plot(t[1:3:end], δE[1:3:end])
    +xlabel!("t")
    +ylabel!("dE")
    +title!("Fig. 2")
    Example block output
    lz0 = lz(q0...)
    +δlz = (lz.(x,y,vx,vy) .- lz0) ./ eps(lz0)
    +plot(t[1:3:end], δlz[1:3:end])
    +xlabel!("t")
    +ylabel!("dlz")
    +title!("Fig. 3")
    Example block output

    These errors are reminiscent of random walks.

    The maximum absolute errors of the energy and angular momentum are

    maximum( abs.(energy.(x,y,vx,vy) .- e0) ), maximum( abs.(lz.(x,y,vx,vy) .- lz0) )
    (9.947598300641403e-14, 2.808864252301646e-14)
    diff --git a/v0.16.1/lorenz_lyapunov/12e1d07f.svg b/v0.16.1/lorenz_lyapunov/12e1d07f.svg new file mode 100644 index 000000000..e7f5bee3a --- /dev/null +++ b/v0.16.1/lorenz_lyapunov/12e1d07f.svg @@ -0,0 +1,62 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/lorenz_lyapunov/6d97d4d8.svg b/v0.16.1/lorenz_lyapunov/6d97d4d8.svg new file mode 100644 index 000000000..d8b0a96a7 --- /dev/null +++ b/v0.16.1/lorenz_lyapunov/6d97d4d8.svg @@ -0,0 +1,50 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/lorenz_lyapunov/index.html b/v0.16.1/lorenz_lyapunov/index.html new file mode 100644 index 000000000..fc080b468 --- /dev/null +++ b/v0.16.1/lorenz_lyapunov/index.html @@ -0,0 +1,50 @@ + +Lyapunov spectrum of Lorenz system · TaylorIntegration.jl

    Lyapunov spectrum of Lorenz system

    Here, we present the calculation of the Lyapunov spectrum of the Lorenz system, using TaylorIntegration.jl. The computation involves evaluating the 1st order variational equations $\dot \xi = J \cdot \xi$ for this system, where $J = \operatorname{D}f$ is the Jacobian. By default, the numerical value of the Jacobian is computed using automatic differentiation techniques implemented in TaylorSeries.jl, which saves us from writing down explicitly the Jacobian. Conversely, this can be used to check a function implementing the Jacobian. As an alternative, specially important if performance is critical, the user may provide a Jacobian function.

    The Lorenz system is the ODE defined as:

    \[\begin{aligned} + \dot{x}_1 & = \sigma(x_2-x_1), \\ + \dot{x}_2 & = x_1(\rho-x_3)-x_2, \\ + \dot{x}_3 & = x_1x_2-\beta x_3, +\end{aligned}\]

    where $\sigma$, $\rho$ and $\beta$ are constant parameters.

    First, we write a Julia function which evaluates (in-place) the Lorenz system:

    #Lorenz system ODE:
    +function lorenz!(dq, q, params, t)
    +    σ, ρ, β = params
    +    x, y, z = q
    +    dq[1] = σ*(y-x)
    +    dq[2] = x*(ρ-z)-y
    +    dq[3] = x*y-β*z
    +    nothing
    +end

    Below, we use the the parameters $\sigma = 16.0$, $\beta = 4$ and $\rho = 45.92$.

    #Lorenz system parameters
    +#we use the `const` prefix in order to help the compiler speed things up
    +const params = [16.0, 45.92, 4.0]

    We define the initial conditions, the initial and final integration times for the integration:

    const x0 = [19.0, 20.0, 50.0] #the initial condition
    +const t0 = 0.0     #the initial time
    +const tmax = 100.0 #final time of integration

    Since the diagonal of the Jacobian is constant, the sum of the Lyapunov spectrum has to be equal to that value. We calculate this trace using TaylorSeries.jl, and after the numerical integration, we will come back to check if this value is conserved (or approximately conserved) as a function of time.

    # Note that TaylorSeries.jl is @reexport-ed by TaylorIntegration.jl
    +# Calculate trace of Lorenz system Jacobian via TaylorSeries.jacobian:
    +import LinearAlgebra: tr
    +using TaylorIntegration
    +xi = set_variables("δ", order=1, numvars=length(x0))
    +x0TN = x0 .+ xi
    +dx0TN = similar(x0TN)
    +lorenz!(dx0TN, x0TN, params, t0)
    +jjac = TaylorSeries.jacobian(dx0TN)
    +lorenztr = tr(jjac) #trace of Lorenz system Jacobian matrix

    As explained above, the user may provide a function which computes the Jacobian of the ODE in-place:

    #Lorenz system Jacobian (in-place):
    +function lorenz_jac!(jac, x, params, t)
    +    σ, ρ, β = params
    +    jac[1,1] = -σ + zero(x[1])
    +    jac[1,2] = σ + zero(x[1])
    +    jac[1,3] = zero(x[1])
    +    jac[2,1] = ρ - x[3]
    +    jac[2,2] = -1.0 + zero(x[1])
    +    jac[2,3] = -x[1]
    +    jac[3,1] = x[2]
    +    jac[3,2] = x[1]
    +    jac[3,3] = -β + zero(x[1])
    +    nothing
    +end
    Note

    We use of zero(x[1]) in the function lorenz_jac! when the RHS consists of a numeric value; this is needed to allow the proper promotion of the variables to carry out Taylor's method.

    We can actually check the consistency of lorenz_jac! with the computation of the jacobian using automatic differentiation techniques. Below we use the initial conditions x0, but it is easy to generalize this.

    lorenz_jac!(jjac, x0, params, t0)  # update the matrix `jjac` using Jacobian provided by the user
    +TaylorSeries.jacobian(dx0TN) == jjac    # `dx0TN` is obtained via automatic differentiation
    true

    Now, we are ready to perform the integration using lyap_taylorinteg function, which integrates the 1st variational equations and uses Oseledets' theorem. The expansion order will be $28$ and the local absolute tolerance will be $10^{-20}$. lyap_taylorinteg will return three arrays: one with the evaluation times, one with the values of the dependent variables (at the time of evaluation), and another one with the values of the Lyapunov spectrum.

    We first carry out the integration computing internally the Jacobian

    sol = lyap_taylorinteg(lorenz!, x0, t0, tmax, 28, 1e-20, params; maxsteps=2000000);
    +tv, xv, λv = sol.t, sol.x, sol.λ

    Now, the integration is obtained exploiting lorenz_jac!:

    sol_ = lyap_taylorinteg(lorenz!, x0, t0, tmax, 28, 1e-20, params, lorenz_jac!; maxsteps=2000000);
    +tv_, xv_, λv_ = sol_.t, sol_.x, sol_.λ

    In terms of performance the second method is about ~50% faster than the first.

    We check the consistency of the orbits computed by the two methods:

    tv == tv_, xv == xv_, λv == λv_
    (true, true, true)

    As mentioned above, a more subtle check is related to the fact that the trace of the Jacobian is constant in time, which must coincide with the sum of all Lyapunov exponents. Using its initial value lorenztr, we compare it with the final Lyapunov exponents of the computation, and obtain

    sum(λv[end,:]) ≈ lorenztr, sum(λv_[end,:]) ≈ lorenztr, sum(λv[end,:]) ≈ sum(λv_[end,:])
    (true, true, true)

    Above we checked the approximate equality; we now show that the relative error is quite small and comparable with the local machine epsilon value around lorenztr:

    abs(sum(λv[end,:])/lorenztr - 1), abs(sum(λv_[end,:])/lorenztr - 1), eps(lorenztr)
    (1.1102230246251565e-15, 1.1102230246251565e-15, 3.552713678800501e-15)

    Therefore, the numerical error is dominated by roundoff errors in the floating point arithmetic of the integration. We will now proceed to plot our results. First, we plot Lorenz attractor in phase space

    using Plots
    +plot(xv[:,1], xv[:,2], xv[:,3], leg=false)
    Example block output

    We display now the Lyapunov exponents as a function of time:

    using Plots
    +plot(tv, λv[:,1], label="L_1", legend=:right)
    +plot!(tv, λv[:,2], label="L_2")
    +plot!(tv, λv[:,3], label="L_3")
    +xlabel!("time")
    +ylabel!("L_i, i=1,2,3")
    +title!("Lyapunov exponents vs time")
    Example block output

    This plot shows that the calculation of the Lyapunov exponents has converged.

    diff --git a/v0.16.1/lyapunov_spectrum/index.html b/v0.16.1/lyapunov_spectrum/index.html new file mode 100644 index 000000000..109137ff1 --- /dev/null +++ b/v0.16.1/lyapunov_spectrum/index.html @@ -0,0 +1,2 @@ + +Lyapunov spectrum · TaylorIntegration.jl

    Lyapunov spectrum

    Here we describe the background of the Lyapunov spectra computations in TaylorIntegration.jl. Our implementation follows the numerical method of Benettin et al. [1], [2], which itself is based on Oseledet's multiplicative ergodic theorem [3]. Namely, simultaneously to the integration of the equations of motion, we integrate the 1st-order variational equations associated to them.

    In general, given a dynamical system defined by the equations of motion

    \[\dot{x} = f(t, x),\tag{1}\]

    along with the initial condition $x(t_0) = x_0$, then the first-order variational equations associated to this system are

    \[\dot{\xi} = (\operatorname{D}f)(x(t))\cdot \xi,\tag{2}\]

    where $(\operatorname{D}f)(x(t))$ is the Jacobian of the function $f$ with respect to the dependent variable $x$, evaluated at time $t$, for a given solution $x(t)$ to the equations of motion. The variable $\xi$ denotes a matrix, whose initial condition is $\xi(t_0) = \mathbb{1}_{n}$, the $n\times n$ identity matrix, where $n$ is the degrees of freedom or number of dependent variables $x$.

    For the actual computation of the Lyapunov spectrum, we proceed as follows. During the simultaneous numerical integration of the equations of motion and the variational equations, at fixed time intervals $t_k = k\cdot \Delta t$, $k = 1, 2, \ldots$ we perform a $QR$ decomposition over $\xi(t_k)$, the solution of the variational equations at time $t_k$. That is, we factorize $\xi(t_k)$ as $\xi(t_k)=Q_k\cdot R_k$, where $Q_k$ is an orthogonal $n\times n$ matrix and $R_k$ is an upper triangular $n\times n$ matrix with positive diagonal elements. The diagonal elements $R_{ii,k}$ are the growth factors from which the $l$-th Lyapunov exponent is computed at time $t_k$

    \[\lambda_l = \sum_{m=1}^k \frac{\log (R_{ll,m})}{k\cdot \Delta t}.\tag{3}\]

    In turn, the matrix $Q$ is substituted into $\xi(t_k)$ as the new (scaled) initial condition.

    The equations of motion together with the variational equations are integrated up to time $t_{k+1}$ using Taylor's method. We note that each time step of the integration is determined using the normalized derivatives of $x$ and the tolerance $\epsilon_\textrm{tol}$. This process is repeated until a prescribed $t_\textrm{max}$ is reached.

    This example illustrates the computation of the Lyapunov spectrum for the Lorenz system.

    References

    [1] Benettin G., Galgani L., Giorgilli A., Strelcyn J.M., 1980, Meccanica, 15, 9

    [2] Benettin G., Galgani L., Giorgilli A., Strelcyn J.M., 1980, Meccanica, 15, 21

    [3] Oseledets V. I., 1968, Trudy Moskovskogo Matematicheskogo Obshchestva, 19, 179

    diff --git a/v0.16.1/objects.inv b/v0.16.1/objects.inv new file mode 100644 index 0000000000000000000000000000000000000000..daef5b2ea7abb22ef5f450730c997285f159348b GIT binary patch literal 2351 zcmV+~3DEWNERX>N99Zgg*Qc_4OWa&u{KZXhxWBOp+6Z)#;@bUGkZVR>wC za!GDbZKvHE^2HFBOq2~a&u{KZaN?^E-^MPF$yCfRA^-&a%F8{X>Md?av*PJ zAarPHb0B7EY-J#6b0A}HZE$jBb8}^6Aa!$TZf78RY-wUH3V58&8p(3oHuSEqfT#8J zV%CwJX)>N1syOM?iKBWf$yWvWF;&707^RsH+=NkbYaU{*AEPT8B>`rC{fU-1<%57OmozcK z)ryc&Mi@;A!}BN>vicTfcj#TTSP&pPi*Wq@YmT#sCj93wu{M_IJ82pUEFPmjQjl=; z9cVa1pMNbkJ`ZpjnJDmjj7C=%gHIF)@Xj%dsRyj)vAj!y#&}NR25Ue3h$Ie@IHiX1ltDzt|zR{Ho9`#Hah^e4e$M<_#vT}ty02mRKX7*6d*`~45E-=8?F)+ zKu^H^KoLOjV}@`NN_`6)i^h{~Vc0a<`f*=t>ZnrDV3c^KPq}eN3DQ7=Q4V2%afgH% zS?~|jHL|@X(!v4|lW6B3WuHp&1ZA@|1_Vh1XzvR5)}Y#z~%vJ)qZvL%kr%8cYdODWT-m3d#;9C3qQ5 z>ek^7DDrg)zAk+RqUX>)t`=3{&`9jcj08R-@j4d<1c1z$ zBn2LI>{bcb*GbntL?>sBT}#gw3D0os${JESp-5z3BVnNnTvvGI*&Aj-Az(k&dEJtH zts-#gvRM--DY-PzlwYj~Yvw#*^N|R1-YkLlr)duIdYVq3kC1+pC=(jz0v=YU&(G-F z9WV-y=u3R23DI`E_J+e(Z{@+_cY65h-Qmgk;mM0~$+}JNNiYHVLf$KvKv~VJz@oC8 zB_sqROqpjgV1m7+^!_6uDa6F*J{-7?Eop5z80dAA7~m8RBmN@sF}vmdoQA6dK}F&A z9dx*G4^M{9i=t!>)Z8m-v?xZ&>Im&F5696U4me!vYa6+MTPj~#;*3R)2bMX`Dr+pC z3|@wEdBhlAJryegWmsDs8@rott20k}APLIGG`kb>EPUl@`sVDK;P?p5-kgo|<(#ly zvaZPmwB2x{S<{OeD>dZ|Eg;EHY0yLK$YBfAxC#FcpxCsW>~wG;0j-%vOpzivJwH4h z2|X#;nOac#YBOCGbw#0RTkTD0t1kP!!LfvB*s*DCQ)}P6^qOR&IHrMVeqF|Pgl>A- zTg8ma)NUGv)yMdNRSUP%7+s2=I`LfMa9YCVnwCp9Z3>^~Q5^bQC#m(3YA$M^AiIHt zPMO@$j{;hob7$@g%Xx$W4ngTQnX+i{X)R@==$pnnA&&VXD;SPSTm z2Gg}hR?U?prx=)MXY}ypiwfLnvgA>QGe5;F|#!0B%5BJQKqI%=t z9BV6+nXEADg~xV{O6}GSE0CF0=yeno+Z5=&93gRdj44g`+Y7tS-nkjxDkX_AwwPxh zcw@!k@O6JDE|7)IjteG+uh)C9|Ak}$C5r`bYuQDmw7@YZMYCgdJhSKRTAW!gow_;Kp zun2;2y*ZmY8ge59HX@Dzx|SN~^wf_%Q< zJ{FG4`_5+#l(w;~>eglBvC9DAlbi-hXyb9W5rTuL{ml^+mDV|qrLCt49V3~m&M{oK zY_A|W*#I?(J9gc%MCby}dvm5pE2loL33I=KbIsi6YO7J*W*WTGxv!4YspAglJ^`+@ z1Wkc-<$`%@G_`h=++KDoC&n2GrB5FiJ>*`BM*DcPQIKus4(%KxX)LAya0Bl(syRZ6 ztI29Pr~ML~bxHrJjpVB0PhHr?$l9{9a^c@}U~V6yiz;~6T(w~(*>tUf%*{sMs`lPf zPLmP7MY5BQY(F(3ogJ_y#W%0+-NtJDGn!gGb$!B^Y@{ZeMVGE78`T!mM%-$KmFmRd zw$L3=ZC|}?sMEe5IwpM#g%dS~?&|6E^xOT}RVTq+=ivn%n{;p1M7-apO(XB@J}=k7 zQU0%hojAbBgQ9V18dS#U;L1Q!q$yr7vzghwV6J%{;ax#Em;EL3bK) z2R8ZPZr9!Jq$GfL&P(I1ioo@msy(_Hp9%jR=&kZ&c}UAlTo_$*sNeMBHI + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/pendulum/index.html b/v0.16.1/pendulum/index.html new file mode 100644 index 000000000..8c115599a --- /dev/null +++ b/v0.16.1/pendulum/index.html @@ -0,0 +1,37 @@ + +Jet transport: the simple pendulum · TaylorIntegration.jl

    Jet transport: the simple pendulum

    In this example we illustrate the use of jet transport techniques in TaylorIntegration.jl for the simple pendulum. We propagate a neighborhood $U_0$ around an initial condition $q_0$ parametrized by the sum $q_0+\xi$, where $q_0=(x_0,p_0)$ represents the coordinates of the initial condition in phase space, and $\xi=(\xi_1,\xi_2)$ represents an small variation with respect to this initial condition. We re-interpret each component of the sum $q_0+\xi$ as a multivariate polynomial in the variables $\xi_1$ and $\xi_2$; below, the maximum order of the multivariate polynomial is fixed at 8. We propagate these multivariate polynomials in time using Taylor's method.

    The simple pendulum is defined by the Hamiltonian $H(x, p) = \frac{1}{2}p^2-\cos x$; the corresponding equations of motion are given by

    \[\begin{aligned} +\dot{x} & = p, \\ +\dot{p} & = -\sin x. +\end{aligned}\]

    We integrate this problem for a neighborhood $U_0$ around the initial condition $q_0 = (x(t_0), p(t_0)) = (x_0, p_0)$. For concreteness we take $p_0=0$ and choose $x_0$ such that the pendulum librates; that is, we will choose a numerical value for the energy $E=H(x_0,p_0)=-\cos x_0$ such that the pendulum's motion in phase space is "below" (inside) the region bounded by the separatrix. In this case, the libration period $T$ of the pendulum is

    \[T=\frac{4}{\sqrt{2}}\int_0^{x_0}\frac{dx}{\sqrt{\cos x_0-\cos x}},\]

    which can be expressed in terms of the complete elliptic integral of the first kind, $K$:

    \[T=4K(\sin(x_0/2)).\]

    The Hamiltonian for the simple pendulum is:

    H(x) = 0.5x[2]^2-cos(x[1])

    The equations of motion are:

    function pendulum!(dx, x, p, t)
    +    dx[1] = x[2]
    +    dx[2] = -sin(x[1])
    +end

    We define the TaylorN variables necessary to perform the jet transport; varorder represents the maximum order of expansion in the variations $\xi$.

    const varorder = 8
    +using TaylorIntegration
    +ξ = set_variables("ξ", numvars=2, order=varorder)
    2-element Vector{TaylorN{Float64}}:
    +  1.0 ξ₁ + 𝒪(‖x‖⁹)
    +  1.0 ξ₂ + 𝒪(‖x‖⁹)

    Note that TaylorSeries.jl is @reexport-ed internally by TaylorIntegration.jl.

    The nominal initial condition is:

    q0 = [1.3, 0.0]
    2-element Vector{Float64}:
    + 1.3
    + 0.0

    The corresponding initial value of the energy is:

    H0 = H(q0)
    -0.26749882862458735

    The parametrization of the neighborhood $U_0$ is represented by

    q0TN = q0 .+ ξ
    2-element Vector{TaylorN{Float64}}:
    +  1.3 + 1.0 ξ₁ + 𝒪(‖x‖⁹)
    +        1.0 ξ₂ + 𝒪(‖x‖⁹)

    To understand how the jet transport technique works, we shall evaluate the Hamiltonian at $q_0+\xi$ in order to obtain the 8-th order Taylor expansion of the Hamiltonian with respect to the variations $\xi$, around the initial condition $q_0$:

    H(q0TN)
     - 0.26749882862458735 + 0.963558185417193 ξ₁ + 0.13374941431229367 ξ₁² + 0.5 ξ₂² - 0.1605930309028655 ξ₁³ - 0.011145784526024473 ξ₁⁴ + 0.008029651545143275 ξ₁⁵ + 0.0003715261508674824 ξ₁⁶ - 0.00019118217964626843 ξ₁⁷ - 6.634395551205043e-6 ξ₁⁸ + 𝒪(‖x‖⁹)

    Note that the 0-th order term of the expression above is equal to the value H(q0), as expected.

    Below, we set some parameters for the Taylor integration. We use a method of taylorinteg which returns the solution at t0, t0+integstep, t0+2integstep,...,tmax, where t0 and tmax are the initial and final times of integration, whereas integstep is a time interval chosen by the user; we use the variable tv = t0:integstep:tmax for this purpose and choose integstep as $\frac{T}{8}$.

    order = 28     #the order of the Taylor expansion wrt time
    +abstol = 1e-20 #the absolute tolerance of the integration
    +using Elliptic # we use Elliptic.jl to evaluate the elliptic integral K
    +T = 4*Elliptic.K(sin(q0[1]/2)^2) #the libration period
    +t0 = 0.0        #the initial time
    +tmax = 6T       #the final time
    +integstep = T/8 #the time interval between successive evaluations of the solution vector

    We perform the Taylor integration using the initial condition x0TN, during 6 periods of the pendulum (i.e., $6T$), exploiting multiple dispatch:

    tv = t0:integstep:tmax # the times at which the solution will be evaluated
    +sol = taylorinteg(pendulum!, q0TN, tv, order, abstol)

    The integration above works for any initial neighborhood $U_0$ around the nominal initial condition $q_0$, provided it is sufficiently small.

    We will consider the particular case where $U_0$ is a disk of radius $r = 0.05$, centered at $q_0$; that is $U_0=\{ q_0+\xi:\xi=(r\cos\phi,r\sin\phi); \phi\in[0,2\pi) \}$ for a given radius $r>0$. We will denote by $U_t$ the propagation of the initial neighborhood $U_0$ evaluated at time $t$. Also, we denote by $q(t)$ the coordinates of the nominal solution at time $t$: $q(t)=(x(t),p(t))$. Likewise, we will denote the propagation at time $t$ of a given initial variation $\xi_0$ by $\xi(t)$. Then, we can compute the propagation of the boundary $\partial U_t$ of the neighborhood $U_t$.

    polar2cart(r, ϕ) = [r*cos(ϕ), r*sin(ϕ)] # convert radius r and angle ϕ to cartesian coordinates
    +r = 0.05 #the radius of the neighborhood
    +ϕ = 0.0:0.1:(2π+0.1) #the values of the angle
    +ξv = polar2cart.(r, ϕ)

    We evaluate the jet at $\partial U_{x(t)}$ (the boundary of $U_{x(t)}$) at each value of the solution array sol.x; we organize these values such that we can plot them later:

    xjet_plot = map(λ->λ.(ξv), sol.x[:,1])
    +pjet_plot = map(λ->λ.(ξv), sol.x[:,2])

    Above, we have exploited the fact that Array{TaylorN{Float64}} variables are callable objects. Now, we evaluate the jet at the nominal solution, which corresponds to $\xi=(0,0)$, at each value of the solution vector sol.x:

    x_nom = sol.x[:,1]()
    +p_nom = sol.x[:,2]()

    Finally, we shall plot the nominal solution (black dots), as well as the evolution of the neighborhood $U_0$ (in colors), each $\frac{1}{8}$th of a period $T$. The initial condition corresponds to the black dot situated at $q_0=(1.3,0)$

    using Plots
    +plot( xjet_plot, pjet_plot,
    +    xaxis=("x",), yaxis=("p",),
    +    title="Simple pendulum phase space",
    +    leg=false, aspect_ratio=1.0
    +)
    +scatter!( x_nom, p_nom,
    +    color=:black,
    +    m=(1,2.8,stroke(0))
    +)
    Example block output
    diff --git a/v0.16.1/poincareanim1.gif b/v0.16.1/poincareanim1.gif new file mode 100644 index 0000000000000000000000000000000000000000..081c748d12967d8d42213ede5fede5e2f8708f4a GIT binary patch literal 17980 zcmeIZXIN9w*6+L0NJ0{_=%GpI9RdO(HS`Vvlp;kyL{v~fP?VO07J2{+3Mxeu6%`ff zU??ixP*kb{0%8Y6r025tTlPNZzUS-xa?kHmo_v^VJ^wkznEyG~9M-m0diw)Bp-jkM zDDV%8HUJI)fk2?U6mP&_FgP5JKp>DvBnpK>qtV>l+?ZW%ZeX!k91h3B!vlgKFE20O zE@c}60s?}9fEzkLx+5PeEj_U4)4O+^7r=-2nYxa3=9ei z3JwlFwoAuWNJz->U=1g>S^tp5AVs`1?yl~+{ zY;0_Ne0)MeLgFrcTU08QMx)W`^rWPuwPr7;+c^z`(MjEv08%&ft! z?Ck8EoE#>TnU|NBpPye)P;l|$#Y>kiUEbx*_LVDF3JVLbUcGwl+O?vhqT=G>>({T} zxN+m=E@RszB_*Y$rDbJh<>lqKcA40&sHnJo`*vkz<=wk?@9i?RegFRb2M-=ReE9Iu zqes=%)sJ_X-hT4r$mX_Am*5}WkvskRQ zwzl^6_KuE@&d$ykFJ8RbozRS|i#KgqZ)YSX;?>~I_Fulv~otc@L+1c5TA3x5`&CSox zFDxv4`t)gWm(`umpFe;3^5yH-uiw6X`~Lm=j~_pN?y}BVT3T9OUjDVq2Iu$h-zzIC ze|FjAtgf#9{rh)qZEbyhePfqx&gSOk*4EbcE<2oU4rga)hr{7WaWGDn2i(j}DVAF5 zBp75j9i-Ob2rU2#sQx22{*fkW|M>BLljQ#<$^T!I1jPY3XmOkBlC~rizp_tPb!kT$ zC}US_^SJCqCSmW1$*#xcuX2gz8RE82ZgnTV1Jd=opH$diZU<&A*gn18U!-^DOL5Fk zE<}jI{)Aucq0f-s|BMF^dnsRrK+Kiv4AJc7YGslg`jo-@~nFE(HSX#LH{8ZNfSMkJV{6v zi3xS!>O@tBtE{Ow^YZ|Ev_}xsURFTft?S7`cRgR(0)D>l`-_MIz!j`0%zw5-1sa-k z4e)RBmj@_B=`T{MOVjN@Fp3ungHQz)#IJF_1Sl)sKs>)7+)VeMAnO2nQ4Qu?FaSS; zlHXrNj5ZH4f@`tG0a=fHIbeEl&`74LB=-V%?T>dj0_Ra|TEngwiR|ZH@re>dza6zs zUDjgmt$e^cL*6VLlG=S^Hr%v;n*W;owFaPy!Vl)7_s*>;@Y1;QlS}9lGZ3w^&LXZYxN8Q-OdBCNUO(jJ~`ef-* z`I4p+U`I~047b35LJD~(%XDKYvYU8ij(*Tgjt|~_4$k}AMyjmXjjeZxM*ye!=bL%2 zRIbGtws9NTwM)U1FUV0TjmVLvXR-HER)}ky15crYKu8JY7Hl30Am|(96<98~;u!?p2B;d^^^?}7 zFBWaI#h~k)-#UZhD`w0+fVL|lkQ_g(ok&r*$OC9pLLq^q!lyVaLleZ9Mh3-uLNBOd zSzvZd4wS-O;SUsXU;R#R{HEM_?Iec^=mH(6m2A*L!yjep4zPM~X;MTAkN**3FZo20 zQ3mV`vDVo+ebef1@tppCIE6)@F1BKF({F2X&OGRgQ^B)5)3hmr>( zxfjehiU=Ss+=#|bf};riCc&%J5Ofe>QIsJLkT~TuRVbjXNR)#qfsO!x!NbXz9op)t|MA8HfL z2)GQSY6#3gw6fnO2-$*d-^y+?rKEwLyS5CIUKQVBpbGr0gEz?k+83h3K(-Flw}p1BABN#w3Zas%kXoos_x zr^aKX5dguQ*v8K`tAzm4psp#R?MO7rtnXJ;c{$G5MnT_eY|pvmIGE;5^4c-3eT1TFc5&&$+kPsB}X<}veebWi?OfE8%=4sCF&-Ju@2V#o11tkD~R$i|7P~i4Tp=)oZX{!4b@T%40s zKnFA?#c{w%Fj)+krjZ>WRApHUQ6VCgXPkv3hYul3Zo^IQX)fnZY|h?KFg48psC7di zaBk7N!JM3G06@WX?AwQDPB9VUL@7@5tm%8xX7yzBnE2)EJ|>f)G}851r^NRr^jC-I zQAc2~N{HAhfReNIC8j(R1-PbH(Aw&IB5mdZ&Qb*E$$>w94s2P>Zs(pq4FDe~U9C-@ zP6vzl0|$S!xg%Vc=tS{~hm81d$LGUo=ign8qQlWJ-t&{38KhbCeax*?FHV|jWNV~3jQow; z$<%Z-qBgm>7lWiB@jM%v^{ITniMrrNwhgB39OCh@&kEoWuz$)O#8vC#X0VxLLs2FV zd=LecoV`{@!?&IPT`PGi6)d*~51Ui;^Y~o5+&;m0DD8~?U;F|Y;HMmg@xlPWCzlm(SrG-Ni9VPG zXZJ-Pv<4RyKq>&FlfilF$t5JfP1Jv1OD*{O?)H_K|!30ur%N>k>NEd06PU4 zK!x+d0jfSU;{3-u;r6=GoP{%ew z47%>899<4K67~X3_lChtkA1nEPD}@j7*0FP!^$A~IT>3~!X-p>E>{HQ6v1yxR-SB3 z7ZVxANujIOXK>gV$mI;asO-WH*i8!d`4ZZT1$kB&5pmmv+jk!rh>;bJmDu4?y(VrD?TudO9jco_HFeOGO>ml4s zWFHZGh;`yfDmbd3_Z0Q($FQ%Q!xJqTj-!%aSV@Sv-KP!=kWDz`y7r9nZr6R~AvE?y2x{t*a`0Wbp; z?1gYZ$e#v%%!4kmmD+!^bvbQ**o(u&N9Q)3;kiPq{&B8Zn9t$Ig)`0gk- z#a))QYCXK)k+E?nG=~uks zs0jA6W7TDl&;b0=6oM|xCAlFRU}wYfcsxm^TQg@+%PI4O)QkJU{OSDy)7+g;Q_cO+ zXevRC$Up}8O=yD$!VS`-An-PnU!!becUso!p|n8@GrL=%48Pbb#fVb8X%a!5ik(vg zONi%zl5;C1TnFupOql}DOTrj=(6?)NwKu4hhDs<0!ZQRaLS67fRLyh*hRH-fDaqt8 zdEP83?DN1O*YP{kW=sm^pziKJE@y?k(KOr;G37fEmvUL~_7bX?ikbC1IJD%!DZvea z_ukoH3MlAD{?0H{+&vh8a1}B;KFw59$OQ=Un>7R)>+$!!3Gi{xMQ;9Kt#YE?o zaF<$xUDfEzAa;lSV7~G08{jSs!t?CH{RU;O4_{tM60ZHRsBXMP5?LEg2pdC!82YELxPhN=jC zD&Y$gtBW+Ki}J2J8(SAsRCl4NE^eYOVY7}ZR!=vmPxh`)jjd-C)n_!-XHC@SY}PZy z8uASqE_ydyj%_F`YPiudD#hRWN zG}U-F)y6i}7d18Ro@Y%owQe@C#G2a;nmfIlU&c0f6*c!XHTO+44{SEG#af08T1LEE z-p00!7PX8wwMkk6a$Wr{B^L6Vb_s+)R z0}bj*E9+L+i7Q?R$YpSY_4us!^9v{OO81}dgw*|>uKtZ?aciw zjcJ2Au%hkTVotW5&uoji-)7a@hLUPKk7+-r(jH^qe(q#@Rz~~s*S4tM_OoBx&tW>S z-&j(%9gM(^GnpOH_dCw^c0{XmG-=|0Pk>9z=WT*4CDqPI`_8D7oza<{QTIEK<>7rn z2rmo4Mhoh}XFr)_FSA9Wt!*2^G4?hW-Tb8bmb0g(m~R z{M-kIG2t82IFa2#f?9qFFKv%8copgWio2@rysD5vNhJqF^9F;rxSkOFBTq7qolg^-D!p{vU#9t?9U_~SUekboz30C#!j($w%MS> zAYVLtk<7y%KS;PfDB3cJ3*!mt93)B%NgEB#1F*F5+6XcdX2b)TVq+ZmWmpGm0q6=R zu5XnD5Qb6cSTM)1zcP+>U%c)Q38v6r8^IcYF8A7%!q;U`Hk4svCUou(BG#*i*P%c3 zWPey@znSAmRP4z2KCy=-kaiMQjKvK#g*zU=7Hda2N{dUMcGF z5FZIM7_n@r^}jyy!$B|?fN7L;bC%%MR`3ZaxWNN_R5et0nw%ZlW4bjg`0ZUNX7q6O zNUP6iA>$pV^+6r;6u1U1tdr(`2e-qmKCh_|l@G({z1lYJK9x9rD27kSpD}&kd+rR1z%NNO^VTxw(B`0{_ zPCrNSPL}o4ZiS6YW{ns4OdOA$z)A5)fK#i!z*8b`7#pg;J%Vt-e3k}1OX87(a$VS? zLZ!fmd*C8&!oz4n4f`QjM?%fLza;Ix9nq;X68kNAE*zgmG- zP>=!$pZdT8cxy{8LTPZr5WG7TVzq$x42RiQa|tc&g-38-lt+mya*Z>2NF+prKeT|# zhh@Qz0_YJI>~uAkC|Ni!95_17^_qm&FM&r^Lrpk(pp|il&5d_2AJlfW)b>n`^-Y0a zNb|x@Q}|^xWC!mv&BdAe?8$b{WIMxX3rHuGQzS0pUdTo`PT|D)od?rUDU_fc4x^$7d|B7_H^-6gAhytoo@loO60Ao;u_p8e*Z0L|lJ zc;a@X?{yNnpRfg2!C7A!?&kphQW{?;VBAIGeli_-2%q2Dx_&RN?Z^kP+aKx8oV@ z!}#~ZoS%stVA*+^Oh@4MSQJub%u;a@`ZXRuXDl)V)%=P*Pp6WyB#aW^B5AK#=hw+M zEcQRPQ%u>ItwkC!u2fp-O zcY9D)Wi8Vs@X)s<0U_r8&GX68{u`F|?v|3}9(U9o7l*!2=D2)*U*ReE(=YW;TsBnP zbIHFw1t)1$?71BHGNb9){8xT;vxYo1$(mTNr{tC*jdx9-&Y!Uz+^Zm2<)a@N{3h0* zt`#GydwA$6$N7eC;rOc0+ongYt40UUhSxnyKiug{`MZ3l<*EW=CvGwPvs1Rmxx(V< z$Zy8i&wUb+Fm(FzG1hNiE@hMa z+;An6?X}HUCU8yeCDTmQMP?aHrP-!!lMn@Vq)V@W(&=W}ByB#;A*L};k^Z1G=I&CSYbRoi;9<&lsBATR)vi=(-n_s#o9iHDMRgjD|l`VA$=_VFof7vQ$ zJDj#t)_nTeKDm0u#a^*N`?b9$`pJ;B);aCHw%V`U&N$M>Czl; zHzMK~&vQ`mpj_S?&^LwGeIdv(|1B8y2Ye?KZIt679sdXP#HJYKdCq3x_`I-}9x%Q5 zuH$$PNme{y9zs9B@p^x#nacAzK4SgxpfCK*3#RYHr{alopIXj+NX#{oh@vXA#(d1pMP83)9&0`S z$#-9x#8~bVy9`4vyXmhqy{iEwN-K&CtRkok&87@kTT1?US9j<7pATs!3G1KkJWtsC z`N|}5`@?9gK*&jatH|N6W&lB#ZFalhQ2PjVB z5bL^FZ%+BA(|yWfkpZLW?AwyhUMNItc!}GcYNMUog7F%FU8J(*+}%?%VNT^sX!~-m zsBR_N59Kq){Wn+e{hgE_=V#&rWB3xu0SLEhKm(o+-@o+@>ORf-v%{M#ZX<qQys zMutE^U8_r2@+BFzC9l9y2f=JNZ`hj~L_tHl6r8(J`N22gmlXWI^LTp8yzOT`(+=)O zA9`Hw{-*li-cy1&p9tx9U)ayI&u(X>bKQAYv~*BEK@jJ!mgMmoe5>s`#ltzMa`d2q zlCD;k1nv)a(C8=P+r5|PF~K??J+Fpe-hX2X8}e6ryqBpff7^)XgiiUP=IXav4^z;g z=`s_&Y+YTtk?1M6vWe-Xw_2?gnPDaBR`e-jEA_B2c~dQ>(ah;lye$= zEx4dDnK5UVvyPK38RwRveoX&&y5rIPGdZ{4H&y?Y`EeZ=w@mlD&%UC*`UjN|Q2wE5 z$wQCjD?&Apo_-4!s&ie=Nc>dhpGET2;kkiHz9~I3>-pD2NFA3tRTgk3d`(%vDko;s z{QZHe9uBfj8R-w`ftgfKZRwrtI1l-cciHvQx~tfn2hbz8mOPb>Z=;y|I5Km0!Snhk zE0O$zWwTt5W8Bqu@(WS|=kD07OWD1}7F3iSy%|2HzsC=}WH2%-m*1ce?8Nt zu4@G*WE7o;9=k=!g2BmV%4|ai9q$GY&)fMo&a{6jrG!f4g+l=C>C^{dPuTXIPu&C@ z_b6J+i}kLh8IW7vnyORHI328U2&30Z&u?{sh1RDTOvC?_>n?ouqyQG6D_}CF5FQUx~2AoGqq2{n|OKJNJiJ7ub zc!v?rLv2Uj9&hYxpW%4~U~(u_Zbs6qCJhQ9lDJ+A$|4FXyKv!Lx;?yb&=y4P$C9)# zi)O?ywpl;y!f)Nz<4!^STn{58s8DV3Nv*ZhFI39v&Ju5l%vUnF64r8kgGz|uVqI|h zAP*2{PAr&)m=&{;f!YaaZgR0RQG56w^n8Se?;f=kGPC)?mKlXgfV377*l>6r(gxaS z3Q<7S&H$n~Gi4t@{GLdiMW7-~QGV5%qPIBZ63;pD`Y$1Iv%(+NURfvny7WA5Vc&=K z*9yk^U6A-M9v?Q|y=wi{?~?QF+=tB%$iy!Lya~TJ#v;=GWXIuUYhGwl$HM)!ni5g1(L)K~)5?g(5OH0VmwDL#@9 z5#Yb`3wbjWx|Z}D0P55jP@!-jda=52nu`DcQ3e3eRhJVE)trSrmSWg5AheKFB)L{l z@v3S_5_eWrmsoLkQhM@NAWa28`nP*yfZfBjp-i-7HQ<86#ZyywDKu(1<4`r=Rhfbz zu|(HW5*bJ=0UiWG_kt*nl?}}wm4Yhak`mXDJ|K$Q;tQLgg9pq+^xDep)6W1@S4GBQ zfEv8Wa9)J$Sxlx)L%+MEDpW%Dh1Vr6rJ2=3q$^X*FFb2|Tw6+N-xxJ%3`ZJN0(JZl zWF=L5>6w57dUudxim3LJ`eu8tVN{#s+Ex5fz`6>RA4TN`=n+Zj1VS<$K=3HG-1yR2 zzHU*9vaBLlHg=^ZRwpTXa=ETOJQ|1cVgY+uDaWQ$_SFNF%G5JeO(##heA>oRX){+2 z&@L?@V2QOCYODj3^rM?CokOknowrs@x4v0IaJRvp47nX0Ri4mSkm!(4HN>AP7DyJa z^idU0n?rLndU?{Tlrt=fj~ntcz6oR(tL7AI@g97OuUmHOTi^jc%AZZcjLRCg7#x>6Z^ zEroqIDjk^h4#i!4kH@T!IrIg2^|>7Hi$3r0X4Ij1v2V$y-`%VK!tws0nEob4fALyh zE~>wX(9cQfa%>!REM9cXUF*M!8aQsym%6|I_|<;zyZwm`{rV@J1TPGnN+0mQI*@$V z={3RWeb>O5v4NwX2h!IE`cckxiUUP@1AJa(^K+d;L9fbu3g$X#kOf2un>J6bCn%+mtEUHu`hp} zT=N>YMR|c9bnRi=j z7Z+~lhwLS zFM+V@-0(}ehQ38czVc=dD)r-U8>GnCL`&H|khj}bwC|U9@RfB;k#^dacXm{wNGP~G zkafKzB7pJtE%lMa1|#VD?`;78mRWf5+p#pMhi!9 z_z5U!Pk6N#L}v|_l=W8UqpklR+km65BS>Qf5@~D--GsnEqPS@#$zlYQ>SCEk2+VSc zK5UK>ErBR3d8v4&odXY*`ldw?#>*|oZyg-3I68hidi+kxc;%(>a>umD!twhr#;e|p zKL{H?Lqa}8OjHX_JdQ`6AtRqyPShOqu8>QM3LgiEMviHSg-0uQMjRR&fvp!6 zWhe8M(QaB1V%(Y+PsjCXNDiVz4MQ+H8sw;~ns6yrK@^tLrt?J@DN)kEpdw$4ECMXlt z)nxsY zKtab?QFlOP-zjyy9p(KAiuyT<2B%aFc{HTl{iIu+$pclEZ$8${e$4vyG23izkZ*4F z&|Jfbxx5Q=`5AL>ugz`Vn`>>HyWBH(WqfYp%N(#d*TFqsBsyQLJU_2LkFcK~I5b~! zV!rgk{1?|Cv)Z0{M3>L|m%an8!z=Tt@L*T|U^!P;*lkytooX-R2Z#Lbd7rv>MBYk? zwlJE%P+hiA^<<&mKDfwx!N733J%SC{v#_BZ#2>w&{qbnEYH(5LCtUZ!)cC@)FAI-1 zg2|l==iGZ^QhUz3=Uq^L82j*k+^PHVXI~^Z9pm#orY^WBF15({q_z0mY_Z8TL@5r$ zo#j5~h>m%NI`5c%#_wJFz{3ous!X0LhB043g2u%i)k}U=SvMYgJ|tZk&?t0LyV|OH z?T2QOlV;*=d+J-e%Rl&v_mHmNP`kmScGFm^2O?YPbE=?)=cI+|j(-O1fvP ze*d9bmGRT?Jxvjp*^zrxA2?|} z?Hg|MH}YsTjVSfnpp#x{mhRtYyKVkkI>-K#oFpNX13ZtilkuQC> zs0e#fOIC{yS$Ol!q9Kgl5!&o?>V9SF{#)26RDFDSYP!zhr?=fZok&7CX_5p8-x4H9 zhH;urLju$Y0_wCUO|T14W53I<4gC~%sx9ls9a6G*7czd7W~Ru9_D3A`{7EAusjeZ< z5^3(Er{?zj@K^iMUkTycKsxIAB~dL`g;3~41dRbx4G9l)`f+&R^qnrM4~X((QIopD zY5qt65VvDPl0%>`PZ|a*oBSPmdi;tdQcr*=OGP^9@d+t8w&yukxxP5D9;RdyiQ^!JLpl@d=^GV4r;QJo zY6P0qVf~m?7sV9xQez?oqPCG{OM(N6$u=O$9tH8DCZkIBM!5$|n4H|>d~z@(MLvX{ z#f#EmzDOj%NWdzIfU>ipD=V6l&xP2V%<<)RZ@e7X40Z^9XM5}&CB(z=xUk)cV=gD} zIEH%IrR+K`$znIXm+jr~0~+F%K#JUWk_YJ&y$i15S!V9fYHvu|=UJxXKi2*kY7_I9 z#`t^w(ciX)zi}V_wtfDaD9oU0h+jBdM%NJM#2+q8P6UNxsA$$&*1I*N4UqkJEf=}Y z6kg9$SkK?LUSNHmc?>|uHGGbL6yJ9vc&3CS#?dr;0A>_EP4`D0A|<;J^W!Vwq|u~cHO7(YB+@jj<9A*R3Qh`v z3SE$-5QuJJvMLK0s^gVWggRE!eyK6`D#GpAP^^CxAsq=4lI)hKaoP;|Lcnr~H?b0; zR1X(suF%3ED&VyiUN8n=pkD3F4^zKNwkLDArCb)5q&gXV3a(Wl%YmI|!NTpPG}@Jp zIP_tg_K;t)Jr|Ypj2M5Nz3CBr_QkHpf6EVCyc|MwNNN9IPVt~C_8ebPbWN$%W*7>! zRhS9a<-0!MUKUPCKDbH_3i+ernbAU$O@=DY8uL}OKM9*qv@zp4aS z6iF=Zh*W;b+kdj~#0`!zS`B_?5sJO;w#nmmgTZZSwl}Czx9Zzi@LfUltKxK2<%^cr z_Z){@vPiFPr5)WPUQ)ABYbl$=r%b4<&bXbJ62YHqbK9X^pi(@i)D3CLSMmbaA({tb z#Ri7!R6>tR&-gKl^(NYS7mEbQ)fl7-Z`l8uih$XIy|G7M!ixCR_-CgpTS@3bA@4Oo7ecK>)PWgo1% z926oj$?Z^~iCDP54 z$!!)8w4AFYB;W#vm)V^x*jE)kazz`}(xGs3E~{5)UzK(NXz+RG2(IZ(@$XZfudC^f zW^N_Y0yUl=UYBuD*_6JO-NYULJFxw*Qb)!I^GYz&P^(+6C{C+K z>3*|TFGsCuORG<_*KlvY&P3eaf&E{b_r5mT+}g`F#TaQ1T8hPM580};Xb(FYY-^9W z*c<7*Ip`g)^VaKRi_Sa#7jFHA+=FhoT{|4FJDzr_0PsNL0;#&kdyV!@S$QqfjL~F1d6; zrs5Lxzc{67nsGbc+R^`JC9``02=Ow(;D^y8usx_@b7!+}n#e{jy%2l!%W&EsLhE>C zz%hIt2~@Kb*xrfTmG6mr6;`KWIYw(UnI^{T^F@iq8=vn#H{Sf-#4+Al?lm#l{xgwi zvg5q|^|=XWdy``Vz!X^!zG^C$ArZ=7$wFvV(|F>Da2drmv}-k8sF}#Mx3UcvS)H_J zi-se z?$q5o=7ydpx;irnVu$*=mS^v0OPFhIDL%PnmM`xnWN}wZt~ZmDpPtu7Pgh7#K5Vyz zyhCjR^g1K3f0grV5}{FMTh@wFlsFNO$wC(Tu50S7xFVK{{%DfO2|loWE?Vj~fT6`$ zDz8dXZ^#G$Q%gde-*$E7~2(q0~pZ$B|ulTl$mU>_&+Y$OPfkRR6Q|S$!lwsLo`=j z*%iQcSAa;1yHDgSFRLHXO5V?Vvs^|s=+@O$=Y`%}fv1o4JXyRZnH!-q$7N0&wz-Cz z!Z|M9Rj~Ad&JpZr^GcNT1gK&a@ll`=ol}hSNAf9m+~xKN+w#D+ja@n{A>?lpa>Q8T zRI_^&(LLaB=4LgjA+t_8r-hp)QL*?lGxxmol={j6f)plBa67MIdEmrEGj3h;vkx0W z%6tsmV(^*+&xVEO!)OkawvkckGA+zaA0KN$7*I!bq?9Pz-d2;jU$5(YLk)mYX zZO6^ebqa76RGxG6sRPn_nrJ2P+(qDj%SWUC3`c7;;lF!6LO?shKl1Uw=&h06d=xQz zT==-$8X{(r(M*WEWt%PTe9zD`vZ9x!rV%Ku7(CXSs-)0^@@Ky`$=b2%c9BuK(OwA7 zD@7%{94;_PKikK?0xFrCAp{zm)_&fh#&F#@*pGI3Y391;xL3%&)iT%(^!K1RI>hWj zd60;^=c2+9gVPMvxRVCFD4*n~&350$1ykkQ`3B_;X%X*RAI{0o(Z!b!3nY83`(D&B z>k+^l-ipX!IA^u-q-*ZPp8ay5=HY!gCz-|1@=hPrA3!;ZaWSuEUusG_8%ON_&2T+s zD4ZVJ_~+~B(~} zQ%CI?PsIt}fY6W6Z+@1R;txL~MY@huap+k4ee(*6x+8dyAwzCg?62^?=q7oxoUNVmq|r<{;FEcr zD##Vy8POrU@07Nnkx1V0cJ42vQ~s-uz8=WrgezjFZBG`PHSEM+T6@%PWePMvt z{V{Kg%#$w?FzElf$oz*C96;^gq!>NY|4%7KBJBSmMeP49#k{38*=gElZ+1m5W7tVN zYGhgRnc)f9`KEQsbw(0`n>ib!LKn60n&$OI-66O0tf_wyYr8vrAjMj6pm8*m_RR9) zTl886c$k`Es8*W~B;{Vhe;VC0=P?~-=CG~W3SF{inMfq9?78@uUS@Ay?iC*E$UHh%Me1*<=hwMl@TH`@qM|zi08yn8 zbfYHoboy?+I!G-OfmSLTK4A~KKjippbI0<{n($(Vi?`E4A&rTFygLSu!2y%ZkY4|p zYr+8nH_*1*m%1*!PxelpFe|R8PHKL7(+b6CK8S6H-q+i~lp(_clGmn*dpxD0tdD$e zyy2vm%_ckiIAs@%j?_J!*OYijK~4TVjLU_uF|ewCGEEKh4x3>QDQ!42QQ{47Tz2=AIi=PqU-JWj>yrjhY&LKggcS&Qdp1hUo}(H+g6yf z_b`o_flC%zCE{u6J(uuH-I?9rus$jHnC?kcNweIC;rh`9?`#jf_6s-oOWPk8hy1yA zGVayxRr&vJ0RERb{R8m-n>O`j1OH4LpEig8b1fZ`mZFEdbBCZcuQHNu?SvKowINr; z?RB&h@F-=qL7$SK(XOA7mlL&xGhDjN?!532r`E=j)lQft2nwk`70nyMUFVP~zcMJ3 z=B~miroi8yS80Z!_(tFQFS91v;@7G?T@-(|6>&dZ-%k7PVaR_EE4EU;gnF4+h{$RO zog+=pYk}^CXZKrQk`f9x6;yVSC;$*%SyP@54%~~b$Oed{`8pHHB{KfH}nB2CG8gq zvY!TXs%2WA7Rqi6zsdkSAL}o{FMTqP?NqOFa%EWQ&gGl7(@Nc+5FU8TnG<~(@N%RG$eOy`v^&(w@G z^A_imHmw;e)nh{hBEztQ+U?FHi=B_Nx1-IYs|E9=eZ8MhUDU~er5~GS4zkfVhY~`( z0S(NK@oLOSap}!zC>4y>xWV>IJp^sk9DN&KYA9Z<;vn{++7ru%31pgvpkY^d!{DoY z$DV7_2$){>JBmT4woR6{sU<9fgnIT4B%KY-d#SudK)j&{@w{+lNME)HOqaRND6>+2 z$Z*M2H->kBZX+Qd1vH-s^eGztT0<-DfAa6^`)`ONu-nA3yI;@&5XrHEw&NxcsQd2z z=JWJFwl&&Y)-KfDTV@)8HF~_|R=NC$lJqt*Im;hf$?I*K@rB zF{B>erFjvWNxcAtZ=KPl`dXyF0LfW}&S^#e*aVFI)BE%O!}9+)-02Cpb~2=>hx7x5 z5q%ic|1_{Qu$`S>ZslqS*|@f4TXQ6}HIV~HF^)}NwMef~ttnW8!;%jPPnuuQqFZ^21*F4bzDI%h zZ%gjKo?#Cl`eJ2ET#X^f>jySy^B+`rkP}8FR-a#*Kz2(X9~Wfu`7y3vTjm|5-5G)@ zJKG(rDmTyvl{IqO!Jmh7l+9JA8~<6&g#X>^wCt8DqyH>buP*)DhMMiKE|4d>yPO+?{=+|gmbgR%`;X|uD7}~WS#F77e-dtr>Gt7Q6)T`)zZ}R6kkq0z0h`z|GR)5 z!(9ATSngY3)}4J=0g|zZ2FBSg)MTv-C+14$*}|yT@U4^otVeDp?gu_ipD?qQQ?T3q ztC21a`6{Z%4{Ee)-ot1%I5K3^EgQ|C=;{}xL_Q0uV7th@YWhq%hZ3NuFwLKp#i_4P zFJ|*}@LZAGX=i3mD+)((0!qzAXYRG3uHFhJV3Vro&8lnV6CYi^C#_ki`aE0qDFgIVv%JJ(T;vey3G`P|>V_ReKyaa>c&+YL&E z{DuPmQ1}O60uTrU3WdU8FgP5JKp>DvBR9{ZPfdn6JmK0cmICMPB)CM6{$Cnr-Vl$4Z|)YR0pw6yf} z^cy#BWMpJesno2$4DV-WXXoVP+`M@+H#avgFE2ko|Mugw9s+Pb>ByLa!_*Vo^>ckljRCifc~8=IP%T3T8j zK79D-(W56%p0xgD=Af;u?dj~nvuDrR+uJ)kJG;8NXf#@PcXv-uPj7E;Utizz=g(if zc=7V(%U6F{Jb3;3^_w?u-oAbN?%lhAzbqfn>GZ+D!J(m{;o;$rA3uKj^l4;dWOQ_N zY;5eymoMYv<6pmiotT(lFc?!)Q`6JaGcz-@f7v|v_U+sE@89R<=H}<;7Zw&47Z;Zn z7nhfpfBg8dva<5?=g-yI$<@E?FxTe4t*x!C&wpG0%OB>(^1{Yn{xCN;H@CL7el33g zwX*c<*RS8de{XMZ?@W*F?Ckvc^Jn+R{O;P1-QC^2pG$kI%X^!vdwYBPzc=@Hw)gk< z4|e|?{0rv(9&>-6$z+N%S!_+69E}Z$rmD(#802pq#CPBbRR9Vo{?m782as@Ez0;BLSBoIWnVHlbnveYN%>CM@Gr{B%c5IE@fMR`4c zX#lVqUgJqAKWch+Jh61bkDo++cb z;Al*vuW0ldXRwTpz_It`NoXtq0)(R;L%bG(Cpuybg0WESG>nz?45YS2Xyy=*Ckhh) zfOJElaixn)CpeIK+?Ex{2P>1=c?K?-7v8sRTB5}5f>+*|cHz`)K5xDRHAJ^TSSXy$ zRoF0UftUOA^^cqG5g#z-gO^5|;iFJBB8}bf&Kf|963RL+di)U%4~SK=-Mk@iq5pCL z=@+l0&oyWrHx@^38k#2b%nnWKw6V@)s^8j-d!>O&gjwPeDGpx5aJIkaPdX)a|HS<7fy)`R-7pXio6p2kfQr}p>>W9&w<{YQi7IUkIhpeDcvbKib#L&MHW@ z-rG5BrppUIUlFC~67 z2l)YtI4CE4?IS-PemgPOfDV)y%a&ZZW%vY!;ffn!c`HGb=cTX#T$(J*Dk$(IpYf3u znz9}@A}yRsd>I}3<0BBb{oobsbO-LC!LL1~NOUBJBnqGii%0VP1RtUVLS?F61K(8+ z6&c{>*+}Q2cEpoL2=kAL$}$u-s3VLGLXyWvJ&GgT)Li97Ka|v?#% zI6U7Amc_N}Dk=FcWm!*nHgP#}`ywk~Xp$`on8!%OO%Ugg5>c4F^#WHGUs<}u&)rlZ zBs30N8xK8QN0Y<$Bm*l-La;0(5K6_o-syw2)aMyG;DMK5m4-b?kykC#xGU&uJYo)T zAtf@|8)*E8pE|SksY94MFjim$&VBr)Tr9;rq!jGeV3yHD8U=7{7YzHAfK}2hDLB6n z{S-%#6v)|Df$(e_7)C?WI4MejKr4q~JYWzzJ`JE-6Y$Ytovg&cAgF~9N|c0jrBz@7 zq9MnAISTNlfjt0HrlJWO=PrTCZAGYG+cELz_ps79BGJxyOo_x zW0^rol&6{FK# zYF4TwvndlNfrWs|DruP)>}%O^fDj3iUaD&v2wi|*o*nAf2WM|zPdq%7fkWSbDh* z-2Vkko2VV@)Cdc5MjP*EW%BSac;Rwz;02zFQ8LjU7VrN9Fp?9Cdf}K*9~3}EEGBNp z0)UB;?hHJ>NV9(~9{`2|m3U_9ot|+DhWLlzc^)tLRqH9_toL!iYlK3dq?_dI#IN;02)~ zhan z0j;HV@V-6@2+)1vs?_PoK?Kmi&;khMxH%oTiJJ;w&O+{n+Ec^s6R8}EgmT2F*~GLC z7^KJmo^nq}pnYyYqP#vG&`naV@_WYVKH!5n|1df?u8ZU86G3SjW^UAjIDX$45d3KL zKKV?X;_V?=R^KT^3+DQCA+DqxVc3#ILZw$X=`%GS9_~&j$+3~&vZRzKAS=$y@WB8T z(qkh)frDdPDzT>RVqCIJGYF8LX%;Cc+!cUC;Lb%SQYA3b)LqwBWl!K} z0*(w2*oJ7^FAPYK{ufUT?q2Mha;r+);4l>8Q%~$~<^w}UUj>Brhyx87U4|MwOiYvsgW99ss6$+$5?v_4utAlJ>fmPpP$h!CzWfJx zRvrSN8;Xo7Ly4;eLD#fQ&B2)uzU<}R6cTF`h1KmQrXMd=&#&>)5L6@c^^|G6^Jcx} z3hDy@uZ-?Gb4YK`2^?qWzF`QtQ4$3m^cr(OwMdk6REo=p&&NEFUB*}9EEov@+(g6$ zIyr4yg)a|4WMRL{fbXe@lSlyRg*bhrTSVkK2VhRUSpmgJCU_H&tWyxTMm4eQ+z-@>ED(M zH%x1D0cSx|?s>t&C^j?zxnPL(bOuGZePjH=UULjvIn~&UqxOncwVVX)qR|bD93WJA zYUFQ&d{{OulXGq?xPf5P?SobHJsI$&#zhWqjxhf$RQI`00C3q1v>~M5Iv0glJGGAU za(c+ye-<39M8P=``cnbtbJRI4KoeQ;LleMCP(iFE%27>p=6Q+R8sh#O9o*O9= zMbNnHA&VrBJDRhgj>?V}(#!dP39|Xhu<44UGv~p&CunR=38K3MvxX=&1p@%!w_7P} z&^&`6Rh4A-%e)54=?7?sLIXIyMBI+i29*eaax(ZHN3M1&s&<3H2g5`!8nn2TKbo)U zIHOQv=m%3tkMMK7G0m|^*LgR^A#)N;VPvpoLE)kI#E*jCNx|WWpjhY10|I*;(Hshi zBN=+a2GQDws+KgtZ=VtJbFe%9>~~LsB6EPAHn_t;U&ckEX^_}#7P!|P$n87ca~uN^ z$cMMVXH))48R>a3FV=Jpf>%x;8h#k0;yBh2r#xn5TG_ToOVA z58jhM16|~3!8QBfuw7JaQWMM@4`N{O*fO;9`M(zifzc6Us-X1q`h!JNPbv$o3B?BH zaceigyvw0e$YVrwJ(0DEivQN@#O4J#MPi}hP>5B4^E<~%03;n?y+b%jpqhNN1ls_> zr4XG8R3fu3v(W;(qM?xltl>HmPKTuJSk9hQ){bWXG7G=I$`aiKAgBURCZw@oM;FBa z&WEB?!PDz>XVq2o6Cz7K1HoAXUcv(~8vI5mw#*Av$9wpIZf=cZ$&Z7CjTT6(7eLGX z`vJ(;T$U$Iw`|w$Ae*tCo4l&{x&uaGz+yA38+~PimlFt`+SXgmM+PGvh|7Tws3(19 zAXHM2UcHim4tPcuTqeeyE{EYyTu8;aW^N!1vb#w;VBH)?EUv`UP$#bc(akGh7p=!L z3|gFH3y`{nH8ea8p+iY_2Q;=5t3s!nf#0o9ibkFs5LlicRu>`O{pActGI;B+g7=&3 zJhSwd&a}Y{S?qmHB3J85-{cBJqF<%yP+vRou3`mNd4-vDEFuhjVTRY95#D75#*q3f z>cDeIAn-WYKqB}&fF9}3$5KFWp5uKJ<#aQ|@aTz)QdK649JdHP^$qMkB*5n)U`Q=R z#hr{k3^|97d&xL^dJ6H!o93oXz1VCsy1}zTVtvyDuF$ZljLx0ctk0+TB%gSTp-Hrmw7!$%yP^DSWmqU4`HlYM^^rs zVRY7DKd}JW%-T=vhi7qgG+|Pxn5U!xsRUM+n9w5^zzzVTC{nPR!unGNd`%06hp|VQ z=Y1x9$|}QhkATmq7|JTTiQ4m%hP^?+Nb#~;ikS7UhOH1;_mi}mXy_ZXt9lbeEFP#^->7iIrBJf3c9F_H@zhnIE*YSPG`1^e>NhA;k zeuYO|{Z#yQtmCT^ge96uvK{x}$_6ov3tve%^i=W0V#mbt*NK(=iB*xwb-l?=kI7## zliS6Ue>x`jzD^$OPXeM0s6GSk$v|Fbpi3CoP6q1)gZ+R3c5>yd(ox-?fldy-gGqrB zhEN7Wu;i-)P8#FQk>bHvCl10^*uP(6ESJ53-)9%gn-ISbN|rEWN*MAb45bnVeq};U ze_G0xp^?GR%3$bZF!UxS3^KrD84Tm=4Ab}1%K8k8_Y+pvL7VFgyI_WWFvILR!?|<9 zH5fb*%sA!A@bF}u4rX}YpE%R$-50z#L^TWo0gnopGaNvH}NdEm=|pVJc-yod-)a(d8cf2wU}72c84Uw^J%_C=<~uGxt}jHCEbRY4xzH7tCstMt zR#ruSuIvBY^!)kj`p=&w2uR`KtO*|LvWP29aMW7jsIq5MK0?L~oEBZm)n8(IEN%Zl zO;j_2ntsy9eiH1V(|56tu4Iqg{|KW6CxbcIt~oc`6(D#eJ!550X^qu$4c5JE!(0O- z<~W`LSAMLoeMnTx!{0#;LIv`-eVG1(8h`my{F&fMc zgpQ|C!%qkgNHm}MuC*|#y z6uTxMjFI5>gEB7O`i_oVl<)4cM>ya+Dj)pnLoj4044GFz7Yq# z2=2XQ`^=)US2f8qR+hkO&vs5^*VCq*zGT3YXOts01XOo5*P%&fjtqEeBzYh zB_bW?t6}=qC>8xK=B{~|NEuF}nmU%JA`S#e@VB%j5Q}wllsr1gf*!8xCmH!8#clCWwQq?WqOkjBdTNT;n1iDVusi#!oN z_*UvwzN~YL`yp3ln?lWR6VKmp`+0W8c!+KZ<%fL8FR8ZO;@OZF&_-pE*B0$2#FfME ziag{=Bl4N->=j#3rQaQk?HLYjdq@P)m(Y`K4^Rs%{1)QO{ZYt^a}uXw^Pg4;N)IU+ zx5nQntSVgl9`^m(Z}ntR{?Ld;ZA|ZQxZ7R6=RokS5si1S+J4(qvOG+ps7qGrSE!|Z z|LIC(!O^T|TjE)=qLDmE`!nL<{Q!bTcyA*aCcrb*C-!(gv^+;&8hyWFYVSnd)A{Ur zKP@(cVFg*x?54jqm!0+e(>yXg7$@v(H5{^%9!V;rhs?>L+z z7E<^S(a;xWEumBVLi?Q05#-nTvZ>Phn8al9UTr@noWs(K2N21oX5(TXwBbC@2=b?D!35yP!=-DxOZB`lkaERo zFOIAP?3S6J$$p&o&Gi0NZ*k+Bn)7^^YStvj3&8gGGJ_)AmePq^md@qQFA;;z5eDg( zJi7gk)fKXw93}`0?0Y}wKi#2v9!A{rPKrN~s`rT=!rK46O#3>1t}KZAwiz;LVh!< z{8~YCy;Ok7QLW&vh5Ht5uQm9sL+BfeS2xRnkd!8a-t#hupUTZxPM^TDGtT>FuC zEI)tMu8IE163LLO_$u}#Sxo-&>E+?`F7&JN#$NOD6p0p3!vB4p=xd&!%B8A@h`evS zp2M&b&VQb0vKq(Jo`%?0NfNKB;1U5|94#UyI{9J5^GF1FhjMleF9KVY-*IV4NSd*i z*P-$rf`F}eqQo}rkU&3N3D;aF6$NnCkqj+6ryv@&@fb5rG}4Ed;?M^L%FUlwvKyJs zDN)l@MyKUCr%jPP3!*pI#zr=6sbxD zQ;2mq$su!se)t;XyreJ2i>ZlLQeQpHul zzHgwo*Fkw{VH450KBBA_5f!Tl;XsAGfXsR)E8ryI_XW-;PQ(q%^{`nxH>6qFK<%7g zKe)b`o`(3g7OzJp3q4;=7Hy~ogK@O;x~3G`UUM3Pb&J#Vf~-~<=Z%DPZwV{&xC}ZK z9y@OYeYu*S)KaDxaj;A9fx!n#ZC=8;!ASxv<)6AoAO9$_N$NpC@;B;`ye!l z!>9?7*zXOO@=Fp4j;0>BE<@fdM-fT!LbYcxp5}2FADn3{E*>UB z=vH74hn~T~Ii+PGM6Gf-$GJqsGlS)- zy6|#x>u;}4oVk0GRv)xr`NfLok}w2XQJZl+g^Mx8woO}jHy!=t38TFI3=f@7l%uG4 zuisT`Kpk(4vv2TT4$DvDSy|S0{%8w5;})-2U6S?yJu`8l^@Y4XKBKbc3})T!vc7)f z4Kb#y?;Ph&-0@D4Y=e4Vr0SI`w&!p+&&r%_b`XqpIX)rIhli-hboyN|=qF4bRDVpx4q`rvW=kz1@thgV_r2(NPFkBlEfo&zDH?*k)iOGRcp zlAn%EJo~lYa%1|!Z_Tk6g}*GjIyyoRhm50?e`gKE==lyj{n~p~BW_0I+m#xjJ4-Jn zI^yzvGB;MPzS%E1Myr!qo#5PifV?b{S63XAr|N#0onN8PMkef%kx6X1G=LW|k)Gy1t->=?qT)%cjUrdDV zEVtRgS)6vz#dZnoFtBC#l*?jIggEo&ypi=cRw4vO6xH zn-m(8s*TKVE{+TSEHb_({TnsZaW?X$*hEOp@3yt#xa($uj3t??4rZ-P`+@BO( zJ}Y%~agcfa;^Wi&E6p{#u50?yoxg=v2c@npa+W&3xGcKOia7| zX_rrzMSp#*ikS_I4W5YQ-OiIasPc-3gMRTb+^Vc11RCO@CPiA{dF^Q@@?Ni6*KI=s z7kh(QZ-WZABvcgQ5(TR4MiHbWT=s)=_=%YbKz(VnlR6Y8tOOw6hUngc3YWlyu{uD* zX+PlBdLq)VhzpItK@_tXw23uZF2qoS(~u! zNRwRPKoJ}+K4fxR$UR4RxmaWqBRK*ilYl*AiYXmJZjC>-it@@&JO?7!%?lFEAxt3D z80ZHs;F7h9jDyRN+I_vc!@YX5z51KI2Jk)tPoH6*@r5R&kx8G4Q=h4?i9ugdpkJT) z%|44NlknE0pxQp`;Xa%3-T zPoO8fZ;n%UOE%dCa_8Y^@X4;|IPJ9O!Nw}*O!&_q<@UQN;y;VACB$K=@jHhq4YiWQ z@=1dIi3xrQoD>r82#jc9=2mEWGfjp~5+4;Iaz&U^wp}DrnEx^>H#7OD2nEiWa#JMr zCU2SvXS%S+jXf|ULL~DVFIAT_3oep94CWjax#`P$OOi8pTsW_RJzrSlwk~ghFlXVW zP*D|oF7-mocj z&x!l~FxXfm*yPLJJTBCt%l)8%{UKTKkuLk=KA|T^xm&B)+kyn29%X-4B-GBz-I31T zX(HIg!%8a>>?ZTp?J4#~@b|H@J|_#l(B(`Rd?<+ zckH?_|Ar*)XN1g_6ZbDk{vUfPS99!~D+bh>2dYBtPQ=+Q670I??bLP#D$sOSLHfKb zou*00TM#SUh%Wy0{Lul&R3gu9dU-9~v5o#cir6(m=U$-S>>kkjFmOV_o=eNVbepJw zvHvbG*y%UOd1bJKGI;Fv;7qN3XRAH<%D!a8{@8;3%=TbAdWb`Cs91JLP0OM46;b)5 z1Dn4?ag>8v$`H-mp}lr!v301Zf5>I(y-?wh;va`av?KGq{mUQjgKkzI=G{Kz3pnzO zI&{qsJ)=0z=R4-te&BBV(An?UHuB;7{D-`4M=p$0r@(NltkZYR;oIi+HdjBmTpgaF z4Ck5;bDnS-(sIN+b(-mSn#~`MPJ49RBbCUTZhx!Wp}5uZ*fD1|R+o1a8=E{;j~2Ta z+=(rglQu8Z-wil^bVg2p>|Ax84*Qsq@R6wC(y93=p}m6K`%zxVWzYXpd(rXkS zTu#A`d9#>afw}PVy72A0oM&;pF63&d*!YNnB3&)(CQv;u;1=*la?Ne=^ zvs|^oUh80qF-2eh2*!4>kd&}-w^-u8(k|R+^WSd?xF^O;y1|lsPn7aiD`o3gYOz?F z2R8lK$Rfe5jp$YZoVWv?xS^z-@kl*$tK_Cl>aF6>t`}UbVqC-1K2y$&)?7RhnsCDI z&55Wlqc@gD8+K1bvWz(kos3Z!`&oYfnBa*;*%J$HC%pp4;;){}-v*$XP~yngBi*rP zt1;5Eljq)yaStX((^2efr}7v`(##TXiC7UV5(;F zS$uy232ATislfSD;f;@P?qo#M-4p4_QQ*+aODUHbWTpfTV9|uh699g{qI@ru42{I< z7k~0F9D|SJ29pw+l7vDJsf6~#+!%jWI9^ike!24N{QP)oS@QBX#|hpPU#|pq01zo7 zf5#*tXz1H`vY;30ax27$h&~%iTDX&d(?qL~;$vEopl0G})Bdx|6P3H3*H|XMQ&87I zOthE7<~_6w4nVKQzqO?Bc#(_faoLb;AtG9j5T8(+1f?Qln}CLO)X{z@JmV92`4f!W z7W?<9lV>VUlk9mC?bVc2G!M9FQd}88;wn^?K*5wHh5|s(I_fydG|>;L+n=Z)+N_)N z=}>S#>Kwc9doyt!YSqZY3t%SJLe&Wr4o!q#=*@&yxIit1UjQONn-QWXg)+|Q ze?kV#&k*=#4W(y|)Mt&4&ziW*nx2~_yiW@7n>Ej!wWyx8)SnG(LRx*AwfR14%Z>`9 zA?^6S=}#a{l)u?m`x+bj9?`ER*20cZ6KrZfamgko5ED6xXw_{fIh5oXl?*AnZ!BB& z*@jUwJ6-2{b_P6?>h^uZBlR2!0-!x%0I={QMcPX~wlzUOmtsbZO8}Bke)+uf!irI7 zpAv6`{`Z&G=eqsQB}Sb$mzqi3hOqRLe>I~VaFFxU80RLEBN4%>=@r`w+0#j8n@{jW z$BSu^dCCyhBtV?(!i*gA89n(@lLQzEw5Ab?~;q?`Z%>KMjq6(Uv(_g*lF z-A2f?#vS!5irI#V$U>cKKmK5AM`S!jifX2_r?1^Xmm@!1v84n8qy-za%y-6(;f3cj z3->k_l3)Q{{T``JU%z@_1@Q&sRyYSf0Ek(9ownFgxR_QS(AA2n_>~;hiW+cEb?66F zyb#``#A7s)6^-D#I#ndRG@!8bL}!U=71%YOe5EY;Y8fip?^LU8DqB=5xbmZZ<>RxJ`)^iOzpSh+t*q~^jIsQDAoO!fA*4<(1hD=&dFp3tUV*m?-`;p#%SHi0JyVy+Yfu)kh!E#dH~A zIk=JM*->_>Oukg$Jf6dh6EtAwJc8x=jo}tch1B>RQeRc}yuf3?$vYs#TB^?$tIIxM zDlEe(!XYC1Q(tUA7ngZlJky+|#_+I#fuxw8RHm8q<;4#fBcDBOs4YJ^y5idh~lH9y8AsCVhbQZ0S*elvX?=@EOH2M!M!!!O&)L~BE$teu ztTHXE8%=E*^&RZ29GO;5lNQb)$6c8EuBBFPcGf43Se^_qJ7s6!{?p2%)Y@~v@^quQ zmkhz%z}n}hHPP&({b%C2OzZOoHfO}Fe3|BFISd0PtphV{fGz>Xn6PoPq zCv(cb#vvls=F$<{ur90cQj3d?Mo|McS7L1=^V~0+ImU?DULUZHo%1B2oZ~`ly;70rDqTA<_4%-cWR<9`a4qxtuvMc8)Ng?C>Z{Ven(x)v2w z*EsUva*zY;qQ<>2-=wSDZ+5-zeQse|Jo_BbB@_C2;%el|uB*---tO9n=e72bYaJYW zPhLKHC^PgZcHnWBb+?^m&u_mMrD2z@?{nTQw#si@OL z#5H${pLrs4=%BjeI5J6co#qu*5xQ1F3M&tNuZV*j?g!l6C|0#3$$pXxoC`J5m0L0| zSU>;q<>)7~EH?&;JPJD#&c=>I#G;dsXdg4iIYH5V=-k2R)&aLT47Hi;CjjhhB)jwj zUjWLXtUWE&7OR3TGM3-6`{8Q2!PPmOLxbO%#EbMp8sW>bAs#QO5@y+oR|Z9Na^ziG zf)+Br>g1`OAF8Ug^|UD#jM}bRO2&lK<3j z@=5rQ#Vv)ACZEQqIvT$e#~ucJj`XO>P#SLypZo6kGDCTyJ^E3>#kphWpZl62x%Ii; zmS!_`v0~#VN6^VV^1*wFZ_I9^Zl|gTX)fq~`_e`)?>)hN;m^^<;k&L6f`9xuwmeeZ z<(+e3SAAvt>50HMk9Rdz89f7MXVmvJ*JtY*D{<6`UfY?xcB@n^9XIV81%23VXj z$Gt3gH2aB%C9%BkH?tB2A3K#MiR9iaO%_iYE~W4kbN2}36%ovhtoyU*e0o7ca1e8Q z>ZOz)zR8ljXyYV774R02%;E`ilg!4%6L@Nx|#4y^CVAP0pM0U<<@c zlK(uZsra)qIv*2f^pvxlM^JkqCdEfytg`Uw@7kI@J^p~>w~Qj>>VEha$a@vHoaC-; z9FnYSz~24?-hDLm@a}!(wlM{(X6Q4ndrv2x67To6^wqaW?~f^3^cd+lG(QrpC$@aZ z?rV4~uJ=XBY$*Pj{i7DoLgM3@@V=&Wfp|GBeyaD&xSX#kGeUo<43cUW$Iu^hWL(?V(-Z)d#H#^}B`b%q5+NGzEpdroIRM zx?TMm^?OZkVN2Hv=t~M6EyJ+Dn8uO9y8ZTXj-{AJ#*(~#&TMa>e$)KY-Rt+3WfrbK zW3K*|kG;3~Ccq$jwMKb=AvLyTeX<^KlZ0fXkshfs>cM__1XoHNBfP8u*DsH$PK`Hg z@p^*amS?L@O{iMOQ35kGPgj+Vh|963r53hKS2dyKlmaMev~`JU8d^?8 zJvCiW^-LpOQ|_30>W$R!%0x!3f|gNgMrzAU`Kp_^-lx>e8|yRWfSj!1pJZx_YE=a& zCu@3;lC>K)TaUXUYjKd0eXXVHI{uZs4K_9B+PZHE;fk1jb?VJn)w3l;e;KCpSn{o^ zaH&!+f0+}nQ*t+&&(?RWgpxqLidEUk(;XCi10}n}qw>;^bvhBvL9&TKuT^liW8BQYuZ? z{ip=2WY!S5>Y8d@LHhTjiM2eoaHZ^H!c&w0B3a~#d7=(qMY^$Dk1$`De~H&2$(xVm zq}7}$`i0#P1+O^R+bFauh=&41WAP_cf&i5ct#p9bMLNh+^G{Y3q%zG*{c4SjTD*{? zu$e>d&i!0bEgZtKKGum9Zl98VIXz0H+!G%<&!V11wQV3tMELfe%xMfD>6p0|3S$OqK~rwkJWdsJttriA4wcmVFxCN<-@7yKuv z98`>JJ;8`o(ABi_OIBv?EW6SP<3A=yL>~@`6+SG^u4!siO@jl9;#f?WDSU*G$aSsq zP5+;8MvwJFmEW)G?6#7P3n6HN`!Vst{G`fb;{G@c$ELWiVJ8hFkzXtB@=LF_0Yuj{u z%CRmzw7k!H)wZyjqUJT|A1hp`Qp}!oq`HH}$GVX3bw2Y`hlEO^KMR!gLv`<=Y7eBI zwGK;6;-?Or%8D(jXT13Mlc&5N78E6+;{!>Q_8O0$7i*qr40NZt8@HdUb*^Q^wkMO1M4x=Jk|5`PaKgPUu$f z^Y|lWMLGYBW zp$e|q--C@PV~;B@hkMSG#BnVN(xKi6&3yf?bxycYXdJYm7JZ17b~f&UA;ObJyD7R3 z74&s~-P>Y@Hkrx{BmlozvXZp+y4SWcP}Fz>r(PIOukoyiPC7wqkL9Q$aAOdPAc+k{ zkPg<~$le6Z1)v---k`OYTe?qb{f(A6L0J}!IEplo?!!kB_Au%AqcjHr z7|eGp+z`&O-QDHX!{X#A{g7Zp?%n*@Q}u|(Cn?_52SrxFm7DEUvKFm`s(KplHo^ZG-PMYViGO0qB0u^cP zKKzg=+2serJv5w?g3BH4zq}{j)c})dFqD-wQS7VIcIpx8@0MAXn*CNCydoX)t2*RB zIuuzG$}SVeR}&^G6E0m7t}Js=z2>66OvLe;2wRy;E;W}tWg^ejLDN`eC?Q#<`GmGr`$B+@_mMJ^gbW{YpE$X*gP!UDjd)mp0UoD#lAfmJSBnyW5b zSuRJtE=OPP=JC3lPt6GbK@)X>NCHoQI{@%klS80|WkXN5UqLT?JpBLGdp9G}dbdE6tTYacgIJ z4%HAVR|;LT0*33|u4v!UY&`v`(aSOTR_oD*(FX!gY{u2u?|pd!&hTD};wUj_joQE# zy^JU`h*sLdzDUcQ=#EN4DR{nZZJv2aJ#1BC-PZE$O}<*-#M`z9a|30@X`(hyA1-{T zb*%S%_w>=y=cY4nN^G7z{_&;t;?l&sXHR}k(h^w2Y};GcX8Lm!PQPz&+nA$QT9w*% zJl$Fvc@Q}HzT?^NpN!tL1~I$N_MMIS5A~-9Iy-iMug<(Fwd?BK-`(C=njGlrVln}w zEQ18+^JB!JrE3}Stm^ZO1n{`*6q(1xZz@sXTDWnj)F&H=QC|T|1qs z_;`Lg4gW%RCjDsq_P`D1*X>L|dp-HEp}{o2Bvl8C8KiEAzanOBsq9d5EG*%7u1%Rc z-HCBjzH&O35d2Ci^K|F$v-v*f>Lg>#OGc|Q^sqeOzk9x(fFyv0IR4iG{*OJ!IHqdA z-sS)1ISx%7k3VE}_uo86wBrl%U(fMfp{7c>Q@%>gKq(NP<6qB_ zXsCMO(4)H_>zxE`pTB-o|Do8lJ6gm_T~;e;_I<9$n_u5uihaJkF0Kz>w0Ih|kufgo z*f`lmg0YBNw>C}nQn>%W7~u7P26$!o;61ZLBhypw_u|^nGqY9E{p|}23u@*Z24AAL zg@;RHeHXYnj9^^zA9XQOwK$huVG1L`L#tmb(fx!QHAz7Kc{ySC+K9J<#L$BQic3mA zF4Z|kVBosq@#p1nDlUn3dWbEU-3^!L7fXTVwWyDJn|*4fRA&VI-$&vEoCR>eqkkU> zgBFYAmbcz+EbmPO+0-R9RebtVd6bO$^6d{BlUenWoX`%l-Pv3=k&<=mj2F33d%jse z2Witn(XbcfwvEGf5KaHPRdNrdUR2;kB=%qZqn;8gEsHJx8HwA2fUkc?^10EgH&w*y z@!wAQeYorK=JDT7h0eS#wt8~^>$9kh#jkIk{I5oGUet_3v}0g%Qw#C;+d87wjF@B@ z?WvA|Ew2}89Zi#SQM=ZQg~>;zJHJT(eE019;Nd%h?yDF5;BXK3(!HU`faqD4_kjg5q8(RjfByG5u|tF)#DC>9urFl3T1xt#D7vlo zWj*mot$!5Vf9;+E;gP1Y*Z-#IUX-*-#sx0^vwH^8;NnmBEFRVlR>~z{om2mn6Sr!N z=Fxw0I`48PTJ4{lG=eXT9{VRJ{tRa!)xSA;8$P~;{hL!`c+JHBMo$0dch9Z=w0oX? zHp>*%js7!>`o-UPU5|V~uRMKvdzgQ~XqTqO@YpKLc^}7mtQF_JR+hj{X4BI2KDjw~ zk;7!`?Sp}&^E>?Zl$|UzpZ*2~J*cl#U0dP0AA=s$+dym1xURiDe8%|qaPmOL=_%Mi zCKfR=Ni~VT!!X(spm^taf4poLyFVr4@E=bJTgZK&{jU-9|C|#4X~~$lh5T2UdX1qQ zCGszs+Se%h&-A}!YOBOec;C|RmcL6z_zX5b`R}Ak@ra=f)Wcf)BJInf9@_b#y?G}63o?4QV?aywV|E!RDA;ai?plHB)v-(3H56lPUjb!tGh7PV0Nu|HUJxbw`M z4ti8eLg!jbC0Ocrzm8fa%2hxu7kaHFTX9HLTc%h<+mc$5XmpZT$V|^)sLZ}jk-H;{ z{0}S50wN1^1NZ;K4?sV9b6VU)fWuQSid|gaDW5vk8UNqg^y?EwiCgA;<29iZrnmlO z)90MiOWh9eN!K{?Uy8XBf2i}gKh8p#Kf}rDPo?B}Z;bL~;&h94iw;M(O#DY^&F9uV;I<-RDpEzCPFc_`crxZNQb`9J2;z zRi)8KejRP>80-L6TD?U?TfSZpm#|sO(RX>TfRz?dQtGk2yx6tOU%t6?TID{l(mpkK z_P_m`EA8ixYWKg_0M`8)Tq`V2ScNt}v1kQxm7Ey1nFdm*@(R>G?jYTdq^ZrWpBttn zy(Ef9(UWsDO%0=*lRhdnN@`ipY>-MY5)f+B9FFcKB^?t_l}@t1S>ck5dFU^l?gcS$ z#j8*Hk*}Yrm(?WF$4<&*E{*BCWre&r+*{C*MYSJL%&Q{+uF)B?ZXy(<`d1oUaOi>y_pB zNcS#dD>ohjuGf@#F6N(Jub)%uXHyRN+g=d3U!Tb0v-JE=goRlgsgBnT^4KwGcK*J` zyOn)QVKmBXnN5SDD}l?x0{9E_L%d=R%e8tPFm?!3D2Pp#VsF31lb9L8%Pas6Wtm{X zTn=rOI36L2r6gZu9!BD$LaM`e22S1YNyf4MDkE|Hz)1dJj9>Kwuomr1gA+!a85sEU zU7eYl)Ll`zcFGFC!22vIg0p!fG$C${k@GFI$kk0!d+dJorp4J&cI?ddjCw6FkcuE4>Q27s_L(TXpL`^nGLlf&b=yZp(meDKKpzJtUls|jz13oK_ZwZq0zlXqGzK2O#Y*J;LDBSyoOoe16^lOxU&_>K;190xa!t{5hUtiqQ7a34aF+*%$?j5e#u~`BW zWV)a9e2WN@5N)<^tU0O9aUl9kpJw}Y7m2a|l=r~4#1 z!*9HhOxRIHA`?TaBqY=?3b;eF*o6&8G@_L!DLLF)X*+Xf?#&hCY&TGo&5^XDgCk=s zubj*!oNaO}EV%H-as4jVW0C=&CIGez!Vtx>lq@#2Mrc@=q0q^MOZBO4*YL_Wp*PH!Wyfw9VvaiBh>;dvC*7EV zWI$3(7T;eA`uD|k0L*j}Kw2b?Kadub$G!GLM^1g>mxwBtx+Gx@)Vv#mRcVIn`YdgA z)XM_)zTLKj0@P)_RL0())Xuh2Jqomey!l!Cns_6j?ppx=J>@7;zMr8J7^ubkfKKoO zC;4w`Z|!SsP_~$!zxVN2;5?-Z7t#LMIfyzn75;jliWEHG;@z%EttAniKC~d)5iI>R zgJIEK5@K3(maqn=q_Fa_S>?>_>g1>=W0)OY)?_QWYE; zVxh;lZT-*YwqOr9ys1=GbU_isch9h1F{PLgG(wnZ!rromd8l6?QuGqpBk3klgzc$G z(1Y&GjaMZmUt&y(<$m)x)Hh4CDg8k$=tpX-NW$eO4Cp2IOFqST5-w}Tz< zxzTx4ZB87rrR%5+1T60)6YQvb z(5IKEsnF1n^R4Fgq34Gc(Z1l9z(tpXtQSgc0F))fWVu?2&!2cTzZVF%l@Dt2H4rYh zK33%Lnoufaeq&82l^qAbmFp^nRq~&)tdoSswF|X75-Z z$F&$^Y(pId+)GSbOYa`NaJ)KBdRcgq(&^)R89-U5Cc5r886~M&mHt*pJT*AbnwaA` z@HeOJ;m=sQzQep=7`4S5ud(CCB@~SP4hsWdJ#bW$zgEDnMo}r@j#24`N|@7I6!8e2 zC1iWtd}g_m8I8}tR0CO$L~H1=|B6mnwn&tO({wmqAyAGsruaoS;Y5T^JufQ?r)L2lDE?o>!%bw4 zEm5m9Rk*veOo5?$8{OpF(tey#PK9Yfv{+T3c7ojICbLjPu2GJmZ|^(>FfP=O^7k;r zL!R_*R-@8g+V>q>Z?Xlpk320oMZz5Bvbt-R=kspT?jh~BfhWdXZLG#ZnP!PXu28h&R%9pg z_|^+iW`JMy5Cr7DF#M`o+y*=VofcW4e~xtwvPK_A22m+5=F0D{YQ{I;_TVwK0qj<* zv5to?ElwIt1D;kZLx`#?^p>f-$e7|QJjCXx#qs?NZ5v2H<-Q*4}j|HPxwj_NhemJ!|c678Exw-b`DXHY&f@d6k=#vAd;wuW^7rKf=S< zzX)-4Zj04V_p1i}>$01D{wU!Pr>zThz6xfS1;uj<6gnrM6e`5x(aQRHi5!+TV~Lv_ zQconCU{9VvVj$2HscfDVqbYXT2AP;m)v9Bur}yMaV|}^{=aF<3wLm3MaNSD4zGw9_na`Sy7ZqoT*2Qhx%}&# z=S0lo0BUWgC}Jr~N(@flRfT zAz;YY4&z8G=Yxx@l^hS>W5@=^axyg>$0?cpDhj7Q<&})v^uC8=!Nl~3!DR(<2W?xm z1BMu;F<{&P5+Qi2Efln~<`VY?-5`A`Q3uDTs9aKD;&doh2(B>gX5w5OD~LoG7wpe6 zN|OGPt-4x~RpW*+gbaxgFpU`%`M(-mCc$$f)#-X(gDrqM-E}Ob$N8~8U4eN)2u#!u z!pSb+1idl30SfPIE?Dn9Yuv#HS6BYD4{|DI7WQl^{}<89*M;xkZ}rf>HU>WC@7#__ z0a)ADK;>f~Zl=vlroXo#bO?C#=Z$|AC@aL1r5(Ow)dOK{9w~^=MuoLN+1`6&$n*n% zF537&rY#-Lc(jkxvnUN5qYcTXNq`5EL4Pk>o6Bg!H!tLj01xDfRHW}v(|xy2R9%22 zfFBO=G|?Dt)&H9W{)TUKNxz*lp z+$f+nsd+ILYg_j~RA*kZfFD8Av1q?2fKtNih@MkPLM-Y?W<{DG0qiN^Y$!iMO06~< zXHngWM$$_3ovtkKShT}F|CYiZG*|LGOM87AS~8UZe-{dVugITVsaJw~35cjQQ$jDC zPT`2QdY8layKwV>3SJCxRerS%#ahBX7&3G-*ZOppso^=mKQzT^Zg{5NR3h8zw_#bz z7q|uWh0GI64*>q86Rc(fSlK1)-&T9|bvMz{y2sx>IzsJNkK`{JB=~N? zelkj-*oOym$y=&=iH_98xy~GOKUjPsNt**w)zT{odv2qSTc}hTrF4prUl>LIqrVHa z-(3tp@9)B2LjcK;&yt0s8k^({;u1DWM{P;iP&J3rw!|2SsZZ~EB^742M<*}TLC(S@ o)G3X_CC$8eiI~ow5hZ<{rO`k-;~e+KJk3Dqa%TbyaOBnh2cem?Z~y=R literal 0 HcmV?d00001 diff --git a/v0.16.1/poincareanim3.gif b/v0.16.1/poincareanim3.gif new file mode 100644 index 0000000000000000000000000000000000000000..260428e3dca50bab0ecb66618fc7e7b3e5b3fc4a GIT binary patch literal 317626 zcmeFX`8$;V8~=UHz8L1RFImQteHmL(mKl3Qgh-Z=z0i=YLc@%mOeB{Q}ODZxXA)Y8&Aa^%R-qepdhb&oy$d;IuueSLjHLqjr|Y;0_7Vq#)yYHIfUuerJTi4!NR ztgNi9txuggb^7#a``5b;4i1ivj!sTa&d$zf&z?PZ?wqTutDBpfhldA+Lh+9#|7Z4C|@#4jxprA{aE`@aLhK7cQg@r{#L_|hLMny$ky?XW9wQJGcyD>2_ z*RNlv(P(jTadbMJ@sIw!goK2oq@?8J^2E-oo4DJ?B6`^U$<^78VEii*n0 z%BrfW>gwu;4Fw^XCl>4KH85eEs_Mn>TM7 z8ynyKV{yN!si~!GRs&%*@Q}?Ch5>U*_iK78Vv37Z<-K z`7ZtA_x`t=m%n}c_WdsH$3K>rS1Oq+HF+!lV6Xptl=JiF&(*qu)zww@v-|A-irEci z?5+K^7o}^jD%RdUTw}A>-&C!4yjY+AyuQBvi}mDJYyGcZzc#vFZG0Hq_{Yxv@Aq$h z_ci?yiI^8ZyE|K#z1gFXPZF`^c=MNM=xucB*bZE;HyC~a9_QCHHICZu^` zsj9Dth8+SyzN_&n?Zarw_VwiC*suPCP5OPO&VUlF{*D72H!@C2VV5=I1#o z@r@visIMBX5URP7TGn;P%*u41SN zIDvbjF!tMWN&~u4dM6KUUDUMEke$ke3vRW<+-T51>UIy6Gow7C~z> zCs)r?J4`o%k|oG1C&AC8S8VlmkzAo$n9ESH%PGD!t?G#cxPVEwxNk$TMfR?LOQ)#k zNSq~k+cj%iBZk@3N$LR3CyLyhFCS3M70o^+6Y!?)0jZ{woG5jHXXJ#q_oJJ>*PN0#vi_zzSg0RhzZ5$uMk4p(@|BST^a}#*aZ>h{PueSkZ1et@Iz58OMXCk zEztFyYctlcx|6%TU`(FJTqrUyZSJs%Say=oRb`z4#p`)>?Glf14tv+nvly5_kkqS5uPT$!a1T==hJ3on0gli_kC9Vka1^+Z7TQOP z6mRGqk3(C~ghZ%`mN@9uX>JQyXLh1R-WP5Xz(RlO!1p;8A#PIIB>p9A9p;J`mfQxF zzx66Y-ss}#(+nxIa6ztQ8vafZ{l-=W(}E9xcn-{YD6=&=_*hUqHeIG{6A8Ei;3HaV z$@#V#wCD`x=2q(=DO*5zz2&k( z^9oSopr*{V02ai90+&kWNsxw@@ZN8LZ49xbfs-`IsVEbfBEh=wxOd~wE1>ih# zOlg3`m10Ehej=#?N@Rn z#twfoetbFL>*-tx$S8)aVYj%vA4P}-0F1XIz$stG1#}jZbUK|C zdjt$~Lve`|)qI>Tkw$zGizNbxb)HHl?hi@arZ~-S=7+~B03iKm#T8pW-uiZIaoawg zTggCD_?S8e#whbh1M4nj*m-y9B&Z1htX-i5KNA39%zk-2_7@j~kHC~%zD+RQg&gX# z2I)!+7rz=FxBxXOc7C$p#DuY$OyQZhH(v!T0N}t*<1zM^$b16VLQ)ws@TyS#OFg)5 zn~?hI@4W061O)&n79K(g2NGyhpUW_6AdIYi9RO?>T{H$b-jbBzWTdl$Hc)E{9Xy9~ z03${McLDu!CKySEm{JiG0NFJhc2+PNKInx5Aj%W*U=egO;T(^w4#EzCCW0w606h>c z?QdRk#$7}QobvMFx(P!t(G^Ta1t4*UitQMSgvBX%O9!CPN8Eo?eb0c$)+JusgZr{n zc#}V0C>o#vs!Q>S3%Va)fS&}cl%f(rQh-cEu!sgY$LoSvg8>wXISnBlj|Q*=UR>7I_$SBZtX3z~k%z66q*9 z&S!Uk-+KmNcH)JSmC@g$;TE41K9xo6FOfd!Anwoq+QbwU-BZu7+YIIHyLJ^oa78v5`lOWfFjw!4njhtoAKuX;DjwG ze))pAFa@AEbJ*EfgB*xj$eF|7*o?@R0I<3ff9oc2F)w6u27t2z_$mPGM$Sw5+fWDs z0GQFnMSmy3`dWiIXYiVrt7R^JKsuL;oz9(?AxI<#4w@p!co6_NEe-x)>P5EW1>`g6 z3SfE!gm=en?#wmhw>*6X@OdqOCCR|;V!U4X4D)R~% zz}Dn!x;Wnyv`a{^r~tDmZI}jtx=F&O4(NQkY`>TTI1ONKQ`|&JW%IL;>ob_^fW8%&hlE@dC)Ei& z1f3rMFe33R1scFYmw}iu1ifk^23=SE2!Ox_;5k%`bqbDR-anRPeTOFARC4_ z2JB%2e3-BS*o%B{6SP9x!Xt{%*NF&)W70oZRwtR5du#-TZPaC%E7^)hkfNhbWT42X z4NYC=)Ec4Az-W6!;Tk_bp)j%5#Qi34i4~@I6^vz;Q05?ilfhdlr55k;mhbU(GrArJ zO)$5?{6remBM$Jg1%Lc(_?TO2U2PSZLWLx05@pVT=PBU;6Y3omQB8v7 z&jD~*@W{s?n=bry(p!&NNE#6=ph6oVfX6j3a^`sGc)ji)GQa|^P{kbY-qY^FpCahF zlL4bzxBWS2&Ao3Ut^8!|Qo+SR?-OJqa zU>pfj!OdAwOC@=s14*cF=3qHZeu9cUYRO^a48A3xgD9wMrsvxODmsXb`Y6{4kHRjV z2UkE$C`ribGWeW|RjcBp;iO?+_?sXqe8zT+iZyJxv&lwZqM*!_!EzGTp&6{CVug=@ zccZZ{>$>W{8D~BG=cDLg0xFku{2`GDAH+tmkxUAHmWsV3eElj5c@@Ms3}K)5fDzvD zFuSf?J@mDc-~tPK{}EUbja>?V@0{Ar7(m9+l%7zr@bmZzQgsIvOIpBX)b=E@15|qO zFKSUiMQCon`e+vN8l?le)^QZ;b|UJ&`z^*!d0uuA>ZfQQ%8u)I0oX^yR(2k}37~qS zTjav9GVk##wjIbdjuS#5H3O(XDk^iJ8*^|Ie}{^?@29?gbA-M;+Wo&%})KHjOyP@K&%;Xd*=B?Wnz8&Uv>n-*<*N+p$pn@h~yoH~@)t8`gGmCbRS>Z@Eq0j+xB6H+kpnWWn@g;ofAC*oPAR4`ps2%40rM-uqCUF;-+b zu?-A{?R`j5`Iv0|F)8R{u|80nF}6Y|NO;TDXg%?Rc_P7$tJQj9f!KY&=40aY#}v+~ z{+KCx&{WF3sj}Xwgq5je&gqXT(^n6yr;~%GOEab!HPcDG(_dGn!#O`CseCH2{zMP@ zl$i19SIwue-cN}upI*NG=%@1eo!Asze`+-7^W~b)MVz0nu6%ChoVltpGiyB)8Z^`0 z``Nc<2GTbZzB04IIeSrMwlHHRJZP5l#;led{udFyR>bw4#r2iSrTCaj&H%qf;T9?U zEP7*1{L>`CW?ZUpR^|rx77?%9$2rQx^?HJ|0M|*vHG+$lh4XDJ+^{X@XBro=53lV$bu@NNw{P;e!MMK7_=Yw2Zx+{Q z5@$PYzKMWqvc>fhImg+Y-wxPZzX0AHBK|v-Yuc8xpM`4$agBtf<^kL&foqjG_eboj zum0D&ZeK%VzFxlf6hVc!2YpEgtb@W*fvWQ8~K^xE%Ly&1~Ek0^TR% zb6d@ngw3o^(D%@c?=T2{YT&zF;kT(GuFhDIOEum z%MjI7O!4j)4%Lm{VoAbI2 zZlv~)?qj;rHGL7cJ#UhC(!Pt3}ZoA_@m9Lp9*!Sm#0&fW2tEKnOe zYRJ1y;xVd_lNE!LQW}Ig`Ym~?-_IP;F_DgHxPkHy&Ji9Nis3Q8Y@G9yjO^>#r1m$t{ zdCS`>3b&QMo?bk8M-?^yFyG#P<-aw=1sZ>stox$@~$zIc{-aBXf-d=2?S-*95{Q2?GwY?9m+mR0^ zo@`Y^q-BHee|#SQu04D?M5X2G2o1w~)b5gZO^ojK!X^It)6Fg&2i749BDTd}esx$)`}nOE_Rl`(vRd-$>iyLgr z;|WVMK+3&3Ret4;!cU!n-D}JeK=75EF=IwuHus{yFX9t~)yR7?AAc(Ia0H7t^C-@V zVf7$Iwww6i63x?BT;$U6HS-4!yLG0_MogkG$K|_r7O_XdPCtoChb+p-ZKtR;k%Jq^ z%*2zDMo6`>6H6H)QF-3Q=FBY(i%u6M0ZOTd;U@ z0j%5sT~Wjif@LfY05^|_*dCVjGxH~LAKiYfVUt?^h(}-V`p7TyKU?I}Cq$m@W+o|u z@6RVC{1k#nT8pw0?{hDcmXe&fUCw84XoWBJ^6Q5$iJnhiTYGC4pd9XaNcePx(E0Nl z%+Z}=I&eu-9p|MK8SuS%oXrQx89v5HC8XHGxz=yO`iVDpRr=$u2O^OBZt5-_)Pipg zH}fEg_W~i-Oo%1;$|NpeG$WUR}_NnAAXw|7qh2$J4BkDbfCvrn1n`s6tI zzVylU@O>$Gj-vWf#I)kO;rWw(#YwVP{fg4ejs-lpg!!=GaiSEQa`c^N6? z)Bi4>jPK&?u(*6@x6=3WP#i}XyXClFkCJ-Y3Q*C7O!bO=YTiH4V&)9?zZE z|0=LHDCa==#sBH7g)_iXB_ zj^(4&T5ooh!5wcH|L)d{j>}C?cc{`$D6z~KI_YiuTkgz))W6{J*sXtP6(r+&u<2kh z6fUP(^UZMpYx>^}QweKaiqmiT@tDcVviJ2rY}j_`7sJ}Kz7~`ooHhT&`tX%#IiP4n+Xx!Nv&oIj8coaM)nO{FPmLdV|;9 zHJ^=pMl}V7x#mNcs!(d{SRVD`3d15V+rw&}`oVq)Fe+j>3_>C2jE04!pR}X33yb+( zIH)7<6#k1>I_6!wDm-3N#2ntr=)-b`CLc6O>XCQT=AE$942R7OwZ@M|~T)q{J0tK_T4^(HPVWdTQJ z#99HXcY6gt3xr&yyBfKg{$zb8UtApG3EnaqndJ!Wm(dYGVc!4uWoak$9LX+6^R|Ke z6jKf^{<2fkN#>J(Y9?|{Q$WY*Q`}|Ie%E^Kuc)5sriO8*v%+uUyg;8+rT%OH^#y=gaucLRJ8m<2{pK@0EMr`*G$P8?#p89%IO>XH$ zJl@^gZ87JMPnWSqrfX%a+}-}?!`~259jz^bTxYj3-S6S=V-Jv$#ZK4`cs`R{R?LGrYepC&CP(yGDSV&Bt^U$IyZ**Z$?#>7ejh=fpPjHY(fp7Co1aZOgoY&)<$00NIuuB(KUBs7jYq>1mgv}8p_gm%CpVzR&Pg^K zt*78^wtQ_@SO`0U@wAw*lW69AabC+YaNnx9O@0}KX@fuX^V z#>HP|#OtGz!o52p!a5=u<`i305Ut~CeaE#{^XT+Mug;FxjgIT^P8!49Z^k@MtCMch zd0nQH;oX@S*6AZ}k#wswrM1JmGVy>aFP!RXewCd@0^%5?xMP%?P$2|^4Lu8iy`N2r zrqL2+QI>hM&Ew>IU{Zkp(a+t+FDs3%A15^~bvX3iqT84yk9 z69WFQ*akR?bl)P6c4L5n6=H;ZOhKk`3WU8b@Xoj|nq~mcuokg=NP~hiP#z({SPOdR zEXs^ZQ(S`JsYpfxL|_2QNwth+0$ek3P4h6ho)q;R%Q|n|q9Wh-xz8Xy48GAL<3BX!eFrJ2BcmCHoT=Q<)Ve&0MNZ=+fz5uVj*o++nEqZ z(&z2Qxcy3#OzS<^&$F(rw2pe+`^2{W?xR;f&L_UfZmxk9e-Uk%n@tS;AEXi)&x|D%s+8&KhKKt5@=m=~Ou9g*m|j*2CpF%u zolM-a`NnbTF|&_Ued=K+)_tPyp^GgeS#tqxt0+29BX9desqx^^jXWLHl%n2$>xtth zPcDrV2Bh@6SXLpnjYnFlqiqKklWq0twHM|KVHq`uI8@z_0mMDz!g?RZO;_S=Dt7O< zND#K4lz8>mf5q$1e?-~o!%sg1Pj?<4WK^P(yX|s|kUXJw?em&~={!;o9uv5co2~UL zCa1pppS~A;`k*3t$N@S$dm4RZ;^@<~s!M>~Cky*A=i%`v`{^b70T(nSSvTf%Q@A2qx8R^`~R|HaDlgkf;{_(|=-+7BhlF{4?-C`uIG>VdVL zHdfMf)X{OYpfk%$WsKR7_~W>P%iF9YoNpC^(C395iWPNbtlWOp?>-XXD>>oYC26_Z25*=jhqJ zQBM1D`74hO%!8aWD^a4H&X=cC;!U43tksy|DQ&Y(#~zmZvHGrLOlb2?-j+Z0ghRzQ zIZ4K`KFe`Zdv0RE|LmiQvxxlU$ff?s8mY56c%Q?41^iD^_IOik&oVD+T=1{hA-ZHk z&jhTUNg*MJr5!TSiOA`+s>8NrZmET)n5RD4Uv?6AmF*w%gS8KA>mFc&`O|avj(>4c z&VE~WCC|Pp;bT7ASy=sJX3Y)KTe~)X(kHExQ}bgl8l^Gy zUt4l(#`Hn2sq6!7ex4TDie9v5=gT&P`z2@*#Z86hHB$V)*Syb$o!!qwu+x($5RJTHkzN(I#KHj9~V{xH%D>15A@QDJXT6; zBa22pyPbW^`^oXj)BWiWX-mjJ$4`(OHhXRQXj#4e1-DfH#C(2AfwddeWjdu{X6pg^ zJlmz$_%pN9ecaY#{Ric(Cnd3j2!EU`zL#4&JtG{B@jWzQ9isstXH#gNz2P(5Dij}V zR?D5wWkPgIa;D6VXYwc|C1L7e=PdVdvTQ^O2Z1JnX6(P_l8ps_B@FS%I%9m3`&BB8 zo_#sEt%E!&1OX}m1^L3oqT)Y$=hczmaaj!wceG~VIjx9PD^fgyKoeSmsrGS-#JeFO zUPs#I(uU{euX!&&{PJ)qK^C}&17W=I6!)2?k0gY#8QP^5(Lh4rvy2mGJWYe=({*P1 z4}ED`n;YMPi4Xt`4N4%+Uh3GM%y*;QA~@6e2-cw}9t!{hwXmEm20X7dlfd9yN{H@^!_@Pk45 zK!FfUfR@YyG(|K3hBGLmJiw}?IE3mLc*7>B5glwsx@7Qn%{o<-030AKpf;3$sii5C z&ChUVV4czWU>tbCI948Vb3Q3xKIsM*jw^4`-W?t6KYO=#v2WTpY0)bh`t@FNoVGJE ziOsOvPv*;mF`N@1wYh4YaSTFSGlQlzi!vPmVx#B+7HDB-`uXC!uOJr^D-$bC{a5V# zIqL%Ms%m)(c~*dN&GSj;0KmmISpkS=P#~Zl&6+BRnn7tY;~1^0kJ<%S^i!=lOB;j}(gk zeb?Cp=d^1UUbp=dcmSGOdI{Fdk>LSsv~0Hw0Y1P(;ThwgIZO{I741 zR1Tq80Y4MB5(jHO6CRJs3yhsOk}Ajq3<$heb>Lh8Wc)82xkNv~26RZtqFeMFzBsuh zIKkO?svIyQG0+V`f;#aw&hdOjz9~9M^ylt>#VVZ^3k&`^JpjNc7*Qa=!!V@XL=VM1gZVjz|U0A(G`Jv&E{H)IZ zQ&Djg`U5id{B6@Udj9%7B1GLe`9QB0u>Hx|RgEf93EBNLRu>$cl>9S?#K2JE&Cm#o zym(9}-5%H|bicfv<23AZROiV!v7ej2AA?2TGrzu(F3zcTW!sv{2!%rmgR{Np&pF{2tR~kFZ;GdGir8&PT-ETZbVatI>F&SPmKVzjj4oP>yHYP zh)Qisp8owi#r8_psU;EB%9Hoes*!FPogXqX8v>k?&oqK=hQHH_kY5>9hpf)gu3t%f zr=9G#{cICF_UfGfiw&*yZKrq1wuJLa!tA*SK!LQ~#Zkx$DS>V_esdN0Cv z)u%OwcHb*F#;iZRm~G>AfBEEb8Gnz+ONQEegX0E6w+uhM7CdxhHRDcgi>D!xKUj^@_UCPsOnqN1mxwPS^_ULu$$5EvX8$-{nzu2xHhFi}+ z`tJ?47MigMythNRd;d5@J50(E$lGM+Y+nuj4tsj<^sWB$yzfnl%sMHI$#~Gf|9k@P zdc_y({`9%oq}Oo_Jn?Rh{7i~YIeIo#@3#G^4B{(ziP`WQ=gEw{h06IG(9I=p-L`aj z87mXtTX;2%ot&~*tB6VO>j$S2t8S<}a8(_)_+m@2 zZv!qA|LHv;VeqC*2bdeK`(hq~X-7v3LekMJ}d zx@}&Q{UKDYPpc@Tq633ynn@&205kH2eiN)y0xdk=O%(`TX^8atD;d1{?=O=N-^$0n zsgC-sEL(fwrq)x9?t@BpwiynwP?SKf24++Y!}#8`@*q-J=HzX7T#FG9NZmkM>pasM zwm!b6HPUbU%u37lT#WYES+Bh`6_;y!+7q5>oZ)J2nK4H`1RQ_cGx~O_7rtpoJV7qA- z-YXPeOg$a)lJ=iZr%rkB>BP9TL*?&!!k;Z(IGXdP6TS(yLL^bTAckx$+LU=H_17E@ zS_<+dVBQh=6fJ(iUpiF{Ki*&Hto!8~YW+OTJQEqoHtvKgS@WnFT5T{-Df35P?S|fB zYa+35NA+fv15Pr2NEq|r=HFi+t+3-*QKK2yaVO3(_>#ks}s$$*>b z=22<)jT0&WUuGk7$>=_-mS`ozc|3JiVl}2m#t7bZ{Fqs;bgW#8TeQ?A@2I<1*+vrf zkEARgqj`e8JCc=gGac^ca>O%8C5)c5NKK_&E^*GnZ&oVujgZB$A+z*4^>*EAqc*)* zlMKQvh&|XcOVX;-h%dV#>S)^8;_4;x_pFSx_Lt70ndWqF$h?uFLcW!OT=s^#44?Uf z&I8*-?^^`BB)(I+U8+ArnUk+i>07=84-N51J$EgYYl(kJJCkT!onm9_ znJv2wm>sKM@0)MUF8Z}`QXiwqd60kkzObF2MQsUJHSX3?#D7aQ~)@w?r~;7DnYqxR;cKgFSn+esWzm;CaF z-2}NcuihBCh@H{rcor6GyhBCe}VT@!!L8&-U%Di{P;UC67y@i)V4HZK}&f!8?6d3XC6>bNLpdSN>rFV=#j{=9 z5zlfXPYT8mVE481*9{(?%)ZD6>qSqld%g3$NjqPX-MzT%GZwm-7^DAd0heKm)1#;QtF z1Mi{pLq6@fZ)r>@m%C`Lbn)VP9W3U@v-x9EU)TwOUJVx%U%04j`PbGRw&ukSo4)uQ zaPZuCvkA8@wJ_d>+qA1Dr%N629(!zcq$bx|fT}q!*5IsW-(zhRCh?$Sd4}W7XZ;JB zgXbhiSsV5nVwSNI34PMRk*vMb7gf8DDZS6>; zsyp)%BU(wczqI3Kd}c^RxQ6VL?$#W)fcrgkq2#Aq^}k$KTJ%Idqa?SxE`3@_eO=Hs zP854a?^`OCFq7z&N50;U3oB4^lbkBYyywXK618PC_v`kt+NwUGrp7MvzhNYGWhQYjyK$r3Q2)FAlbz9L`y1}^FyV>X#IfPV&8l3Oe!WrDxVoEC z-lY@T(IIX(Vq-tk{xgFxi*^?@-);9@H`pju+xupIfF5~guvyvLdjci1vFZ8^B&cmFQ-uL?NiOou+KbM19iDBk zF^ST>t9FvUKgi4R6Tyqa8_JXWg&0!aENenMa=s9k4k5Ehb6~5mUK6575;SNP@ikEl zi{o0N@zadtGYE)22^UI{5lL7)aZr2=fd-&tTr*0Pv0!4cKG6b+hLV$;I6=5#GELLu ze5|&~VKcah5Dfwc)J15#-k-P>jBx8M>hkeV*$g=rM9dp%5@p2i&5#q3l>c5R`Z(d8 z-Z_QD&k93rt04Ta7K@A{^YNJ=h)@-Pw9lrC@trj2JRq&IOH4>{21ZR{{&d5AY0~%R z1BkS`fHzs(>)!w|WQ0UchCtv_COu7HSQ2;=0A-rc^DJX|BMfCu9+0s}EVH;Fb0TqG zW7p_Jd70&78LQ`IR{L`rqAgZ^GS*|>*5dS&Pi3^`jWj59>wOv9EEyZ5kHw<+=~^;O z=D}$*fNTQDfUPnl7MTyi$JYwiYgQp~k$cEkw(%i2ggjGfeFbv%YMj&~m`nKs7x5O7 zfr%ozlq@16OPC|?HlbZvN?X3#!d%xg;(Z`rcQ|#5lBC7UUiaHS^Qj01eYg z5@4%DGK=g0abBk%5v3{2!=O|sIXcd)goSA(;Rqy*XrIinR<&brkyam95wg*3fR6z& zbZExtkqN3z$Qc%V9zrGoU;_yoP0}iWqEC`=Xo#VIJZgl+Q9#l=y$GLx7zshq^8iOW zO_dFkvjsRiX=fwmyBz>72cTEk^}Yw`^D<4Mrl0Cea$L`b#Y0kevEsR!l4uUDhwMC1)tw zi~s{*8&E?MAPB-aMj&g;Byu|K-)VUtd68S8Kp50W-jpXQE*T2I*NpuOo1xCdN<=_g zu{BKtA^K%1eeqmskFh2@w|cqKr9K|91%M7fi!vbciG?9H!CmDHouP07gfkro7hpI` zne6=cz*q>9D=?28ctGAIn-`K~9B3*`1%4SanM#s=q;S9d)ZJHc1?w$JIGW&_8PLL( z{00gPd?7PhgxMq<4R8*H9^*0bUyNI0w{U8ez_|#8BcFqq=6o0!s=8x)+f;4hfGo!F z7yO{4FVuX<`NykHvIO5ESug%=V};s##oH0&8lKV^Gsfff77;3dXT$Oh$h>@Tv}p4k z7fC~{rYuDzGSdiB5BatiN1mX=M!u0r5H9a#1q!(}v>Cx?;{Tr9^RM}`Bv<;XxU^j! zVfOuWn3)09m?&dB)}&O9J@M#F>p9s+(o=GV8}T?krTji}6Y(Kb-j^TQpEcH`a={Jm zaMDPNjL|VBJ3tNVX@rU8?snyd2=ButBz%oA68HUO7Uk7W;L92leHpsigm7A|=g=7j z|423W%!S7#{$yr=?kyHqK@-{`u>FFHVR}4FD=zkD9D>p$qD;Oka$us>`EL;VU&Db0 zcZ6W-$=o#7hxf{<>i|bt9IlgAsC6ND?Gg8vnkOm7#0I6D)*l`4V3VnqnXw8jZxba8 zDRN+Q$px4g6*7&4PMTHzR{|wamggUn1*V!<$X=L>< zmNlG*5&WCPmu&k=9_Cm6Fmfh1_84o-8)*`Y3Pe@X0X36?0blPW&tuy|SNh zcUEn0_UB2s3K66qt8^`f)Fz?XfSiR`i5*O$tyFcIQ47=9Sh1nheub!_pGq1sh<5+3 zSSQ#Qt?6nqFj#f%mjnXJ5FwYR63(hU)mb|=$WC`SfDs8T?Cm6Or8~$|7I;krA77JE zIxr#7DzX8b6^h5ov?7v?22*QS8a;WP;0CV7M7Z%2PJ7{g#_E?7d}?icf(#{PsKQAm zYN<&f-BZUuj#Ea~us&X!8SnGl_^?c~#!$0*Jygn8fh-D>mVveu869_q%E-4Jb8eP4 zxuo;R=(t|9EQ^dOXx89iAd`*MZ@CHmf^$2$A3EBqXA4sYT14)4C|z&oHMS6yZWH}Q z7o^fa8p-i_9IOGr*Qyy78DYEuyh9*%ilzCHj++9w{Q=Bc3x0%#U8cdJQ{@~05C=i? zl|v^;TrA+9^Q+vVam=$2wqCLh2P}>$K&X}kXVY5wT9MSx2GMk4d zLDXoNh?)wudQ+E=CK^!bCa1Jao$5_J>P`QyiaNz3{Zo%n0c{s`BkvG$8Oh*D3tXG_ zVwZ$l;u6}TsTl{8dJL43ffFgNfWPnM~~m87q$555X>8bP&y!(x`^y;X{6ys>Kxi;hvjw#GX(C{&WSF{PUc68l z;J!|W%Hs_IBd6P>4;o4k%0D9|k#R@3kC^CFjTKKtSZPJbpGiEX1ykpP9etz`W)U7V z|CF}8Zr4*MNhRGa0;UC8MM3Mc=Pt=G6bz%Afj1F>xe7soaO_AGlsemvRpQozkmt#H z0+D1Q^os}sJk%QY*NEu)A~3zK^h>ZZims+b?+i(dkPwRelN8Bos>TtAp~VTXXtEAm z7`-NY0k}e0wNT#k-{QsyWr$EE4bFNI7#YGZN)|C8BW$anWq^Pd8NtRX)awYGB&`Am zI^>ObIIc;Xr=jndiHZ3U%>v^a5h(iCv2@i)bpWO*bnlj9gN2S(j(5W;bR6IRMb^EC zGyTVZ1OMz~o6|PTDTg^lB6B|EFlQp>e2AK}9LhQ5u+3RyL=HJjh;&k^RA|onhR}f` zA*UqfkdWGMzd!Ely6@}$bN}qRwrl%*-k;a|`Fy+upt6+|Q6kuU0U~z@y7*32inJzO zeAI}2Qu{ki`g^JDolvngI+z9)yW52tr;6PLU1WjPwtJMty3aoIu^LQ! z0W(b#`DH@T)^6@QIT*$M8)}oZGYW<>eq@!sgDNv95GAmO0t1z6MlppNRzlPf5LT3K zit}?)aGznlX#<~WvC6K=4ZT38n}L!rIYgJoMHpAx8|$Hik`_}nXj)5w=~&c@Ji|VH zFNm7^WzEAfZPAl1&+tc1UEXmvRjq%h8qxDTn05K>ftg{GsU`xViulv?t)ld++w-8O zTsNYwZJQY+L1O=O^ECDp|Hv+B=+T&diPtdg+{g%ke0kUt^hibG#T%$@UeA|?NOi9? zy_gx;ytAHj&$FxpP2$ts!jq^Qf6#%44$u1aE7P*2AZloc8qriQyWP3`pJWr6`KLp@M>7wi&(zOVh8i~YXcK#ezn)ZcHq{d| zFp=xXbZ%FXAPcm1OuaIg9_W~UYw%^F|5uLrZSowsF38bvzx*`YvzhbtP^KdVQ_8F(9f3HE)gfXJkM7!N56YO^p%-JVG}g=S zVC&F_^#~j56Y|M(=odMEw@}h^orRFCPa`_`i&IWG*cVY&to?bN#jY$B=*L(O3YsTk zf{TC2&Rb%QcHR3_U03i6mgyEg{&cJNZ|dnz0<}R8U0)n-(H#UutoVN27abJPJBSZB zt%rzwhjSDV3FiByBobUsSVi>pj~W)@5W*G_OSmusK(|iu5|(-<1O0C~lkaLafay)# zq;p6r61M1~oWW+eqc7f^K5Za7SPSP^Cvfv2a;@fInmmshs8EirS$2LAryz;~XvKJI zX$5MA;GvjRDL1DuBHhog%m$}+bcF(!L)XcA3c5GB($8rKlW>@}WD}gT;vgjlIpiLr zj$3+^m9fQ5HQ}^@v7+V*sG<*XqABw_poe&WngTM4r=l(!>9v@Zqr@2nJ3?VcV;>4_ zDGxx5c@KOzePLVVqO=O(Ne_lUBCRHtpfib+x;5yEL*tGq@N?J|-py3GAV?`l%cXUD zQ_SM)ampcR1sc~*-w?$bs#dp3Rj{tbQdR$gG0HG1)hXpFh+xm~j5o!ZtKnC$sIaa* z7g=71_c${J+)z1a)O8AH5;B+`kfI-NTKEiBln!&Qkh8r3Qd|h)l;+l}&$LTgf08L7L-0Mli2c3pV4zib0>hAN-(P z1yQhla6MxVVL?0xB|QyV?QXsZm_Da98FRpN`{8z=7nFJehpIau3@w5P=8@qT+7S}( zo@&Zn5C<$L6Ja}toW4z`auGz0{-dM|%+jG%xN5)8{dy^f#!%R8Fm?~rVFS7%z>WCK z+lr^%!&pG-<_8oI#8;HHxzJ_EM^$|QpR(``aU$6IoS`v5YN(|^kC`Ow$)iaQU=TJJ zJix1?-dP3))I{dEIH~DL*2H}9YbaPC0K${BhT(K~KPR9-(*g=`r*JHYk+YSoku*uE zc$6%%!vH6IiBRRlzeBvyK|>KBB)h|e)^eZ;)q|3=o{N1xC<5yt7BEOH$TnZgWRHu*W)W6{#vmH-=K5cX1Y8)*M+V5!c?~Kf0Gan80Hy9w z%dI9s?7>O%rIHPVK04cglho5m`W6o!qoNQ|c~M&cU^O^Ru%O)$Gs~2`Ck!a-so0bfYRLXF_8q=aEYcRN^#M@-z9oFpGCItBNySkdtm^NP58myaz=k=~Bd? zH^I+8eG}YAz-&+@hrzhCdsTZj2Cf zcUJ&foKu*p{92<_LH!6w&RsvKiF*&Cf?Q^-REiLz2^<3mt`xH($;zg#SOXFyN0th5 zafcui3GThYV6Jm3-a0c8EN-fM50CsYxMT|%W@uFy9z>^>3D$9{kSI3}+tT!4j#)EO zCR{G$9;uUa9GEL*UC9(P>|n(0v+cFLPswS7N{1{(_L!)DF-v`#exlv#CZ`|nhw2Q; zlCmHt$^mV{rVhpSBE(4o_y*A&`HVpjyrD9PhhfYx^T zSY@E*gYx01>lGqiSUF;&6lDive- zaXWQV;^(a=KB3XGp9w7_kgi?DyQ&MPPbv}9DXn$jo4Y%=9mGYI6iAIJ0OO6Lc&G<| zKNb#@abMRC^}e`Kp{(mJp@^WHpGDo6w03|3M^!Umh_=b$I4%3FIgpeyuI%m8-6u|J znV@#jsV}>6mKP}GCn-0k7vm7eIPh-K4{m(X#CAjPj$KH&afI_H=W6@r&!1+!QYHJl zzh8kQA}FZJS(x@-7iN8h{C^o#VgLxx2VVgJY=Z}e_=&gJm_k8SW2{yBxcD4f)H=><)KA|<;4WhaybM5+Jv+aaPbg4l3#@Xot5d! zWX;(bcln(LB9c-^BDr>d;dD{LTc7&a?Sah8?GQTWVOl00U~rrw*JhyZTi1RyeL8pD zUFsc}3fsjw&D>jYPFQZ3sLkSee(9#U zZe)Kq_>Fr8CrEkr(wxQN{<5#d4Fx<|aNRwYTflxufsp2CC@^QQ3E=v?J_|=#h+fgi z`KD0XCNpYKnk3CoO~@{^bZJGRd8E$Qs}8EVE;{9i`?eLn4yy42qx7>YeFnUi6pAuM zGPBheluK=QtdE2odW@+i=51za)!g2)tjf{}`Ea~cEa)UI- zzuwXeId%(a-l)FSCllE3%^5YwQ#ysv3M`Mx(cITB>KBdv;y56j;=YaYsmTXh3dgqj zeq^gaGJsrYnd*_N;7?Jn**V+C*`j$-iQnZgvJtO4YPcs(NdRpT8*=v!{Q?zOJL5~T z0$*gT#eLexUI$fqbr+mWqk#q#Ykrwzi=Lk@d|+PbFHKfY&WnUsuFO0d5Ds$>!Bm7u zJl>M2R&e-n@A-KDTe%8>64YD#`MSX)fuqK+4Z3-IKb?zq&wv4ui1S#Zg`&9umB1$^ zB|v$EevV6h+oj%DFZOgSg`??b9%8VVSgUEez<&e={qx802EaIWNOZRuId$5BrP*&LER`DAbVjiR<_1dox z9gzXF9Q;jO0TXWC0X)qjYnGH|b6ygv$fNPFZ1-P>Qpb||2<9mofGg}8DRfL(J6H_d z%0OL_1p!Ifpq-miO1%n!C-MMZceT;yskr$VFup6Inry6inC7iGn?`1f2wWC~Xwq}a zf#Ns_h?$SAFeSWG^38%(t|J9+vm;m_Xq=YLy6xsq64za^w z%_cVWj781aKYQX`#&=SL)QD0V=tK*`NT&tlWOYyazA(mJ3if+RjlVMMfEj==p#N$)LG6r-tfqA6D@Wl% zfe~p?Iu+0>B!m6u_^Wippzc1H*T@CoqA&)(C?-dm+lm%4IW3~UnL_}&(Co4e&nh9u zK^9z~?Jf>z5Yh~+=25I{C|H;Yvk9B$Lb7ALf&!vEL>zDVVA}WI7C?b8kKq)cx>%qy zE%K;*P6RUK>_dHky}_JD>XWepSY%muIpqj_Z~7&L(_earKiPCi&wsjOMrcGDOrUPflc zr)R81r0F~R3S?T@pzn^G@GbzD>!T(hG~>V2yI>H8-lO0QLMo?AWx>lB7(EK7It~D# z?pOs&fdA#;7`tW5Tn*OxsQq-{1Ucm!!_L^^=`Y9u=*i%*d>~o$AJaLS%(A=SJLI12|zc9 zU=nTI8#8|i0`l)ty!6o8+{;=QAWNwq)Zw*Ask0Qs~6xK5f2Fj##(bi9+V>{pH{6h`m!@*GSX5<`1}+tPriIAP_FICVc- zAuwbN0yJ8s*V|Ua6sTs(h5Z&+p2NTjxYAsmG!O=z1-x&CtVbM`%pd(?p3d-@@sur9 z8XWLC1OVRYH0g_#gi7T$?=pe!@-YB`C!~FV3r84R;X}Z$wMeAQs%m1pWDrAzB8m?F zk8K9I9rW4hdo~GVM(j$CV4_0r?g*9Z_ANCHliVc;9|doNfgK!e&Hd9`=olE-1^7Sy zl~OMU0Irm%0%(ld)N`&F^DrkM)c;nBSa%y>f$=KCZ;Y3-=4OT4Omn~yCto9~xUM-k zZwj2Ub_Mo=>iCk0A8z%fuV$AuvM4+ z)l!Yh!@j z+3ExRiqorsx7#;t-j6GjbI1fQVb{-L18tO~_Jg9%TZ3ExE_;aiE%rJ=3urbJiWeYh z2qeS>3J4>|5tXwi9xVosU7&5699$j!oAZ1-@~f-=lFr%%FOUW4ek$D(YEA)wNv!UZ z_VGv~2V1Uj9gcqY;#lG&4>@xN4XE zz2B&}?}*WnNPrGDn&V_H^FoQhVo-|lxCM(5UbGbCW(f!5!SZc#W$Ml>ATCW7P2S~C z%S>GHMQAcWl_0@55=I%CP!9p%K|Bl}kQEIc;D_~$u~Jnv2jkCLG5KqVVPL6vEK#6o zDTqq2#1{%)D3#-7LN1b3h2ugwjsp2ip%^Br{8Adv9?lQ|@Kz@DO@4j`F!E8-h@yKs zf(oX|ouf-;^~48jBTuqsL7byHaKQ`r>MlQ%LU&q%T#C?VK|vj4H7p2Ox`#UnOZn@n zYgA}sCXa5(ie&2`+$|7ifP;i47`R~WLbL@7&vOEx&Xp?=A7x=7QTGV`&+JPDdxXT+ zO>u1P1q5M$iL)>gE@CYpaCnt=gmX~144CzzHO?Ze~3h~6)CmtM|fU%kv2U~by+b{M}_akOfr4(;fv#u5>1 z3qT2$6?6a~Ei_1Bc6U@%0R{o10or(2Ygv}ttQElUjaHSbn-r31$w6#dyFEk>x(nRL zL^YO`me=Nj$Fz^HnR)J?9M?pkz(gGdz^REN0D<$E zdqCXKoA1izymGw9gq-;(_W5akqW0wG4W=lsy-JwwLysq z=%fU}Niu*W#tRyA>R4ma%5y&{08u!=h=IL>i*)BJZ__C+cR)5}mp^yP^Xe`aoGS;{ zf=Aem9nT64CV!S`%$)@IhSn`G>3my8zK=z;;`pf%w^Eq#NoRk|00V#m32#j+FSEC0 zM*{^_5zOBxhMZa(r0Rrlg|un0UQl>}gB6)&8TYwdqzV^qL}{q&H(4kbS$>WE%!uy% zjq;2MDt!bXaG?b_K#s{@iwQpP5Ey#LQH;5*gtve(ilhe$4GT3mMZ*DNb4<1*zLr3y ziR_P>P!BB5l$)Nl#w3v{jB35JX0?!AsP)HD-O@rE%b-nn&neTK6N#9meiQ}|l=x$E z`!4{Qk#8U0!}{2K?CxML2D6Ia@9t>=nCH!TPe z{Oe;40+Eej7(xgx@VrAHi-qGDcdeF@5!i8WLiM5soNntxwRpgR$&c4wG3&2#Qa>F7 zce`S;m{=38qOwy(;6imgCJh+%sea)NOV6KP;jPJ4V7Rnc2|N(;fm0FW0l#uB5_X8% z0%pUe%m~Yy^hrA63L)Id8j}t3jjn}X-EQq~u6-?f`orQSfDE?2gqg$%dDx)Y&soUP z1gB{DR1b=~r7?OF`L6c9@_&L$yQoXGP;FIDDTg{JhLe*BIMI;BWGKu0j*(}Xar1Ft z6!=h&Or}B7h?rkJkZWkpP&9}Ud4)y0f^tOO3-zd?BSJ^P-Gv$zx((caP`sgq5@kG7C5{I4%(EU*5bLUXk{cZf=Q3RuEyK z@OoqA1ON*_i)WFN zAIb!~B+)G#?Dgo40dQQ*Q}a!vpEYdfjD8!xXW=B=H4<@z4$ER9%Na1sEKM8TGnV7e zSUBG81W4X2(!T|O5DO(4z4ylpI$2%|*ylveb(a*3Kk1(k?y z)y+UL-Mm5_^ib_a_cm6CtmfPKfZ%Yy1XsDe1Sj5ehp*wK57x zQlQJT7PkW0v^U{aNFZ?swFJPX;DRtFm|Gw&hdy#{3^+|PV=*`xFhNs%NLAkDFCnG8 zj+h&xAJ`a^3<%Xov^M8J6)-s>@yIT!%sm1p?FOoG_Hub7cO&jZc`eVCS&nErV$c_} z#6Vn(fD3<{h&M@Xj0n4+2poMOa#qF#`B-p zQ1oS~7mK6|Xz(&zU34iRM1mNy6wc5o|V;OTPdqe)vL{&t9NHs@BdqEk@)e*@JH*}A5T+$v{nCj(fOl&=11qh9}J1L zZo{?Svuph+YlGEmPcI;9FQL)p%iaB$l9}bPtC)BHmOqT3C+t=}T}4mLtbDOUf3;h& zrE$#sTf1P_Dyq63c7L6>YyJB_G_!hnef@tio?lm6e)E23@ARctZ)|jKB=a&kRX2W~ z*Z|k8Kp$*0*)ch4mj7PZV9j7qs3oqAjoOsW`D!NrD>PPRnfL8xj>IO%=4MIlCemk1 zgSrK)-8wU}bxnCyl(n%HDzVjQx23GIC1}5?m&z0|-acNyY%tt5K&@z9T-ABCDgFvW zV2R=1GDTE&>g{%TYPQTbmaS30QvdDfUi|JQxlQBUKK)?PId#?Y+^R>xqm+NYJU3R( z8SSn~?Yg11J{$gqT>Pbdah>lX-yb|`gUq`!%KMAxC)c$b@^$6n#ouZ^f_X-=QARtl z=Y9zn>?WSu%C$%D5P1gK1`~n1kH-BTeeiyiyGoLKc$8P#XOHxN`6FdN_Um4Y%`x8 z_ABlr@KGZ8GwbW$8P?xf$$#@k{}#^uTT1;m|Mu^S(Lb@h|P!Z-{J3#*=`C_+%SERIB%9K0CNp%A_8Vtc~w)OB9G|#>ZP{T zX625HY=g(UGhM`K$+r09$L!v6e%Wgp-29nh@Vk>ItJv5^x7&{INR4@wVL+RJ|GNxv zNs~TB2SxK{{(Ff-q8~GB3%q-(%`cCxb<1hL>+~Lc*JzP@*t~!9AGe7m4v~k4PnC0?LzojR}*AA$qCT((c z{;};HDbH>VLg@9N*lm7PhSnt4MM2ayT{K`>1X5Hq-DK%LFYwIcoB`W zE%A>USY&y*+#*|0(^?@th4w;8JW%%Vhwb5e0rG&kcvbd*>cu|~rL~NXa6ok3ygwic zZAIwRvmBl>U_q0cy=ev4ML?ORYUOp1NX1h-PESv9b74&^d=S<4MAa336VGFa8)g!b zmeN))eV4>jltKqeFFx-*@66OucCtO)ArR~Bc(H!v{iheCCubq2kVsd#X+58uGqBOj zJn43wK%BM~G7X`}!3PE(s~6VdSD*DVy5dLdrrM3J+p=eXZuw-#=}5Q|)`gbU>&BU*cdHgW76k zogyl$T^qV>DQ)u%yL!*fnnr4ng@N=zK3C7|NBY1`uA-&R2w7Ow6>#sNXRmM`tU#*G zw8~`Ad^7l9s5);*0H?{Ja92JBLGyH@s>J%ruk4|+Yh9-=?vvg^3i4Q1?4;b3g*ZD6O9>GJ-}1B7Z(uUk+WE23k7)eJBuH^z@aTNPsoioqdGJA z_>f=}FBP_pWS~7-&Ho8#a>5o&rJSt5b?-^9zpD1~uvmNq6cA5?@-86FaR}trEH4;u z1LU>=reS!hSSvrGwZ%ezQN%t_K}K}DH^}hU^S1$b8KK?jAOb9eC!Y5`9c~_Mf^8n9 zo_Jr2$_O??Dmvu4zQ6fVVKJExoU20#hiSIX?Lf(hz<>fl9vXB-m~q#OlT><(3~2RV zOIy$A##Ir?qFYjAKaDOiV)iZF5VCCmCmgAryh3p_=KyT0M20E2~50zg4Jeh92i7pyFTW>riEiA50jw|sJWiWv}l zTr+T?5ZFy1J#>or9g7ZL{ z$ZqzqmmA~(>UzWjPwTnZKc6*MZy`{^D=XZNg@P$<(tc8^1B$Iug=bplFa0K7^f^0M zKUuwqP--#d@jXV?%p>7wG!srUTn6$f4jzl|;{P`VXvTMeZs9K6;AB@VY)zj_&1E%^ zDS66r9O?a{W9Jr|PyFPw*OW7~%4)K~ChLGv@i?X2NV7rLr3Nzh46S&T(9$Nhg2lZOn@oviEnIk{v^w?BE~tZkr-yrPI~L%=oO*d0aee$$sA2 z6IVaSx|-#!5FdCdO z%vt0pA4BFJF^eT(RZCiy1*7U|Lz=c=PQoC>*lrVwYm#a{q?yPU;WLhj&HB8C+Eu;g z7L5--DK#;2Cq_MX?L+1Bahl;~UC+JXuPtISi-HVP93xxXnT)-c-Nh#`=TEJl1LqQZ z4QNCPJ9Z}+H42gKB~bzp05^XbRr&(@rM)u&T@(*VcVSTU#K5=j=MjVjKoDspoD!yNPX0zZ@(n(&&b$eTK zr~N1uDEk=}EHej(MZ%BU6@ty&t0+}X3@dYBi_%28k;Z=0M>tzI37p^|z^H}de}-(c zEM)>!hwQ1ZOkUX>o1!eodU{E$Sv^QtDi_f<|L-T9ql|GN?oM605l#!@ha$UTZ*!0s z5UxF8?!FkQ_8?IyS8>%F4aKBZ)H7%|Cr z96`tagL0zDN6FymGh`y8!{bv2zee_%Kd(R<_pzde1$*%Nggj{tcAB?4tEEuZzx!xR zxBObRTzdDh`fkMq#Ie?HrT5)3J9m`*yZ!&bLr2NFR){l%j8ro9=q#el(}X3vM@=8i zgy1t$#zZnbd;X*Z;|5RH%lyUT?N0jb&H{X~uelXgDAdtRGkzda zM<;hB<5!4*X+&1@@$4jmRfQiyLZ1tC_qo-a*`RPYSWKPe9c_uTeeSrUm8kR(ahK=nj<*O7#2)K`t|b1 zB|9AoR|c`oxn;KMmk!PNpTE93WW79PU9$Gtp;%MzvDOuTt1zeMjbW#*7C-EB=Zde# z(9$_w1u%S{P9dFY!<^p43D^ik6MmZ5+|9PZ9Pnnm9`MvY- z2mj%ZF~bw-!;{6spX!G{w+??WBkKm+R43UaL2bq~hFCwE-~8aqI=hnLiXT~U9$EAs zS&A81P9Iq*9{C<)w@^Q_oOc|%HH6qKF75qq3upU+dxY;L@35EoTrkh}n$3M@`xypJ zjlW<6`sBIn+s*g)w~Fnh&c8iu8z?=V{j>G8OT85mIx^mF|3_d%WV_?AH+#o_6bu># zBCq;Qy`fTT|rO#V<2RA&N8)g3X!to*QKB9}iEuS|6&f`GM zCLUVxxSEa4w2eXn93*1Lg5Nl#(Z)ou4(L9sZwFU#i=2y24m=<7Mf&XL_J$jU$3^Zr z>`&%?b#}Z^XD{h8%5muUf-g^zXY4r49$H?g9R8ejG<*y%H!S%xf7C4hU+XyL^l1Is z7&v+SziB5{-gtDmVzV1 za1A}}D*3!%uGjU>`;UwTSKaN8u+u`$1{0RyE(ys_L0E~$UK5(36TA%-XTIDK$GYj< zbMrVo!T+C|$dsGf6^GQH!zXy$gBG1_8z!Czw6oI8AEpn#>_<$b4m)Q);f`+j*t^3= zd@{+`fz0>6l+G zD}$e0l0BZUd3Zl@E3d-T{ zo--NW?pake?Fq{pA8vj3*Og5%k0gJ|Cw_hr`-wIA3zM`q(Hh`3^=0V&->I)(zRY5$ z>OXkTi+lHHoK4r9;Wd9;o<8;w=DwIb?OZjp@SXE>-;-4yZujJgt8!<)_Ib``ctPHu zh=6^$BKOt&jO~b~;ZDQUI*&K6x$61+bJwcAN;nh#{PbStdGpBo%f^>Gx6tQ~I!vEE ze#QOt%%M4nAwK=KW9rnO9FCMBfcMI|;V*x@r*~XP>-k^4@ckF6YEt=U_{u%28NR3_#LACtB9Q$>(*>+X!X8$M$8m1= zo%rx;hEr>f_46C|uG8l>=d?CB2N}ms1;CDHOVX(nG?W*QP{2!rgrQ-HYA4rUV{VYd zm;5+){p>jwIG}mPC$ilDAYBY1hR^12Nu%I1z*cJUP2~F`P#78DC6{GF(-yd`{^k3g z?wnix>2LSX-G+$E2HEz)%RM7646pB7}$l z92dkDoDo1+j&WU%4P1_kTfUUJ93QvrMq5sNx_r5RIq7Op;>YEb-R0EvpcIZ3%Fz|7 zMG!@6CEYdnvc*b9T#(*%1lzu0MYO&U$7c^ZWE1H|XPUu+2U&)Dz-d{6t;F0g&z#bI z*MLArrKdiBy&d+Pzf;*N>t1EpDu22TSo1JTpZS0i57Ui#d=gEWJ*g|g+YaLn#OzK( z1J7{@dK>=abes_pB*IKdK(Gf)I6E_y4n>fmPG}0>K3IsDoj#jpManRnB`c%5Gl|o< zs`=w*R}D@C@>!fxFh6zsC?YZ#jM8DZ?XvIAgn*hLd`v)Ta6}fJ{xvj>eJq0j9umK& z(djbYc6F#I&PzEiJpjbZdn zL(Lm~-}ZIBU$6f0H}>2M!@!z=R{JWe9Hk#yc9t1BpKPA2y|rB(TK8pk{y@vUS(DI} zysNwM{^IP%u%V+utXsaZh%->7vidQ3r;EVgaPJd;`lS@{2 zm+XYyR>k_6Jn~)*ci-{7jo_T{dyHLJc=uzegDJWZaqE_~pmx*|meKbr<}cWmWMib? z)2Oq5yN$P^OopTF z&c$lfY~K3kcS>^W%Fy;maAd&m7S82g;El+Ti@&^$cJ0saw&LFf%I~Uc?%KbNRVj$t zKk?>5a-2iK?wPM^k*t&X|Jjoy&-!Og`|n13s$4P)`t83F8~JR<*FU4wKD!TTY^|)z_%!)G&i2eO^7jfM^(|*_C>RwCPUcrNSu8zHs)U8bW z%~Q)?$pg8xXM4%0*rZq6RLjWg=YDrT*>B7yUYFconVc!pjxR1)Jt99-aB*L7IpO@< zmw`OLGd6ygUy7IenqR4sTcr}0o*J9+D(>n;Y_MCxih5#|cF2v5gfsFxaRmoujRz37 z-Ihz7fZXMVfxXAezf-@iJ(-AJ>APG={$rPwP~5m5Hn96V^&nkns{@tub7=q3#`{}e z54wN7K(yXPTtHtD%`f=Iz3y(XsDGD=}LDUX=+EGX%>(!RRU{>Y_2X{F532Z+80 z+plVN7+()tg$_Oh{o%dzm&LzHYF0^}h)wF=i25KuPHAzUUj8$4?(f%S#~1L#DS7r_ zG-cr{a)T7o`9^(3Qju;gw z>8dVt7anzcWR|@}|F0NwX1sV%Hov<}Ewm!(yo3B(I*%?G8}dG&@1|&hn%oM1?f5On zs`X;w*ye#7x%$#B|GClb2znuK$)rXfeI-4z|xY%1_oD$QnD>eVR#x3(>Swd@Hf1^WC zp4jy#rzGbp>;9ZL-O;wX zAnSeQeM*Gx&WDM7!-=)OzMr<`uW`85cqjj89{!M~ZGRY@F!S?HV^)DgTk4N5LUi)u z;Y(+e4`QFqI`5Z1{geVfEmRxv(V=Yma#idHp-b?@(%G~l^An#knoe8IMo5>q*Jdf4 zct7VjFeZQGg7k%@*?5`2;<}u*=X<_aEbi%)C257grM(Rjd;J3B|E-i3*h_2Di=9M+ z{iCd^`(^EQcoY0mSuURL4e7>3$ACO^S7SqYX2P+CYrYlU=*2{77SDlyWoC1B@Xa#n!Bk1e>V9wy z#yEGCaObRNJ>4eoz`e0@Bq1=9u2$h_)1lO5g1MhQU@v-NdK6(iz-(cY%}m_^E)Db+ zz5c;G^48tznUFj2j}?!tHr0MC3$oVUiFnN?pZ=QzPJ2H_J_hb}BuM^Byy<|$DuJ^h zrA_~pTra+U>c=gkk0H#bm#8OK?@y%obAn$X0DEYmtX8);7%7#}4$s>`ai2%*m|<9g z0{A<}?zFQF9_5#L&FU&|^wozor?|I=b$_(0536n;s*e)>h-r+OztwLYQ!;`MB4Dpu z`p>MRBXS9$qc{~10ikMXC~8i~AtV=*)Qmq`tcIU~y^LpmMuz@i-fS^xm^~HNMx>$K z+7~&24n)1>y8)6^_7O4sX2D5Fp7f|R_Has(TZo3=N8VG4)?F$O?bKbay8KUfrRo)* z-uH$ZDSE5)f@-}V_g;=1tUh>Sc=BiIz}b`Q&r4HYu2;R>9u;5Zi%Ao{s0$$+2Y1bN zzbY2MjTmtTOVe<;u$^E&qSvFp@^hbFvky~yq})06R5AC?bo+g14)iw~Y9cvm&deq_ zAtIBNSis~~0X#L>--4%YOW|=o*BSA-ao>JRx~i0-8;|WdJNKdjo&{r|AcCL)r6G0E z{zyYKLq#hB0iyeg@Uy3Bh$5KC0_2DcJb+n9_MpM`}XbJ1Nkc-hAkN+l#jUDsZ&GM z0<&Ap-bRP0*Q{zN82-L(pRlx5^D`YOf4O`#+%URmCP_gLa%zZ8_A6t)j2-_bJ(!~w zUHf$>z{p8aEb6*C#aH9Dxq9=slWHG@p%h?w2T5!*yQZN6le03~Zir3fYZR(lwvFy_ z%zx2Zt&o4-7@J7EUG%=GEJnffNQhm|i>y0@pMmDuiSI)Lv064&?_JXr-&NYNuy@yO zL!1j0CrZ{ebPVK*oc56}mmOVBYKe#1ylHlNs`jBEA>;O$eZ`MY1O;32GlIz@qB3E8 z&JX3ne+1l7bnh7X^)OfVZqT)Tr{Tbl4-h{?&Z&mFJgVkvz4SL*?VIQ4qV)Ht9{(CS z*HiI+!q@y!`%kMd^5t4l+!J%2pBEdYJ(hi8 zFDg5fue=C&Jy)??`>Eu=xVL{w#%^A}d9CV1Z~>RwT%v2o=}#vvHOzlmC@R%73%Hxi zb9@AlguR0Pvk#biIl0j<^lY}|BB}Jv^!{0FQr6$*$TN;ptp7f~cq1U3G2k%)eH`$L z<>xbQHT8$IcDJp4PQS&0dE;xvBcX1trHj$x)8_;y9zFFd+`Me==_mg3_X{ZtJEx14 z4s?c2zs%8x;hAgm+>e7F0K2LIe?Ixw0ts)3FCt<~#Fk{H+`Da-u9T*M7eu)Fdi^d$ zlr&7ujf{B67e$R#yi+>yWTgCs)6Byd&pavj@8$BLfzhS)`oV@rKJ{?lQcwQt99$u$ zH+;eMVTt7FKPwfm^x-o?r5dLwHiJXsgR z*VP;UJpNOC=`%y=qN+;LyKh&YwH}9syrf^A9a+D0&;CnLy7u(^^ZrYn;%qI}$$X9} zsLNpe+z3(8Q;{vO=`$D+&TFh3Yr3xc(71Y~ut0H1XW)3T%n0)uOKe8(mCl<4YV%_x zkpx-Ov;iNkUB5H^%H_fSs7TWCfKswrv2RIl^4XZdQT^nntdfA*{S3DSsczYY>xawtjkz zVx~TOcr!m`{4=Qj)Fpn#-9)g7(u*@wqIC(zpp3&zM1w(6`h`Ff^+-DXNQ((~U(I0$ z-(Tx<;5e_(`RC?!-KWCKr3hp}CIjAHXgp~G6YIk20CEWOQFjJkFa^%WNVrX4I0|1J z%LG{@3AyeCdNd0%k@)wVKJ&zUssm?T&p3hrj4ByoV!cAsfN_{HF9Oht!6*Xc7H%+C zZzjK?52xc-PQEI^=GiVE#I<|pG;kuTT zcsS6BQ?Z)V1o=4Q12}>$H^WG+gU6J^eJ! z)@fak(FXfz#mVSo%4p>Jsl7m%R)T?Sh%p=15KBieLB@B%z$_gwV^NS|5EHf}ppcH5 zCJPXn#aY5GdMUT0O zzeOC|;PE$2k+rUtJ>^)>W_V2EcuYw>>;$l}EeIo)&Rq#Iwgp24pn`dTtVFL=FhSOC z?o;8HZ3l00wQAX2arpy|n!Qm623f>*=;Vnyxwf|=?F@cv5E`8>9M3o|4AmFtIp#4rherWU-TfA$4Gwe`SnQCZ$4S;y=yt#PT4Ko9os*!V zKn;CytGB&dvdtJb>*wFuupaK~!1*O`=G?`QKrvs*+y1vaY8#yWeL|+ivFkM&22%bF z=dgMW9`Q$W5jaxupy!FkXkLNngIoTbmbS#@=OW9_xS+kCw?HXDe_=t<{c;nV8Sxf^ z3D<*S{2MP>$cxV}C(bVg1LjEwS+UJl>61bGu|e0vmnknANx0?z;p@JFnu_|hf$#K$ z8hViudY2+iYN%2K0!o$MJD~`O0-+b_Afj|cKt)6ZK|}~0k*Xr7lu$&vL6jztkN2H9 z-_4mhcbVC_NM`ozz2?8x^Lt`lS%QxrdZE2&9>4+dD|m zm}rD{p|B(6rw(~7@ySo~BCiKr9>0VhQ?ITa!G`Q)o^;<_Gs3Rpt7@5}uIGK@zUL^G zn97!8CzhhJ{={8B!^-=CsZaW<$bB9!y!X1)8}DR`fnpx9Hjky$jr+M&Np2)D2U?%c zVtVCNMZXN0JTjh`k3F%D6!Sju4Cdc(|KgofBN7X)t&Z|7W%LbVf12vD;oeglGGF^R zx$cRa@3S&-{Bv<%sQ3M3ucxe{@pd!itM(P`ACq#PTC6`wkFoV|U452rRbuDzLU{9j z_(tV%T~0<{)rRk*Ch_KB(c*9GIl$&)N55vezGgV%IZymb?#Ihvqb&TU^R3O+WQi~< ziPuffo()qrd7oT(M+JW_KBw8XDHQ)Cr%f5a3_*t^SSY*0k^QuOZu?mV9?Wk|m5%_KE>xb^)}xv*R)P z)28(w0;F2gq$;x5#`d=+e{W|$5BQkHGfuZtQyBhvqLjt#tFRmUv zSzi^qvG_evQetk0V~17hfal`2@IXUSpoiqWLq_ENjtg&Mq>sQT$m{Km8tHi+{}WfA zW%$(T#`A5Jt=bLg-wnTpl79h8μorv?Ik*95L81O=OrzqZYi3^`8}Wte*q(0>7^ zg)hRxpTZ;pmrPx0!ntRp$|+HeM;drQdZ#Pq*Hn~Q5T>!k^~UZ?X}iDV@(%o5S!2yG z`EMCTn#cFW!P8p01xfk{-rvu8=G3?$v4PZA0v{_Q|K0OJev%pNX`FuO#I*br{ON`< zYJT@r=I1*agXbA9ntly8{bFZxn8XGBo!`B-^paM?Y&E7W}<- z87f%&o5iVt>;7-SD|&3azs|&i!Nx`Zq-L4SWDib%ubeiCS?}_{eM$A=_xE6@-$x+_ zzLxv2OOjm|PptwtGy}~?c4IVxMUA-x2AvTiO|r36&ki#@(PgvSA*{pma?{f^-p8W|xMVML!)TsQu#v?gBL^>8H zeJOTMhrU_Gt(k7RN&7z8z_{TmI#_XB*SI$9UdJEZy@u+SzxD6_mVET}yArrai4!{k4TnxqGQDOf%_kB;zH$zXhys z9W2?%mVSYDEKN5g5;aaBM&$__m|+{~;1F_{ftNHqAEBfv?OPFMKy1-~zILw&^B8Y& zUZ*^GUe>a;|7ZQT^m9z(XFFZvU-9M_`YwAX+6(Bqd=PPXrRT-=rFy&4PG3gdEYME4 z-tpQqqesoo7yA5|`tXP(DYYJ7{=~}$U?xso2{mo$R3V{rEUnDL|5D&57pTzpFtNc9 zjjr;(;Lx3WEqk|iX9~k{q zc(NN1BssxaGx5k0!nswi9+RT`K~Z3kCQ`FWHpofNsZBDwRc2Zw@Kc?w^y~Dex`Ani z(bT%u(-9_ZIxzM~VHqNnwU0p%#2G`Nbi{)*;(;v?A}o`+gioy+xG=j){_C{1NP$=9 zgbF$p|9;1P?ZF9ibw4O`WEgH4#>@s$}ceFfcoof5U4>NKrS z_-j6)Ma2xIBgCD1R6zYIR|g*pQtN#2gCRq}@~wQ41a0PS#tvZtqK-zr%Cpw?XI(1w zgYEU>D$fUxWk0Jl{A_RdrSjs_@$&1}FuMYJwY4gpZ>W?)V%5~0hYCh*%(2-=?shz{W0 zG*Lns()sgk=P%W+gSTB2)$^re*I+!6t)rV)tw-bzk*T9csiRl(PVXhPJ~Op`Yqd_} zj()F>feR<^DE}@>CUpOb?=D}}hH6tWKxv@2v}ScceRqLsEm|a&orKkL2L#S%{{~>K zwK%fqV1io&Yea;GnL<9|QgTq_6~8tX-diam!EU#?8Kk51VXw8AZ{EMJD}llCr0GDg zHCh!|u5-)HJr0oXfws|$3lg}euI_s-un zt8K-_l0Qu+S|{kKLBoU1VCW%$k4&US>vDCtWLX2eiE)r-N<7;`0-8pfdZ_KK4uQK~ z3*uZc?i6v>GUvdyx$vp^o}Xl@NW0;sdT+P8Q?<=YOuF}-qV=77*~nOy8DXJ`AzlE) zDBlXq#xs+N?5X@(n0PdEH+|1(#w}achL}%Yo(6v|xkm&Zyjma$uwSH3*64%y-ltr3 z*+4L9 zhH|mF{DPd!9!8It^F8g4n|!W6W2+s`XtktN7{9PSzvmvjda7ON!fUE$yytJ&auub~ z(iZML*(CB~{_$;cfc?AM-52kPRV$GkegN zqVVU1s&DaFM!gYaKb;aZx1ZitFtCr4mm+6g!8Ud6r3RP!7QMk4=LHKs&P@9{X&&3p zxiTE1s_@*rqFFN|zI?8=Vg6T=-XG@Mb=N+y^fKR7kW;nqgNauP;!GspUSCNX8$RDY zT-s<39lNj>)-=30Kk{Pq6nryy0`hC6X-v0!Bow1RS^sHV$5MiMj8Do^-q?WFK5Sf{ zn}u+VMyIrS;41AXqorCt*VHAW3t@i;aeAlnALabWm}G}rKUl6XVMKkVCFAD2XJm|1 zfk$qeSNHimxo@)adGFOj(Rz)eiZ{6EA3PHDf3+1ZfbV5K;1Ai9x8@7uww%U<`(#?r z-&%h@J%4+5)OsQMXnT4g7DQ)5ibGK@&X5uqOl=mEI09!};{4x0(EcKDJrboz4(T7dZIHfM@5P3S4#&D|C z?$~26OmP@|Tq>P6q4r5`7bSUznd(m6VuDjx&`=2@V55h*pgY5o+Nv||5SWt~sSU)~ z+Xz&?4`Rg@Q=Mt3#S~LcP|31TnV%3WV-pl34~63a*hstZC; z*kRzr2pVL@l848mVeli1ByJ=WX+gkoKFlF3qlnC4+hi!+ZU;0TEoErXbL@^u7I{ZQ zeQj<2U;}8iox}yAu@8YUTtZ^1OpJ7O-{SDkZaSj@P6##$TY*bVWUfR}D*6FOhBTvD z0c9%rg;RsjY)GUw#+DrSxe%Wii;jmt47Jz|3NJmT^@83;51qeZRV`DA9OCXna4?@v zTPcGID~^(goh5-^ohC2|P4v^loFS5!rSzbDeg^JjTA)rF6T=>-b)6xBsSfK#i-ORI z=OlCRl}a!V2?%4->cY|D2Q;*5NTL=9;|lTor_H3S zjgvcbV__)zXnG|=BS(hB2zE&@Vqi>zkp*g%iQu))eFl%fRd!&a2zZJ~Og!u^e*^#$ zTwoZ#OjvT;r7TtCd9wcwAHqUa7slB`uUqfJq@b+h`0C2o1ObCS`GftcmID#QR05Zs z6S2awAiXW~m#X*1p<|a3tVL2_ELNN0{Ct5?>I&THaMJZJRo(`bAmWD2f|Rdf4)!`J zMiK+D-Lw0$v@b6tL}t~rKqEl2%dCk)L!3sqYqT;we9Cn_*WV>m9G07j(cs89PH0Z{ zabYGMkLX2lW|{Oqo&##exOnVC0yJ)|hnpg!%Zt53kSSW?eNYGR39C(gf1iS|#GJ2R zLaF88;J%vxk<-eYAsCO1FJr-nUt&yy`@5i6Qj>rf5FuL81?3v44V`UGXLAP8$j=a@ zYDA}UiHfqZIav0@36LN1T!5zSVd`s4gdbM&;YnD|A}q){O!4(gk6%V;5J-kg3u3O5 z`zeo_f-VG{8BO#1@j4WrpTxfK6V6Ke)*q0-X zLT@Z<876K#4FWtMr0aG}Q?ofQQj3VjDRPZ^U?@)ROwDKZlzFs*MV%Iv%Sk++Z|XIi91<%#M4z-gXz37t8%T(IpXYMvxB0hSA@m=PJn zz~t^M31kv`Sh8lkmn`my)STl;ol-fM?=F{VA5E5-k>(v z)!9XO8gZHapi^g9KVruryJSU3>FB+AS;)N?B|oGhjy|~XggzKASygB~8VxQBE&WyU zQ~ls*JdP)3JPw99vw=C?jbm_WD#PKK4Diw;kjW3Qs5VE4V`8=o;s|0{tE?6YI z&@A5cP*U}w0TBcms(||3{jZBW2X!k6;gGzfdT>;n{+nN=zs!%~!C|0ms`L0{w9?6< zpX*&{H3$t9B@Qw0-g++qMPll@kr>Teqd|^9Hb4Ys+0@6fWA-pO?B{vYsHwdGamnWA^%y8d46sAO>d89`=ZLZ63@p)ffB3`qW;6cOb& z!RK#dRsY@pO%ZWYa>ZP!ANR*5!?}VD_m;X04d7F{he3t~xfFiB%gyKe`i~5Z&)zDD ze-v`yp`3~{Ca-FygF#$H=w&+16pAaLeD4p*5+zT%2YaXs06Gv#K*%17pBu3Ga%Sud z66FFMdCuPMc`kN22BM!o7rWmu8B0AYF0MSYot#6t`lj;FF7HzTbQ2w>dth$h9CEP< zfK?C(>@q5CQef8fyViG?d))YzYyxvAoV223#XxqzZ)<7l1Dj|S`z`1VW#<_t;6j)A z83aNYU4{X0fKn;x1`s|F4}cs-1#<|%nMauX-3ua!)Y?7^Py41dtGX(iH)s6fPuzC` z*QuKcLZBH}avsdOZ*L#*!}5z`^pE}VuqlU>3X9oW*39leV+BzzT!U1^Ys&I?Jq3_i&p7b-h>mBHgW3u5t@B;HHL zh-x2J|Hm0Zc~sgj(W#|YYatSMB&*JyA@4^Mn(g*W!p=m^u#d9^8BX#A|ghh6TSgHcLG{jK; zq?+;+p4dJktIs>>Z17bym|%{uLN|rHm!;sEk~ywgczzHTXt1oCWuk&AG2<1^`pO>wgShSlgUT~_N`Y6KxySvDP6Q)dF zx0zre-FC9<0Oy^7zwQNtq9;QlSN*@O%N6W~zAr-ijO=PIiT+OJ2*ZV#X$zj6<6$=d z^x!S@>9zNq?tdn!b)T#CuW@=+P*;jM0W!L^t$mM&xm^0<(p?H)drW9bDZC#Sj>vgA zAn4TZF)TE*^2vZRpyD-e@!e_{QGERol8+fcPOb=W&_J<>!agBZTPiTn!_VMOfprU@ z`zIr;kfK&wP$-D3{n_MPT@l2z34Pbhz+)od8pSsefF)KIYh_GMNX-T!C$=<21RcBi zgCBs1>}o@$z0D?1UqS_wO)QAa6dNk*e12vqR-j@@um5M@c?<4vIkemo)}{2m_l9I! z5;mWZW2z-Msx@Ow7s5->`=SoYLD1St@lHF%X&t8iuyp_qHS0w*dOpbv)51OjC1eC7 z&ztcreN{q)Q`7Kt5sOk360NRx#+Iqf9`-j5%;id^~b`7(HYP09>N3%<%>! zc1$z$kU*l%8`7x|?bSfq@`I>nw1t#q;V>B@bC^XUwDEE39g6|xSVPcd!|pDWXax#? zt55R}K0)=|6iR6lf*HVu-l63U}zn{pj?@LNst6Q zB;;_@9lN+k60_ZyBCn|sn~r5iH<_>{-q6@U{NDv|L+{uSX0 zS0-2gcjeY}zB8Q*0^Vza28-~2TOe)Y6#%hA_&|fHHGEhH2BNTI*2-cc9b9-DdLF>Z;2aPLrpi(DdY{EX8#wBz0bMK&4qY*xU5W1O7xiFhOGE zJ(mE6Ab}~sa`ioS6*@!k7P=Ku56N8gB2Q?}RvK5yqj=7@XSg0R*L7%%>V~Q$gM|S@ zKbZ;&=nL_h4lLBh0N-GEn_JIqa*tjSz`)i|uVA=1`i1lf0|gKQ17(*#bp-^-V#*cd z(fY4+L7gl|gPMeuS0?vOxx|jinw+*Xu@k#d1{g5)NGK#G6#_z51m{~Z7+g#G(SA#U zkXoDw13p(8{<_I;6Yq&YUfyX!Z}gS(<=~$20re#ZURX1aIlPl zhM?J(#EUA>%`ZG;lIFug(7s{z*!S8yLXV4dR{zP(nkl{9?M+Pwt!Hj8bEpP2HX{R1V@FyVw;PZsy zp5_RM;H9*l#T%-}q>se{b%1t*TV%ff&g*M&Z@}Tvjak#Qm2Zd6y6Yk(wbt<;HPWd>kN^&Iz*yixz%1HLn6u_l0*FXieQ6eH6|lA>N*(fNaj#it zmHd^610Ha?A0YFSQz7z;<4O#&hP{CxVXz2Ox(^!K8 zrEo!75+sly9aDHzCqY*PU%R|%Ns5)7GpqkK z8&MsUn#`>b0S6PXU?$;`>Tmj&cmt!C_FzJoi8iW9*)=v-i^H(lXSe%_Nk5eJ~~5GN#*buR%R+%l=+ zHF2c^aGBV+#DZPaV;zn}ugIhVrE5q&%Nap40C09@J;H&`^)kwYpW7jQR;Wq{03ag8 z1L`i|+1Wx2QdlUTG)!E%qh|sdes~8!Smh$oFPL01i*98b7(^iCpf1S8Dq0907>aNl zK>!bteB(-YdzJA^+5n0mXm-uKb_O4}ORsHxTW!~E{eG|xJUW<XV6DiEOOD+`z*MpvMh37$@cHKClnvwr z{h`-q;}o3a_3Re>&d#RI42pY`n>JmP`zKNr4!qoxe?cn5x8_N4usuZQK2Xdbv&ct> zsB>xV?+Q!prv3?O9+O^|D=zs1E{U?xVG@ z`08+c>J>wOH2BGy#D!wuJ)$2Z0f?MpbS3S%GMS@`T8%3OMc#C=(nFgUS5kf^FM-QU z_{$~~)Ud39#)Gu*m2h+q zePI>OmK8E`Sk4Rs+}<;hln8FG>(D(8GyC$B03gnMm*<$i6{m8_f)A9fiWJMB5YMmT z(uIlu0J5T!YPxEDe~B))ML5HdLt0rRi|NLKr{1;8z5uzb*swbLF*4oRZ~KrwHVzzT z^_UAUhx5%o97_Cz;#2ejlMij)P%)%of%ECetEY$#H(#2ZipY4tqdiBvjrT`r;H_y6 zW*akz{@RTANhGC|4Wga?fP ztm1zZoe8&0qx>e9{7@TJfCwT0*Cl0w?o;uy;1Sh$q>GjBj3E2^eh%~;?P-Ju;zd}% z46eCPgDa`6^r3kbC~F*mB+GsZy@%FzLXu(SSd<116gMpVEd?Crj4C*%doWrx?3LRB zZ2ZO0_z6@75iX5>Xi_C6i589_GNE*#K8+kF`6_4zTWu_=91o|H3HoSP^;sM);0(Vj zLzRa!7eE);+ytF7&Q5?I%RYTH+Q5&5x{F~IMe7NMJ$fMf+G7*$s>=~m1KjDi=OnM#W4( z(HL#DTsRbM6hJ^Gpy8xq0SY=fMSVaj>rAL+I5wR!QVd8x?2PXlpy(X1510sB+B_GD-;dWdezRO_dJ5E71#|<5G;b> zQ5+!#j&QzE3Z^757?K*^Vb%*bwhuRZlfJK0L}SU4-4!qTXW!IW3uNCDD*tB}&NUu9 z2DJ|3JJ)#3`{-*40Z~y@8+$ex<-l^7aPGE;ZH^s;>QXW zX=?E@VG&fCoNVWo&Mb9g1R9Z>Lw_JM8dC%(C?SH;Pp!46n*G_&l^QaVZz`NhhHBjC zke<4<(X5xg5Q7LLBE_c#4@TYvzodzsfCn#ecr!=G6X7?BNQ65zO#pkIyg7Oo6;5d! zyGI%`ZJOve;#h5@+U;NlOgO$ZB7<@ei@&LB39`L6sW_;Gi92!p*LxcyDk%-&$IcUU9plcF6t{XILPxz`!nL**@k4wKf2Zu*hd@FU)YT*9fr2f5G9aHP@z1d_kQzmFN>AN)Odnfm7 zkNRw%6#KsI?Bi4VD)*2fbw}dd>;(7R$I{t*0G#&H+}*{uA-Jp=le_$s**OyT{F3_o zio^VB^!!@s{KmWat-1M~(|I!Y!f*A3KMo7~(F=#A3&-ykPUaTQP8R?k5?F%-btJ)K zNXWp2hc(Exyvor4-_B8bx_OR0+C>!K;%dMmuiWCv?)*bxm;eWDu*oc^>Gy9yA@jur zp+NMG^OvP}OI^A2(WC4585AwS}OvsD|{MDy(T}ZM^}n=m#O%Etc?D+;_^dPYjyE-(Y9f^d;13w zw2ImDzwzNz8BjjvJM`PJ4?ne}5Y_;?Br#a{+Qg+S9 zaZNAlr()--;ry!T{F*r3%0-^_>VTgqj^E7~QQRizIwCTCj_NKM#Z~sxAdq33Ovg3G z^w4Va;p+0;vUTpspNTxHrF8Qhrc4#{i^4l#ej>QW4eclcQb2=hhv?1Fpo@5Ovuo>V zjto;I>Twy`jtV+YmrWASPHV$@+vwWcoizk#op^EG+Vp!69$do!)e%ECQ~;r05nRsV zp(GH_VM8Nq<#r7Eyl!Y(27Qu4edz2;iV<&#*?E(-88^1RyzOCk#3$s;%u>!^b%jYD z3ttHX!Cu1kq4cye!jcp4bKc5sX9E<3?j~(Rwde;Zjb!#ovRK?YntmbvZ1ZC@oU4!o zHiz2dm@tjI)mY$-3d|b?ejpE0RR;57sir!iSRx{<0ue`|J8JxEzwq})In6xj?~Py7 zu1@=&vHRZT`@UWK{tNrQL9|Px{SeKAFsFm?*aJ^#x-W!-I|~QiLGZmYl4T<-u#15U z2+4$Hn-O0MqPbC6h{!AGEbFDq81Q90L^%iYj6_qia8&k-W*ANLfqYaFbpC<1y8QTQ z*Kz%eWAMcBe<&i&e`C(n@38-xD93GG|2h`_b&emkcOAcTrtWe&8Q}frf<8n#!fder zSWnTC6?ON?HDENHQS`jhEs;xxFN0F?evO7qyGZ@7f()*tCy{B13|rhccG}A@Yhz1l zymMX^CkRKFjv14gvx#S819%q+$S#%8= zht4SLQ^_R8x+xmv2@c73T9Jg?4A1oo@j zMXfsatL!Oy%-MwxcWF|*B!o+@J#7B|&Ovye`#Qhggv5iXyHXhUjTOma#FZnJ_0YBF z<&cJXrGu+JRx*-(&Pfsb8^rhDxv~`H-^UUkX1^V<7x}vvDQotE_oRLM#Gv(Uflwj< zCWt0p_diCZr;LEA>h4#eR)hjZQu&g2X%+`Bg9EiPo}Aemy-?mKYk3O!&dVAp{L!#C zRC!}l5}?VRd7Ld2ZH4iHMSF(82}o1hHF}U*5$Yb?UT!dn2|Brw#b7m=(|dm;-?%^N z+c5G&$~U8nea$nF+TwfZU$2Ntg;q&xvRx~lZ2$I+=IOvaDlsvFc6iv6L7_&QwPZfF zc&|)>#tM&0HH@JfB~?Kt9vqjX%;k|T@Owfule+QN5O?U#1D!O1wILjEQSC{5TC8G* zH@#pL5+)>mZRKPA$F};kFEbtX(jQ_UKJj|&JklJZpzPBAtKWq>f7hmDMfZKG=Pf7} zp!=QH57tgSNkMSH9z2QqQ6Kx(R^Yz?&7n^FER_+w{kiAxZ^Ts7T514WI zN+p;7dN~K~A!xiXs=6Ph-$MX1@Ee+w?x))0AoeeyMZIPMyzP~eAgefx0K*r|`w~ld zumOQ;qb-Eedz*R4y;3Mo)X*jCR#QkrK7aU(>r$t@A&_CNT`M4;@c4r}NL%q*V5iaR zVj<73pFod0o#Jn0@#&NLJV7)Ji+rL*!2R`JTeS09l5(AM2oM%0niPGhNf|!;g^jJMllMH!UaP*;ev?%d~0H zh09PPKkYdq6H?yg(k!bA+#<-^4=@&?NDO(h_VVKBN-JFqW9ALyKWJkH*x3}g5gB)h z|94tOBN%K;NC6t-VAhFogd=p%*)dx#?WqoIH)H@giz6;`s`vV;U zE{Z=o2cCp+Sb*~|PG7Mb3=1QGt~A1>usO=22D?T`qP?g-5Ko2SOGEi_*9)>LejN=d zd~xZ+*N}TcZlp(oo#ZRSvj&5?{kd)tcihYl6Rzg1$O;@!AcUcRa?sBFIX5Y{e;DVb zisf-7usmVHYS=N*-k*stu1^@<8mKc3r`yYD*ELikR#t_n2?#Z77tUr}=JjlPlJ#NB zOTXmkYV-+&iTd)I0wjv*MRaCdOHb_;o-Z$Fx?c(YLnl9P?78b)X8tJUXy(>_T20dM zZn@CZ5VkwjqEbH0hDFCv=8mC+XSG0ND@yE^{)TK}-k)l9hg73DU$*-_s2ZW%E1YcF zw5?MjwO_yb%qEN1mxC?qA{L>HMsjIJ-Ye{(b*37#xcVgK7LzMd?-g>)g>NGtJu#gU zvDH(weAwYrXWep_U;GNAC{9bD7R?M+avliG($2>*m!DKzBQY3QO6r*~o@ z13cR}_VOoz@6EF+bH!%0lAo)D)3~j47mPCv`LAFNC!N}tKXsJ(hXHE05_IEjYh;e-OC!WF}>a839u)O?$Nr+E8w#zza@ ze)I*KR59lq5ZW7S&|u@hAXf#;Xzih{*RcL*hlXB4V(76$3eZB?H0nqqL=2Fl%OQj4 z3IG;rA03$gS!!ye^DNd0`CRM7-$U=lC*fq1KB0ys1+Q>Lx4PfjBU;NPZOgq9my;D9 zav>t|r$(MZsG@(%Vct6G4=ieD`i$*%E4&}UY1e4N@aU9Bb?Tb_LG9l&VFzv3N|&sx zY1C-C-PZ(NnWMdqUjov%y8q>qZ{+>cUXQtDBR*R-;(zGRQ|3A5B(?{dyR*)uv6^&n z=}!}f`fKUz)~C;S#9|_RH?^FO-V{>G_ETEbSJYqdB=28>sexmh2>BAr^Wa60$(Awr?3Z=_K-udD~_FtRBTo z1^v_I5|_e<2M}oRoAa%#B7hNSONoThVk+$UHKv)cG5pvQH!)foD!S`57n<)XvB!Bg zCNs|Pr+O#Bh8~JGHl_@LIM6a|%(-)qx|oXJffKtSTU}h&3t90cN|Dtm=mdc~NnoOs zdSiyr=X*%Wmm(SM9DUgKk6M&cqE?PYA(eAtQe@)0D5MaU15u%H1Gw$R($x)KeP`pY7$F*NIU`qwSU3RH722i~0bIm^)oCE^x1c8=B zxQ0)@e!bt)z27RV-#W41rl8-dxyiP<|3;slZF7?2Q2&kken;qlGxLB8Gr#Q?>;`7Q z{rZ6YNxw&!zLzrGE>hpAME}M}O)-gJdY*%cNB)dL!Y2~1G@ehJA^hwhKCxc5upZsS z9!h@C&3bx+ky^JmAgqAWg`rd>gSaGi7_8_r4`9Gp0TdYz3YTbxU+twHQ6zxH4f{~H z1UWn|CsGwbjp_i(5d*-{n8=+@P*hI3Fe8-;=n2aUpfa?|ErxO@URQ<;6%&St-tQmb zAxxs6M+^jR3^%9_%5ew?q4`q*XcV6z9&6*UZ=LZN00_ zsr#fhEUl)a`0L%_OS%S6!>&A&6sz|~J@24yy3^SpIsAl6P5;hdLdKwYVlU;IvFRnF zCq{;uHt&<~=)TF&ZIJJ6IT?OkKdew9-fWM0K zlGkcaR6Ry5zfDesN)0(hPnmI>UC=WzQ?R;b^2H{NUFqSyRBh|X>(kL5pJGg=mDH^+ zWlpCYBd)i_QD`eb7U&BRk@01aqSzrQ=Deia8!UZW#99Go1G{E>I^lZLh7iESOo+E3 zg3-8^Byv0x4yNZ#u$oLzKqi?wgZPzaMoKK0_1?>{SQd_cOi7w{n}os-({ASgRS8I1 zq5(e+eO}=<{>Hj$WIAzfa@GISivZgj9=WPBgGmHXakCsy*D9~9-QOKo**{t3aE*ui zd;aq&oq&A#RFL3oNfHhQtZAyC%Tt`8h)6YuN)QaGg~$P}*AKie?f0yk1^*PL_4z(f9w!7svd-{ArI2C0NNQVLCEMoN+0bMyG5MkrP4e8XSsw+_}XJ!}%C zZgiG1#E^lSHxO!rDt#Nl`F2nQ7KW-&Fv$T_){-2N6?uA}76X`E`qhs6uC1I}zw*d6 zA_E8#U|@s1Oe}Y6i$mKx$&v`jRYG02)19dsjdK>i9)I4Dzy71tq5z%p@cfiS5-ytd zM$DWu`RY7%=H$sc=N(I%j#I}f2fO=1<5&J#6sX(XbC@)TEpW0rKi>Md_U|LNr!~yM z%s9zLw1vbtKvJF}g~LpR&chS?-`Irb-+GL6+*~66C0!79QBhc=(RUGR_SiT72G!@!itJv8A0+H(?W3`HL1R;V#(ug{A%v zN{(NZ;jX)|WnI=~k=LIDgjduR-Q6vhRmK)oJ6A-%EQ`&r2n8+*H@LHFEGC&OvN|m4 zl(}Dj?Pgqf-F(d5BF4j1-`)1i-7d@W>e+(!n8&ppccU^7OJO%FMK?O0RdJ0Unx;Rn zS&Qexu=dOqY5iB4r*EE>84j);IjTjZ{8Z0Sh^(&4UP98 zmv_p(r!wm*Q0Pu@bW2YD>Gb-?tpSg$0Z-;no^9>kLt!gCR(5GS-USWbAMJfU-C4Vz zOs7oik-fhXvHzoBbnVK#_vK`dGR0L#eNQ#3RdbEyC{u6Efu9_UPM`J`f_OIk%9d@C zSKSnUy6gY+uyV;C^L^y#eK*j%u+s-W<`W#_8xlCvV72kW)7O)Av#M}CTX8c7zLERd zH>$zU;mbx{a_*BXq{MSi$)xrCGqf>#JQpb;w+$vrjFVIr(OrwhB6HGgumqivxY4+HzKR=tg}(awn-$?cEp&9HSwHF1K!Y4fkRg_~Xe513In9iN zRt3pQ-M8FyW43T}yk>KrHGrKVZjco?C!TIpT#ScuE29DE(0c;|PKRy~T_lJNAIFY` zecra8vLri?%=)^M;rGeb8F(+`9IBj5HHh~v7=TZceck6CU_mN2NGpI4$_Pk%Yk@>T z>S#dS9;qk8>);YEfP-q|5)B%+JI;IrR{b*f{SG~Ua(s;&y#+-LAyq`>knFtIs z2}u(@KjBtmWvkH|TjEZev1e!v0Q6EKeuK7ca1+MQOrT&V2yqkfoI@$My+J$A0=hjJ zdaO+Dnf^?0^tv6$6iF^&Is}9vaY{Bw#Z-VThtTm4#%v?R7CBiEqY=oX+1nX<`4{aL z>pBNt(p8|=&89i20%jzm8beAHs|q>I42;(IiCNv~!}0#Du$L z?>BdDcpL;+oBeVa+;*&8HLTs=^z^%KhK+E&p2|O?fAh2T&tS){u(_ShJk}8Pak>PD zinx0-j{V`=iTi5>`|c@$VLyM*v(JRQ6H0zjiZ4H)1iy%I>WY}B+Yhonl=ijyb|iXB z>ZauD-=P;H8pD4~@ch0pbr|&{Qt$6!SjHE8(otZ`m!jGupSdp&2XE1Xr%Spp(o~N! zt!bMot=aBW*jY2JYwYu~ZD6_%55Hs=)=pP=v4{Mn@nVY%5Qz-*iVBK|TCj=q5Gsz1 zwR(0i8TWH+d3)bC+vkOsh*yiyOA&!4#PwH*kMV;(iLK!!@x}3T)K)kDTuTb0Zoa*_ zpLye8*Ip?qN9#D?%KlsFldxY~F82>yr#E|BBQS#pHJax~j}9(7ozw^2>3I=0)b+cU z=CEn-_!aL-^WeXhp#Asb`@{EdK7JASCH5pSHafNTgkm%3{jGeTclCG_anLj$9X0s( zgVXT{eM~g{)))n?az8B3+N;*;AX)A7joE4Ybkq;)+x=tFOWD!$<$()Iky1g?zq-QT zEO@rFeV$r4-U+(-e)^QG6!W1ra-{X}N6_Z&@Ut@j8L;y|6cLmn=D$Yf>q})6;dft~ zC{;}7R0=8aekov(dQ_FPa`;kkxIma<2ok{9Y21_3Dl75Xs~{FD1pVH6vxgZd(^fs> z5)ZDPOgFs$(S4m!_*1psqmU7wQ1PjHs+UyArf(iwf*&JN@jHys zsC==-joQ9wiN_Z&2nB4=>-Z_XQT5xeH_=a&4Te_oBkbbwHo}+@lo*bS_{95-YS{L) z*7EeNw_O3byQ|iLuLTL|K(k=uu$FYS7LM8viNC59l-}rt!W1FE( zQ&%7a9E2&32M0~>jfF@2d5w$7Ry=5*Lj^L;gEpj;7PxpD7)TmY7jG{5{ybS+nHqf? zynrn)eDm&L(Z4h$G_K)|_8*m<%jvayqAFkS7w<$3-gq_I-r3C5xx6eV)S$5K5JVUL zi%D2*BYFWQ_}9{8*orglK7$aiWzDy=M!*-&m(*^eHH-dJ*=XeVl{AC1J&b(fzAw|1Q= zHwuj1HGqM7iDL}psN>tblqIFNqyRkOZX5}DNl7bQ2xmZD?etEr2+dqJPGJ1xxMyUo z!`LI^D5s00Jyp^`TQnw}+*&-~WbY)dXQfIqFVg+IuS-`p5mkO+3H0E8F?HTrtWf;| zqfko!g&ygYqx`C4;&ivfH@v^cY!zM7%sc4;nT#PnSJq(U;H9h=DZ0mtTJd#6#gETZ zaRmbOwcgr2$d5^h^;|cB%M2HHXw!VIFLB;DFo5!efl_4!`c=li|B|G+svoO7M$c|ITa`|V~w2bT1b6)t9L6IGU2oYI!O_Gs#{ zyOT4*%+vKdddY2Ey~%63MQygAG-z8azQM?Y%`$dx>W=dF%hR3%83u6OB5Pur<@9P6RZSiB!O)wi1dCGM$W;xYQ-;FF?bV{%5+>Ig z=klI))W}9k=&pk1i{?6NRbEJ#QOC@eo^;gdnC}}$NiLM$ORS)pr4po%rXwsl^)|%rAurW}=1#Ub7l}))Cuo-uBP@Vmr10nm&wlmI&KN!1l3G8X>mE3Lk*HGXzy9}x@{(#l)yz0v2d%R^(jV*7Ff}`iAV{EW zbdm^%A4(uM4b5r?{hw|V$dbaXRl_mHS;h(VRN9k8b>vg7HGgDn?|CU3C7*U%`ZmkK zM-IgS`HaBkE#B`-Tw^nanX%H_0?fTHU$+`&<*eKe)7oau3RB4Cm&P;D#-J0%^Kq4a zWpM%<%rP@~mTDlD&KlPqUj0e-g}NR8=Vv9k>Uzv@aJ(Q2%D2Y^rFK0@LiTL2+&c?o zz@n%X%b8S4W#&90x$QSHPKz4$4Il$R0+nA3n#R&#$OwR{g<)x__c0YBDR)#&k4ik~ zcf}d)xh=3DWS$CVEOaJSPP&2t-ZsMb+kRXOtdhbC`y>bwvRG@xbPxEu8_<`Q8$jG= zePpGX(|hlRo^oY%Lw#i{WQ=Z<6}NZBk#{>;OAj})pDi)|Jurxrv2#wnzSN-NBQYWF zt^epIar54354Yo$z*pR>RrJlp@25ROb5z!%J_SE-`Fr<)YxYW`%2@}<-uI>~&xhfK zP$Ln~FDqzn!AYal7j!2dJT!UME_Bp7nJtck6}57qp&g@d(vKcBX>Q0cs5H_AlYr?*K8mERcc#frJS(j1-7|so zfll}ORd^qbFC5wgN9XWt4XvsRXTJDQ2XWkfJ@CBioA_Z*V8mCulC8Pj)gPgkxIf1f zgui&icM_Av^G!rfYvlZ1$bVJ7hpP9xm&nN$Aw_kMcaR>vFL(D(1K4>#IsCeq^yT}V zkoj-ZZ(a2B3;OWZ)Tlkq_5NAS%pj}p3P=B5UmX7I`dN0x;k2<%`@olcI``e-tB%;| zVyx4{4LSZ_wPI0=hrE$}yEo6PyQ9AU`4{nA&PhG=zR0_~Pkufd-uXg*`QagOKlsP4 z_WsE2|L(4=qt0laeofQW{c?5v7lQv^O~OA3C>dmV9t;ESu{o-(t{XZ5;U#~6u3eaK zK$zCLE)yXcMqobTj{mJCy0X{u<=dV7pFX8uw3TjkmQ56)sluH<;?}=hzIB2i9`q*2 zbm-|D3`<~&a7n`w28et9Yx{>z@A8&mA!O&9Sm#e~N44RDP&Ygc$^|zCf=1wBW_lEA z55xz6ZsY3z^1)8Zj?UL+vo@AoM)@M}ire~h4uiP8A+U7}&^ic58KA96;&4D~Z-}E- z;G@k3r>sl2J0&|cN~e?zpup5TP@ZZ4=NSvWprI{{rXYa~KCLn4yD-_KY3A0qe4V}1 z@GS_EI14a>GGK+`aADXy8xoTr2|7-aS{h@<42od&M8d$#uA|iUYoB|0=m*da4q#^C zDg}i>D}O)$1*J6Y6*&x;eTslwARmoIszJ1VkQkQ6=&Z4bGyqWuNUA|JYO6G!2x)dz zX$}ZcEFYRkyw*E%mG)Yd*0P@5MwRxQknTSrELAnOvPyU0w%pPXmVzSscpE2Mt*`h!7G-8TK0eV0*JaGb^!1I1EctwyNody7U)Fd}C`bti3UanDL!6yRlK6;Rg zK_NHn69k@?LvJVy&*BEAkEjALdN6UYNE)6EBXat(?DQ=WZc)yafWE__N7qB*rm%{P zIVGXdNUi9Hs1g2gEN%Uu8wP+P{Rav+km;0pD`QNk{6+-Cbg=o}gnunk3 ze)W4i8jaO?91HY&xO(oz-&@eHnNL_2#$@a=U*E-ie0)E>Xq&}<1IZK3ayuBpjmA!KBNzj_hbwNhl zqPW4Ze^({QBb3d{quwKd>#ak4Zv6FYrq-;Woq&$$HnkiUi4qe+xH)y{pTZ@t=oHSy^kG z>UCx%E`8cRK<#a(^FI*u43OM27p?R&5l9}I zHQ1`r5W4^9dA(A{UaD)OM$x-89hRGocTRc59hSv98olHjJaj<^m&f<@dOQmP?skuo z#Y^YBTLN4?CbxGxcidCNpI5>PH4F%&!|FZaczW@Hl%|{6QvVf8-7z{CZa8@JqYm%g zM95Bm=8bBfXqVv=i!nNk4ZL{A-27qIp<-WgJH1m(Wi##HR;#OlE{zV8Ac7S zY9*$qWc)(XQs%z++50BC%DnpAn5)rn-MZl&+*i-i^KrhZw`4iB;Ay@vX#8JBei(lki(nu7oBEViE zdJzrGMBBzB&3h*D#XU7s^801%rw_#N`O(3c69jsUt=*2u5g2%4D?Af}C}>5LV~};N z$fp>Z?pB)rFtlT>w3L+DVk_OcA7MLIa0;|98YhJTTN}PHviV%IEM;R!j^WXw)-!+z z&VWRmXHfG}j3wWc4oCC_jzwDQq-bM!#D`o099XvUr?`&I&}~doP~i(xmpK2L5Ghvu z5&AR|qX8a`jzdc0!3&pyVkntUc}_7yHcu>*15m?ZphPhjqoS#f@X>9|X)!FdItmdw zC+c3&=vx5CMh@)?i7^d}fQoXMDhU7bw{nO^-^3q^j-Xla49#ugTMgow$Fo6{-XA1R6`~2#GhAT1PBV+l%g;YP% z^%!|2X8*<3HgmY*zPBF4YzxN|3+KT}slwXA6;%SwSOGGqmxUxDJR(cuue!yCDUatH ze+qMaA>Uj%(LrTIW zI64Dn+GdbW3y#(f5VHEAndrsMV93$>l%{78hl!y%(l=IxnazvyGb7?z4PYH#aXlR; zVf!ov9d>5HxN%Y}I!?fh)TI9G%F~?g0r_SfW#LrZbagxhey5WT7WBly;`D@rl`qG( zn@51?Sw^mMKZ6s#Ue8o=Rcx4YHDj46;uj=i`MZ?l%7YDee>SBU@)EJQGyu#WCul}u zPNcK{km$bEd1=4XaRoG49WSxdfYKUt*;TacZnvBQ<)Px>AAzg>K?c(}4_ey-48_vY2kj{|hNzA(L_`nZ38Lj0al59HG5k4) zIa#qD#44;uc_z6ML*;*OG?yyt^X?bl46|N=@EYUzTH{5-+?5`mmj{R7ZmIB(DfAgU zGZZu9H6G-(%L9C3YHix=wD`Pb{r^D`{d)eC{J&8|44Q51{~JXl*7r<~f+BiIp}s@= zl`}cO(50UCTbf;WS?I&?(SL{O{2q2C_Vqk^sVfWyP(O4#^gz`oJ>7kM)DP)(!|+;U z2pi#7-@4|2*eD0#m$oNfYgdy*t+o7v;w>LUKkg%m^$*=oM1_&)BCtYo{UfFqx@KU2 zmc(h+KYHatHw_O4K8_|vkjSx`c6d~h*5vLV-PS?CQ*ZLWiypE*FP=oHOHHjubdiTe z`$0kmTCYPdVS)dKKxSEIp zHhPFqo4x#0TErPk07=Vj-RO`-KTS)dEG&y6g<9G&KvH=L$8tx8ZDAQF?FcN+E1~7; ziw;6HMrRnvl%{RS{-*-x1c{wOw|vBo!kyZNonoJ^{n`-E0f}8*51w;ob~iofR+!o7 zlCYj-j8}$Q@6pyLooQfr>v5XO=lWuQ9m)Ob+*(ern%nQZJS@U?iU_IiJAa6UDu#H_ zYfJ~ZJLZopwKrVC4v`&lS5xFxS=v(E1 z@%DS=J6|;y2?gg;M;7Bn`c~TgN$j6-f6()0&kja4{JIRxef%$Hbs8|dpb@I3m-}o$ zdxY)!`bT<#z0Tq0psm0cng0;y!?e$KO_~Fqi04JLPja%yG01%*HP4J467GI~{rq~` zk2w~0H|E=aQGw}^%!k*el;-$ee4ltOf7tl~CZ8J*zW7s0#hh_z#`hM!+K}VBm?>2!q1b}xJ8!yR`c5Vx>0Bu>f2LQ?!G

    z6$fEnLZ#y(3NK*0FZm%;_|X_EykV5Zq<-Ra)*qa!Y39^f`n&%0H9C zvjRQl3xI9fL-gp{GO>A+0cnsPF*Lg1GKf6#LH8zT;B`E%yuL*&orcunE1-!u}XEER9`Fb zIp7USC;lUhk2VgHVtkv6(nm)YTHefdxdov<#Tu;bz|B#{JXV${oF5k5p@x@&I+Gz7 z_(<8Vl5s#xw?%a4eCgA+I0&ULL_dQ=s~N`u8*R}tgpbtfD7c^!8gb<@5eW*m*Qm0c z>0y0#9d47sPf_eD(h4IoQRCu%7|NvZ3OdLchaA9^gjIY`5K(@AxgyUhB!MmlN9SNd zf5RFT|26os%_6R(xU;G;kkHC4Iax1hJt)B1WL6?+oA-0!jbY~<`%fS2W4gSz~Yao?2w-zavzst{u zYn$0s-%dz*y41bYd(vtf(G1xtCQ!?aw<}eD`7YhJy#K>m*7F8~H=@D*C%Nri*Aw5Y zoUdW5N725mmM|Fy!@CPBLm}NPuC~9voV{Jn$nT*NkFROoat@vH& z28jENfp_|bii_OgW_v8H^x~#g=yr6UX zdZpxGbs^)dS45>P_Q41F!|=ksufFoWw`gyb61uh9r$0ZeqH)Z5t!j*;zndiUSdsA$ z$FP`*f>VLnM^Qy}FxRp;&qTau{^0nD5aD|!uW-octF5x7p zi^raq=6vdoMIdX@!F5fk-th++?ZsnLc9O$q(}`?9%4}D5Rlae|YG3atJYTWZy}~(T z^7eZ*r=!=UbkFS>15_XPwf-R!r1K1 zzgj$0_D`{KKiutB&hwckqNlAdrMz#qFHej9?wH$XW>MGtxzzGn`AI16o;O4B+$!B^ zO~K(3<|)^TPexa3@88d(c7HmS5>!0+v=0p)KAZ)=^lx|>=^Y}~_x@^z>Wf_&Upvj- zMbM*DQnK(j!pQICmlkTzf3l1pnsXANrz2S{zRv$?EpR5DO|?(ocU*tGC|__kId6UxOz!{i_221?gi}x||BF@m zhTxzmx|58+i!Jdh8n=wDBJR$|Fg-^nsi_Sjz6KY*_+9(pP50j)k9H%Zek~1BS%M8wvqFrn!oT*pZ#-XgBG7jv%@-RKvEn7)M<<#S-|A z{f^lD@8D!E2e|ebYMF|KM-_&-6b28mbG*UvS&yZ(%=(c$!dsH=JJu)P8c!BU)M>wi zvRdS6RKB}dccm{kD3lgeJ{j-!Y zu$#G49{_5|{LYc_(=OvzSjPF1*XQx{7xh8+3(}73Q$V-Vz8GgMcxLU1XF>L}{@UFG z>ijh?rOp^O*6 zjx$E((^Sqi_4jj7h+Kd(TUs@T{zi`NgB&zxmQ63=WGNf_D_cV>muFwy{RTnwK^9~v z_r`v%$Bpb5_j|Y^g5Z80*MnSWGLs1>r7n`KHIW^5Is0;Q&QN{MR!=r9BHvgn4|BP| z@w_0Jv(UVuAP$kqOQPb_YGP|(DgpSEB0bRwuBIrqAR)_-=WhZEe96D3I!C4IexE$RjTC8rD) z6);Z}dB0C9;4CUS&wtA)GpXj7=f&bc?veVYz%jA^_{000lKs+`5+R$H1-HCdmuym$ zPm4%JC6(_VTmE`np_WoHBvqZwzS~>ApIl_QU+mh;`cP1*N|2Z!@mTz2=`iOFB3xiG z!0AOyGPuG?-4kPYRsmOuLu*v#3RVh-SEdKVQH?t5AIpNcxOtXYE5vfe{)fG7zq zF1OUkvwEKI?p?(wS-mPzS9+c-L6)dUMAmsV)}>C?rl-_X%r<( zHY|Fj`y%V_c{M0|mzGS{yCpXod}@4TLbUhFjYukKo2=>nT+{i0{i7c|!jA?%h%CV9 z3V)}L#x_4xtMV*1d=*}`@wN=&|5ziMPK*TB!hk9^lvqdr)Di*NL~{8-lr})5;^u_K z=FG;@Xp_2F6IMzS@fVr`&w;|S7%B)1v>Pp85KI@1QuV{_EGIUY6j!8F<=C^TZd?JA z!r@s@@36qZF4S0-)-HSE=i)jl%|?s1%iv=Qr-6fB3PtOT0MEjAf>4+65TDj(_nql} z9X-Q5WLUz}$=_^OAwO(aD{0s0YuEbFuJflI%iSSwiqpHsF=)Vm{lcTK1z8g;o9`b?^|+@$q&qxy^_YOa{M0|PS0P|+VfLLX6q8L6!B zfF2q)N$y6_wZd#SfNDZN>z`V7?gq}j#+!pkdjOV;K|R14fQi)i2>;!4zFcPtv+;}E zJ80k~H0C`*5=HM#__?CWDZ>q^~rCd6R?O z{R4Dg`Wezn1v*P&XSEqOIn*J3^g0%qcw_Ao7xCs-JjVHh!a?_S7enUB7s!%JC*VvJUwv_meox%^(}aCPy}-Kl2lsnP4SOtYyh$6hryCT)6OUK%(I zv5_xEtgoj0a;ed291HtA_RwK)AZ+OKRT*Ap0lVKfvmcK;G><@<8xM;o>@>=M?oW7Y zO+-u$-E$cAGrM&;cJg*ON|LSX{>s75WF0Dy}l+pC&31W7&8`t2S;wO0y z!-qE~i_BhSUW_Mbjc#9zrbJBaI5@4EjgRt>&a_654kI2@^W;3DEZ{Qab zu+>Rlvx!!%!mb-li5HVZ+BX&vr1*xJn_pfx`%G}sjb4=;%`AGu?mO3!G8fZ07xj7O zkZd-3yi&s9P`9Nu{LN>cKYa`#Gs~p)@`=yv9%BBBYIn%Rv)`0P!cxfM`$6A)b)N1+i_8bb)eqOS zS5(Nf%Qu=AUz@*+JX}@%`=Oy_-fC)D{&2ZFef6+qb!d9^rulkZ`kL3{mEadElfJ8= z>C5LWYpIS4(~(PW=s03FV2_B;!F~+oN7Mxv)UPABn;%sf@ESbuAiEIv?;0N;dlwO?MFUR>z{w@lcL+?P?1m2- z43^pYr#+YJyW&j85)FXgMT3J$OnR@G{7HiH1FM%UwqR?Uf}r>EZB%m3ysAgA3c>9c z!L&R;BsC*c7J&K5!n)A(K~B3LTWMc8?}iWTMy%~d{oBR!?ZxQq#X0RI+}jN#NA0By z?4_;kW&GO>VS)Oh@~~Cq}h=&A8+=Iagl)poWyW16um!5o5 zc3QppXjSz!+i9Asc--dTYIW4#^{b(N?&Y?rGIE^`7k-XcDeM_ ziTr8CoO>?)bjNo~)^W_Z^nKWW>*3|^^XXQs%g16?S1rjutRAi1EniK(@-6k-S%lnK z;+yjm-_zKqr|IQu=k#ZO-#!VOpF4g#56L_aXx@ar-i*s!@^7ZhBG*G!esz_9Xe8}NR#n! z_q7qu9MPBA>XHBAdYIj=5Dndt>HBkgbBV@?Wj8LH#%oCiHBRQ2^Qvr`9mTv28y2Ll zHCm39xg)v+Y&(2~8e7KS`QGdidii?#hKhjG0QZ4p?uUYJx00h_w?w`if8FeWa2LDt zJaBQ1Nf61bxtKX|Cl;y7?$BD@-C3> z_SXZ558WfP!_<)Sr4MJ*t2B9X@zW!(}D<}v>J4nN)~ z%TFo{79sP3(E3@>_AcXT;qTX!|NLN{iI@DlZ&`d@A=e_I8rYg1(_+n=Pv>c2oHI7J zfxpdx8!pJJiKHJ{-ME#`x}?fz)pf(8JYL1#tFETY{%)S*j=gX9r>>j#d#6ut`j3fp zuXs70sFVfBiKtYoE3;nLHM|?FY8{?xh*$(3D39C5{74onW7}woojr?e z{*a?Pj_l?)fE1d>vyUHi28woig35BclX7b7ttxJmgt}<&ulACyYwMVEEAcSr2X~){ zr2bxOxZ4u`rp%VjnLDQJjM*Xm!JF5CaEla7xnKHQ>o zLcdl06@B~VKSc9~dr!J0v=q805;Wa<=c`MEBJUJSY>dgYaBh!`u?2ru&|EhzPlfW0 z9}Tlw^gBPS;d6XRiu`zW@4a(DsgP;DU1fIs*NG82O!L*Ga^=&r?9=7r!<*k%u8d{| zr#e5n=9sJIf~QsFnlY%js@4Mn>{(KTz?_wGk>QWoy9bVY14HFc5_LkA&oWZNz&IiX zny{i5N#zfNcN`692v|gkY$4{pjHzE78b6|KSTZS7;bTC>kkN@pSP+99Md|gCmews7 z!k_efwG{gBc(%+ija8%5W`y?@$%VcYN1!r`LFe1y;ft40nnzebENGnGfB+FaA+o;1 zyRx(#r`|H2O|czuW$WxQlnt3py#>9^@lxE-K5aJ5!{9d8+a4o@XS3<|<8Jc|FQwil z&T`uJZ?SLAQc?ey&16E4L-}w7V<13)ilv=+bun!n@?KeC6z5YC(?`_r59N#bXU;C@8BK%rqluBm zGD2~KZ~zm-EDlXRt4`PXbwfL`!NN?Q7D>`mD9WKo(9%$sa7Ke#6su<0ck6L^C(wUs zpRbi@ZSCkjV7E+2%5f|{SttJJ8k!1Ls#Am27sb^)c@#$Hqd$G;s=w;sTN{iehkByU z!l+8qXK3SmU&Gt_-?L9nQ|i3u#?<3FXS*UhLtKJa?3$of$(T+LCmR>*`(j;HDZzF2 zft>2^m*4fr*fd7uHRbM^JdUp1324y#LjJ&XQ2mlAG5m_mmzzSVy%T&5&%ln{i<2n= z-DUUM35Q<@I(N(GzS2GUWqMd;q}kSfy}r}%p$zPHNz?nr<}Sg2D`GkoS0_F7QA`Gx z(NR(#$~|3Kqyw(7wqjSLd@GCoY9Xl2D&`+!H)&>qlY$!h7!L$h`#u;pULkJ4j#Lc# zRa(9VA0#pz2C$1A_{!<8nOdJrF4jvl+z;=2?Op)pDZ+o2@j zy9N;69)cj>GC}7ISH-nvEV$vPh^pGAE0^@QI6IzGJjj2z7@_ffr#Tf&S#W(jr!2wh*|1Nl5`hgI16$<90v}KU2EyHjbSp z`jY5ZKWZ!J1D)w;YQY^MGSO3?v3V~mA4Y`H2@61+?TndF8+cLa2Vx{ixR@Xs%3cU? zBRONJc_}zUJ;9V^1Se37tpmacahKj$n$sa;X=jR{ zcU0X_3Bp%f2|~Lm6lQ&*({LPnC4!AaeESL%f;*cri;h5}Xx}Tl3UCOF9qEIL(Btd@ z8w62QMPos*ZLGbYD;XsI5ll~6^xQ@oeG`iXM}(4OfFt)<(iXIcFxZ=#>DK~)el z$h9$j_x0?K7~7iFa9h(VW&leF0cA#7npW|~K~gFHG}JP`$G z_*pNm74s#n@Aos;vmUG`(LZ+N<}*?L{E<}&yk;(5;5kP$Tae~`TWteK5_()5j#4+g z*o0{VzujYhW^r#6p?|3uiy8Rs)mCXbwfE{9!t`Qv(j3-egH>=R{`gHKiB{EaT;2kJ zEfuevP+bP`!cX8xwQY6?DX1&f;{LrW!UzxxNghDa#Ii)gjIl8=yA7)U{uDblVF8(c z$4KZD*_yjsHtDUr$Dbf>VXAUAEZry?h*}Zk2PYZP7_WWl{Xj2x4FKaBfl$yz%=KD; z^iH$-u>4+{P&min_rK2Oth~ick$5sZX=6CO&qUZzZIIK95EmUW2>W6HMxj8$YH?22 z@{DgHjQsF&#$cMWXSM*K0-^9U!Ar~#WDIkxgm$cRJUlE$+7l3B256326~$vP^{akJyi}Ut;5i>Sh&p*So$a~W<2&`c)ThREN86DCd|RUlEici6Dx^V z2VtR%(r|rajdD2r{~nWr04;Fp|7T1t=`h|}F&sk{^k&Z4SsVWU!M2NEyOVbI%_&P# zlK&YCF^*JTsOE0Oazuq_e2gL^IO3}_#*2Ijt>DRyhWR?-8~*~|Nz94*@_Oh<28h>K zs{%t{OXB7wkp$^g&=H{QX`l;?ckoVF@g%ig+@TNHG9yj#0pi-L6L3;im1ZC?6L)=2 zMl}ibdS!cO-XSmie8=rv+y`gQWa_`3YNg0hm!QW?EpMc8&^U@V8B+YpkU^5vHX8V%c>N29&IYP#~wIhiFYQo=W zAPnRH2Gl0m*7#ImoV~+(}L&+3JE}Go~p! zaAz_R%#r(UObX)9s0^N|Rh(O4(P^eAXZoq&k$z zJg?N@BvUP}&_Ab4vorwVY4!KSr^c$Yk{XbOONsR}M$SQjYj7!&0(d1LS&Cc;PUIkJ z#Ex^jZdcfcd~{Hl)P24rV8jn+e_+C&OU3lcV#&dEQnzKqzfKcS<+;QWB&~eyabP7= zB1bjc5)353OAsV5PvC@v5Ax{Mtn@6CF_+gD+*-{~5CB0zTLoEZ=m}ZECCeNEMqH^R zt$DG66-Z|DeWG9@ir1s-r^ z1q_`S_dg!+)5g6u*u9}D+M-)q(SFG{(yYf(T5UZWZe)DS#fUI8 z%h$o|5-k^`84I49N|23;GPG(_qfEIJa>RiRTE@$<47kM_#Skj0WB||Jp^O(c@IqL* zjKHwFpy0Oc_#%o4h`yC7KaMe|D`{NZ0??q|7JJ|U;E}&i8PudV5}|4_n$>y$owy!Y zeu}4{`h-d`=2BYWD|#(10B>+1WWrJ(E5Vng%jS2?U!%zjsBPettig=p1mfyP6|ioP zH@&Q#kpa;!4jc55Ipl}}c_uMA0?uHhXN&;fand6Sq?xyMSWHj=YMvr~r)n0Dr1D3| zvXDSdNhB`mV=^_}Mxvq|Ay(LI5dN|QD=80PVQyH&^%YRwBV$v$j|Ey5JR5Lw7(Wn} zn8&zri7};cQx_PHX1)+$zV8PB&-FT!cw7Nm<6&{>%~%%`ML`-nEHnX?WQ_jE?@CFr z+s!61S!0XHa2N!Ig_#7o($Qh@q6%<;ZkxoAjT+&E5eplPptQryv0}nFC_qG8Rs%FN z*v6y=Rxc)F0L#2&ucl!g40a2P6S!U*Cqg^KTuO-5Js>ez10*m_Jy@7;kb>66i-c%{ z1g|q94TN11$s2Kctj<){L6z{kvs9)=*J2DFgHb#H!1CPA1|Ck4hFu~rO(E*w=YaVxl7y!@E9*5fVlF*$pZB7!-h3u!p1>X&6hS53$of<+~ zW|q-IUb&%qH?C#@kQiZ83!{6RV~+5<-51f(BDeMEO)F>dU>|9+V7H}&QM~J#rtwP@ zC0K8B7u}K{U=t^;Pl9^N=kQZ*qt|eC9ZIMYd>;&CTb2tmIL8bne4=|fyE6$zqfOf` zw*#1AGtZf_Bs)F*sy|~ABTb!;E(E08lNk)(oH6u3agwIjiNF+qmuITe0pp`7$Z^0} zrn`48-FW5StL&cF=lpz~pl?vTpghJ4YxuFP-qZlk(&OGmF$7us^G`(>kir>V9GMzB zCiBm(HEoTW?Y}~V zU8iM@QG`cRm6x!oPy79RX$T;9(ZvOj5=w=C(Atns_MR1X<^&okRY^>q1UEuCRNOAH zUe5^Y5Zwd9yJ-*U@5{EIR6%Vr8xLb zq*0(T7BseW*&M={rOvTa8rip{Yb+1!8c?ZDjE;hs2;LfA;&L1JM$GbQjVqKS%n+Uc zcW6uuXvMYZU)p2+J67weH27fMS(Cc*(56z7mT zjVLu%sBz)7mb6v_g6P4-7zif1%bcLu^$Zztd_gn#AcE7=5Qxt+sUJctG?qZH5X&t} z7ek3TL)9a(mF<&9lof$OlNO^$E;?F0uh(fgUy3m$$=&i0ihAd%=wfREV0Qedq%A?K zmpsdMeHEi&fHO5?7GfR;zD9t5B=8p7fPGwPkRmKU<24iq@0y@lo+j|vD1@c5#rn7M zBQYS2>-UB`ppX1$vpkd;2f^jDkQ+k4MC}bUL5UFno}yX!YPd8j5L=^NGqNR{$ z)JH`ngFyBpQLhUuHHJ(HWC0r4t;|p&Fjx6dPkBzUr-$lsNMmRX8e&fFzaL*Pg7I#fnEifx!Rn5u{QLl*B25nuX4A0Y&U zhzKb%COZfNFl!O&k9>;J9)bDPSOe6sT3Q{Nr6G?&8t$orb^+AWFqqiXJF%KBwyJKD z%9b{l@u|);xYgTsLn_QS03gUxQ2B_9DFLQYd*h|2B$Nc`W$8xuF#ij?3qJC`n2*;H z^dgh}yk$|0&c{%zXe176inWIB-@fGIDSTJ~D5F^>*bwe@>OiafMs0#-#SNre_|hm- zygxvro|e;Uvm+8J^OHed4P@vC>pheDB+OEitJEY+Ihh8O&rO{5lr%j^ z6dNYhR&gCETj4q*@Hr+0KePPVk~27%#(H^(>=^QmOz3q3(h?q5s%j# zygkfVM4karfixCEGhPaEbPr{iy1-k#;8jrggHh47k!&_KkPY}cZx3^^ng>=iI_f%s zTHOY0c`bsdvjYlIRtr%bk2bX8kS4h4RhV-Z1@a-X4F%<|5Up%cjKzjvAF>|JHF4nQ zTWXu3yLhFXMv*X8&JZCCusy5w?4{^e6vBSv3gtUWcg}EetR7Cvz0AZ|iZ#3p!9GyS zn-l=9Ba$9?UFREOvPWq|#v;uMyup@PcON|59J|*oz>+bROnbe+=Y+xZ6lcXKLeFN_ zv{d#4o|>RSeG^7K(|c#IsxVER*$G|1C|UHiT|>=I=RkpKb2=~)R7z{u}!8TZw2gP{tH;&4db2K(kN_ z!faeU(?`lAtwqkO)La&eaw&$~pEUHAz|sa=Halb0Ca{Di*3{9#2|zcRwf4xIxO>%F zf`v|!g%e!-E(U=6$&wS1FiRkbgKIKNOq4B>5yWt*v%+`3qA%1N4MfcNs}}_tE#plH zB&MYq5Jf{nT5yqBPSFGv%677O+f^D}f?DC?lHY5l-VkoY1N1YBQ39w7bhCkCk>=H+ zDYfczBEX2YhidRnoibdy(@MsBy#4KLInPcL>JG}z+uIXt*{@mOxf)0`c!#6%m=s;w z0HD|)vNO%#cb^>*s&PrwYkU#Kpb>=hY{3JxWDHWK@97^u9wv;8{V!5oP9%bC`LoZT@a|9i?N!5S0iDHi4>U~0H3aMh}bWXn`Bb{1PZof^(BDkSZI)z zfCC9pM9Fw>Tv4;H>=y+&li;OTxIGCp(GWE*4gh`31)PkmUJwEX>2C>Y$ZJK^fMiMV zsv{~C28cyp{pJ;d>ArfOy!G(b29=9AuwU4w)(g+$pej9r|NIF`EGiMJ9XT48+79*h;{h6Jj68(!~SkpG8e zzd>P&m+D&sa12$cCBl>lT#D~_&zX&U2nj+Xs_<}Q1z1Kn2yp}}!y*zy!3zj`AvC;< zK>g3U+kUCckf}frGZ28!@vj12h_GHEf$z@1tB>Fb*CFG1fj9GfC=ZVY3s?~lxf>x& zGulY|yvRQc*jkYN2Gu>Z{Zr={+fGC#hFWdISH_+GN*eS55grA=F1f?WD7sKJSaB=D zmW&4)U@dulBK%y8(ZIEml9rAxDiIboEkan$pLV_IC)MAf!klcJGmYdK>Qga*mPkD> z_B8EAWe`D|CMrPY>`+}| z)n_=V6Op7AmH_B6aO0t&BxE+@RVeI8A4Y&)rZV)wOo})wIy{G7V=n<*zUNpgqLmBob_=nNNFD|P_t}2= zQGMoN<0epP*G(wQs4K3FHCobli6q<%ur<>S)5l=`)p7@ zRb;l)PL&UQA1Sn2M^ZJcq|5T7_C>=(T3Y7+`kEasNB^br#~`TGnOppj5LuQTKV+L_ z<#SYq_9d~0B&r7}ggHmixig~8k-EfhgYlRqX@=^XE6oF5xno7PLkE&xwvMMGL{T$SsY5Ev>b!iQ|vSlWHyy4wEqiFA z0U}M3Eiq2G^Eh#!{}zH9=m3baKWv4lY~RM@5978YOa5;$dE5^6rsV&`JBHW3!0PsE?{#bfc1zoi}H z;X2227-qWEufn%XR=YE4n^kD$5nl}s_e@OpsGPf;zU+6h?Q*s388_~;nC{C{@6Q)-++7|r< zrb6)EJ9Wr8(dyk7ehpKh+C(~Xll+AL%RKHqr2gwf^=q8+Ae(Y${P)js$}=YzZSODb zz+=LDCr!)0$bKGgQT`5`qBl1_lX8UpMN;holru-WsV$p!9v-iy9JNnfUL zhxh0s!^9P&FGB8^lnF&3j|1J2gw@>Ofry>yEozY33YZT?2X2C}WkYBY<;M4DUBAMc z0uGtXu96- z&a5nRbw0r*6Uj+^%|$S{q4z|@zQ>Mhy>eJkk@B*z%;Z7+1Hg-8(Nq)PO&ba+G=u4* z%195dlMK4_68o!77_HhBB-fRFZM&b_c^DUWdXJ*1x#$fFn>=RTw+}=}>{)|OazV7o zMjV=NVSdGs|LFP2c1=nw+cS(kIf=o-`M zRoYrM?hdQ}*YWT}7Ta6j4>wp6bLP=Il0GZTL(&G;%WY2h=k2~DcOE+7vxt2~-kltU z?9SYgabN>Y_UXce|0>N-&GyL)Kr}eeCWGu#B&M1+wDB1{5x)<<55IK0iM#&S&blXt z1QEXzV-BhFu99;~BTIhfgY)Jq`Wwd4q(*k!O3dVnk}zV71gF1$MyAc(tVXJ@A)$Gd z*+(=a4r>+F+J&d~^~Z>ROoXsTD6Jxhx#eqUh47l$kxaHyesGKOg8B%YC=+*r zRc-6Lt1r^I(V{Qb3z1~9$8)!iiazD2mT`_bCM=Z6C?#TYZ~B`1MbuwH(pb55R7+hZ zsg{>ncz~pO)HU;~@G`hH)^6iG@0lH%JuS2JTX8%hvcR;2%pKr5<;LVl8s$oRcp~;ez zxqajy;b4FnBomBadO(Q(&0X_o2V4_^2A8jOM68c4Ow$*il;l-2dthUe zSrTut|MpEzl5;#^nr3s{vB~nNlS_T=Q>bT!S=Ih#}%mNouFfe}y6gPDkwLbtcpvo5FI-3lf)uxI$%NEfu8V4yrmu zG8F)1?@eRlEx4&uWuE6XVGVJy&!APkUpT6j@n`x4Nt8`nS}76hB741JaC%s^e&Caf zvyngtG6_5i0~QB+h(!Y3yAqMe%0HSd+jP`yMqPd6o>FTG8Cfi{*FUGKKZZBXs6KZr zk6k$4YHS@35ibt-W(_@o^>_GQP>PIQ5Ggm&m#=}cIl!lBCszIMdUHTpOrXUTdKy3q zad;Cb4MQ?e(qxb#P?GVAAWm^PB51=Z4VD4jdpEb|_vUB15F;5Psofms2A z+|UGSBuVl*;}~^hDWpgZ%PfZ|6rToB8zMl}g(eC77prtqx6Gc&6=JGvjy##gO1^UN zy`*N!{Cf?_5+&G%sD==s*PxYug%=(FIBvt)5hBrhRi9A2kjIjsP3^d^O-?>;40l#n zB<7kR7C{JhpDSXL!yuS+&=l1j{ttJdsEqiEY$b8LEh&8tO!ys+<0^7UKx%~qBo4A7 z*8P4Dot>wwwepg6Y1JF*^L9pQn0?la-!|JcBWxuxg~_`z{Yrw$nWWri5K$((Txts1 zab;x7r`K*4L}hKwh;bF@>q^pOiQgRrBIT+?1rdb8R|Hk0z`_l;pp#*Ml_98cr>%s3j<2*6Vcg z-2t?+fm3s``H#@!u1m%O<%{|MSoxpRqN#3L_p=zsaPOtxPGkgU6R=XHT=d^DqDYf1 zXMErFP&^Gp?$<}h(8-Z3@mw{-N2-(c_YU#nKEoX%>&~b1mZxu`=yLt#z!XVA=e+EVxb@0)IY@`W} z7#uk$)FYnC(X`6o0tIufBqoXz3tT|B8PM8tSeublPLooD>_n9#kN`5b)P?{N2{xC* zB26%oD+!860E`AQC8;>jr7|nYx-C?*SI*v+mqv@}W61Agtmvy-Nn;x9W0~$_v`c0^ z?PDKRO#}Klxcm3^`ZzUiA5uAl?`73PLMk*=y;t(G8@t`8kETqKy5~7WCJk6 zFnZ#I;$9Fn7^oae1k`|T)SL*2B9r2=AbuP~ZJYqqlnCWVYwMtCMpEMW!3-uCaV%gB zL-EuAB667jF^j`clLOCK_c`bdloQldQJ?BivT%${5^>)5b#cCJVTZ=sz4fE;10&bub}4Dpo(6kpb=uq+mBuj7#9$$ zyAM{bd%p2N<;i_zDam&}Zc2t>iUmJ3h%X2KV~MS}wT zu$pUihHM^q(yv}#_ng^_;DZ`g>>@$E;<=ZF zN|Idn2DQ@7jw=QIsFv%L$bMc<00bA<*8Rj>-jsW|M`Ad{R1+qyg27={KNZ}s;1*WG z@&;*uMhIwODCq`lJTQ{DLTo69{@6r7gJ+`ONi?+q!qDi*`)Cn7lXt}k4f(qUZ}r)6yeAOu8%1Ouv^AG>eq(?rum|08dz>GFer$K zeq6WYY8dqnlZeH9Xh{T_AoaWe+pZKU8v>BH2Hhh)3=%xcsoFB7mz7SP?Z=)|k@@pm z&k+}Si-vCNpb{a}AT$z93QHh0LDzlIrwn?h#Q>rRA~3E=Ph=pZL`n;;@cN=qC2;hO z;sr5n4L~!FnrtSxb1P{m1e~Wa)GGk#5jqitmOw&p0cjK?(nZY%gWvQ5_Vt46yT5Sj z9>evQXg_c1ei%d&KG1;1jT64lp|sZ-OByHA>K|abNO8;_OSDP89>u1$m3`Xp85%cO zUme{%GBAc1?$nHlavE-rgURH;51R>KlcXR`POxDSfngCODTDC$d!pjhW7_oJ8r?ec zkOGb*pN}SWi`RVXzGmG z{Gq^P;D3`j+*6?j=D%YmrH9}QtR_DP4fe3+1@e1vwe>h>iXOH4opwUyIT2mDwTw0r!A(JPuRL5ksHi*fFPcfa8Gj94ea z|4b!i>nj&n1eZ>SH%|}Zr>SP9NpfdcDrXM=o00xJqyN=1_=n}&;29H*sXVE%b;((+ ze@44|<3|>g@;qY-B2N{UtbFWKU4KuywdcEc=X?Bq?D%TJX{pRvdfJ86+E;omYkJmN z#9YDN(uTq?upr0Q5*m^;`RMa#bdpu?IiZZMn9)3XfP&*?KFXP%)wV5e~X+-%I6u> zd6i`O1?Cx=V|B{6vv}!M&Nc(3HP-*+dko;LUHkoiX zg^na!d8YcGk=)P&qM2_m+#kF!wCy>tc`IW5AJ61q@l36|-N@$`^~&>aisxQcF4ibd zl`TD}P5Ra{v$*SI+Z|?`X)seNZ9hct=^f8E8-KfBd5Z}Y_VcXvU&FuMcq`j~GhAx@ zx7bFp;IFaxZ3y?(a&h5cZq>bK?bWySB-`cK2j30nmk%D?7PH4)Fn#-tpk+X%Mf${tkgUB zbwAjg`ES2_`C#dO!*2)5o_wxsFqj3fbi#6ZK<~gfczZwyXyQ#{;p%LS^KO@OzUud_ z_U|;Go!FP15CIf^BN*kabptFBs0$>Hgc9K};#zAMr$mbEPa<83ie4Z%DkYJG5W=6J zCz>D`lx#4&VYsznbhcqkv}vM3WDDIili4)aayN-fvhdindgyLAoAe-Z^L~}PW#i_9 z_wEla2<^5u?>lTd5N%mx651I}o604)YHiWln6hJa;+*Kzt*|OJ08SU{g+*yKJtytL z`1fEQ*w_>Be2__<6o8=SS%sYn2ykO)Bd=z%DDKm!Np>tJsjMoN$-C`+65VXyVgNY|f_*DwEV zcWHXgSl&(s(NI_d<-8KJlL!k61-1d8sB&5)a2r4s>_CWC0Lns?;;2{9vM1f1r*MZ$ z&g}BlKZoFnB-8A%m?MkyAYyY9!uNlEJfqlt!m~8W`eS2t`Si1k5|QJ;KaYA!pKRRs zlj3z&5#MPc@8bI1!FjLwot>v6&JIh?89S@_|D3a+YdW7j?Yn&_zU=<8_thZSIi%aE zC~;^$`-aEv%@+DTt?~8f-b)|ZYyP~D5cmCv)whe%Pm#?p&u( zHu4jZad_|WZNg!>lyawa&qw~+rzc?P!H<#mXOD;D(nkVPKN!t@e2@LqvC_Sa?cwd{ ze7L{v5IEOkF;BnU<}ulSoi-Exvm5>M=t&?eum1$)A;{WyS7o@vqsRM4!A`V2f1};M zS%p0A&C|=Fm&V z5NgMOWtjz|2s;I*V+TULX7>3||!aeZKq~eGtxhhvb*&{nP7j3IYE7j>jLC!mQXI(!__0Wrf}Uelm3! zy!7g!R^V^pv9tT%&qQS-*j_#iatsgdeQ0eRVDtUweo2_^>(i$9{u?vfT6cD}Umt}M zA4dFq<8uDfwR+y|CcJ_2Z1PFO>h;;@fQTEWxwA0c$UcWi)9rISS0t1yBGouz;4I=+ zrsNzL=@Nf2eHgh{9GNY49?)s4o8_-JhrQmqz*_&wIzNqc{1cTD<@EGVIxb35@*+n% zSgxgVAl5%pv)s)*`00sDDR>?JzuGWO-)xYw8Qy^q2I|L!b3TI-3%Yh5r82Z?%K z7Drr!r(DEj1;1mDZk4%u#2%Gw9h2u7li&I0b#IJc{NLWJzgJ%(JC-9$*{^0qud?r5 zeH^}cH+O+Q-ochx&;Na) zitcBN?c|HvVvn3pxm@PE+OAGZBR+Wi^zR5?>~3fDo_6g1%b=O+t8ZD?ixHQTR5drE zAq!O3YwU5ocdm!N$3Bd>(qNCDW0(3x3 zbVg>MeeBW8!SpXmxx#;7Zhe+aq-9b+LROT0#XQY6yzX)vrfdyv?$?f2jU~u=+mid_ zBgV@~AGom8p8im+x((4;NN1c!>s9g|wULHb&z9K5J_^4tCH%SBtI{Ye?M&c79pr0| zbYXj=emmnQLBhv#6%Nm1^h^Hf-#xOtc}um#bjTR7x!4!^Q|1sGS+;?T6Y_nxe>Zfv zzewVdRoy(t`ozmuAL&S$MBHa+^%Y}^LtFi@ZMqBZ`4u_`mQ;e_oxQ5qAFU4shr>`#4A! zH&=I{MM$@ZGgNJ!76$=sykxAQVk&drgf73da9{oLNdAkS}eX|+hEBf}w!ioOdgWONA{yX+z)_;4> zG5vw*&+eyWBnyHwo0EC^(KwYk^k|5Zz`qIlV)sMUkLn_y&Dxj>QOt&#K!ELLY7JX~ zIz2czVE|7wflmUGz3^GUO(Wt+Z$SHPs%PrY4?i|)OwTHU2U&i3GjLHO&{)W0Xc(Fs z{D+zt2t4J0!P7K22??s8L0QCRZs-9j4NA9)xpGyz=0R)I#gZZY)Ju`FU5tPzkNR6f7q4Px<84tfYu8wwmkv}%*7~`CXk$Ch`dDP*H zOvL3yzJGk%!=20S*eEsZi$^nSUvtu$wLSl1lQ%tk;t*wCQ(Y4E;)Ub&qrBcJm8p&N zb)%f&z>Rj9(cOUw!T$(7enm`x*ZB5OH$Y+P`oNYr8Mnj+~hm|E}l zvqMj!{iQka{H~9YKjjW3Z}}>+J;fv@nE3m}5u(_>S}$0V@ef3h%1#$C6AzmB*~+<~ zmpomgSRx7h8#r*TcjsT=Bkl@kdpmyMN?A94f8DY6ig<`AH_$cNl#^C>LxYfWLP4Ww zEvRn3RmjCS=>f#$jBNhokf~vNa%up@%aQmg!ASMlb)6DVsbg zJF%II_}EKrStlnUwqc3Aon}OysYMVIX2>&@f~Q-S$c5kM(p)GUkX6gg3T;C;h<>0~ zU#s9rwD?ZMOfYb>IC3OVc8UND(du?IFlo1aXR!T;I~pI&azflT?y!=mN|+r!RWxwd z5skwC?#?X`bmoz1t^MpD()yyHEm?Lz;7f4kFS89LK83M2d0{QB#owf=71w_lJsxQ- z*~e5X|6(-qoTd%^%AG5f$oSdW<=68|C4L^ z^o6{aC#QTepgM*s=r67&3zyt<`S<+1=Gae4WdfzCAGs;vh1{=dc^^-!ne@0lX{mL0 zREr!H?}w)cKI4{>6d2V@ma10SaN|_=u70w0Tp5=xVCbng^@2^e7F4`t{w77M;Zbmw zRyet2#`fsq@r`(}lX|UbOdS)BZS#r5D39}6m)SFwsdT>0TKx?LrngK(jctQMx(}n~ z9O$cG1uXrz&QCRH)q7H7tt^E2;e~Wz(rPN=Xz;+iwf^*krZsn3_)_lgoiQt-HWi6| zW9mKXA+{&YSHTTFeC3lKE%_~?l`f`2(H7GlVx7zjuWY0DkS%4>UA>=u9QQ8fMpQZ* zK1qu_p0w?4=cMYKiY*J8nIGAeId570++Zd9*Ix8)r;3F=w|8o__3}xYgpRoMN zJGAiO%mvbPLv{Sq3DiKn@P4*~^<->nIC>qlCx?P1<1nUtuCwY`cK3<-D}1##AK>S((cu-r8iyliayMV z*dw3A!I{KTGQZ?U+qv7HbPcHVI97yTs!Q{|8T3#7`C>SIw;l4_BQcJn2zb^ET+Jp84#h%Dwi zulDb;(nmKxP0TagWLp)w4LoGRKO8J`zEYRHzx>rcC?6UnXRC*=EH`F+p!)KY znB9JEYc`D?nN0;c0zrr*QUEPfD0)MkApRn1Q1fcmBYNYjS89iDa`$%^bI5YqlTKA9 z16rQ0G!6ikrP>ydt)YR}W$)@|a+%r7r%?*m9h2yPmKi8~@1LODQ9lx%otn7QjZlj0 zN8SYCFx&=6l2l1e0vzHIKZ6=`)jj21^VgR%tv$aRvyw&a#QuJr>N$JWnRF2P`tQ=q zYlh(!<)g&-=vCU@i|!z;<28! z3=-6jsLNJ*U<3k*HGL<`4I{ zlw`nxMV)}VI0BUw38w)9BOI6%L3kGjFgS@RtxO9*?l}=alMyloOEkg>7a)`f%2Blf zM2f&bkNQ@IEE{HK8wf2|Q=irqFM3O}S+IbKVNjMf9FVRi1k>20fRG5MAs26k1tJ~E z%@)WzY$#@D+G_3EKhL&*uJlVIlCU4JSWFxXWEBZxK$Y(+5^6TA?oK&O> zl5Eyeq(f2*w$dTCvde?Q@8@N<=0tkzMSEu1Cvlb}F8@(;ikG|)e|S?iVP7t>`$8veC%3 zSF5qlXkOCjVr}kQsvT!0OJz|_D^o=?s;uGEb`k0_(XErKMY%KX;}LVS?6ll*e=+V>CnGj|0q4%LQ+xuwakK(M_RB_&Y?oU!woZ` z$y+>Zov|=q`ArR7rhnJnx`GAqgb^7~;7nv;o?xj*$>m7OD|C6oBL}Y1?AdT4b$90E z)sHk3qK2Ec-0_a9Qn}>1_kKg=ONIHumQKNtPUOLO`e+cwyHlo>@DrAVYP~Gb$Au6mV335Ghak*p7xNr{}rvZH?Pn0>5#Z>Ipyj{ z9eEKQ)v}uKn5wDhFWWNy)v>wev0HpHN!5xOo;n5FRIF7|q8_H46|RS0eNQ<3KUVoO zd3xw#1nDMy4u@?gH6Az&J$O%Pd{SyGSRUw7;Z5(M%dv%_;pbzl@lE!!FxYgn;-PnN zw|1)(X!Niy_Hs#Mbz}7k>Zm}s)YSfVHM{1zL*&+dz$5kO#={5AtC?11DflCF+$-8{ z$H0x>!p}>4kf-T$rFy=*PKi6|=4Ou3bG9>gKgu6|{pAMN%+6a>7Boyo&nu0V3)8Q+ zjA{5}GQIG}ytN!&A0z}U6};2cew6IgzBsAnyR6Ncv@Ooe%)aKyK|e1Hs8Xg`N9%Fn zdTMY)Hsub+FUmN}8Y{}!HlL~aJYW7%L+_b0`OG0#!211%Et+caQfy7`X+aIwf66{+WOY& zct14pHtwslA+4rR6RNHA_HU^zMf=o0s?f6eVeV9`<#i*_7VQ0g+TD10)8BBH`*0_1 zt+x1@AK%aYR-xwY?ygCPkZa?QmtfyKQs2a~ABl}V;+eJoc|hI?CcX23be9x&3u2yT z3PqR-E8Fh(SNRTr`364vd|Rzg+1-0w>egH5_L|b~@m=2@g}t;ley{q4D~{{a&Z<85 zSA8rK{*=i*R<};Cx7%SVB>Q}C$bt2hpg*F_CyR)uU!h{Eto#}MtG?VluS=hNy?Xfo z5e+qwj;)4{L%-@Lg`GykT|`g1KJv_8I)A(N>C@ZqW2%>YE}~r~@};NY%U#>at&K^+ z2UCK=S&jQ|RJO+NdM!WS9lZN0$7~llE8IvVTz>nDIyW92Y@V||72lWL<`e?9Xc}hj zHrAO1*x#ybB9ROX8r&NIF$#b;r6?*T5T)Z;$p?Ab@Pr$v$iY{-Zu_Qw!pw%RR;@&^ zDu?rpzQ&M#!pMHUNPE>$RhA+(zCz?uLLW&}KbIVm`MEk_O@as_VT?LZm*KT3B9LF; zbzoJmgg5l{$C*GKk96mqd2)PTNJ__i3}y|l}@O>Z}- zcetF}VC9A4ghIHyV5)EsH54UB4hTUZ%p)kkD}jm}Ld@L{eriuJw@1*rzT~nCq21fy zY&5+EU+;@k#TNs@$ObnxFk+Bh2T9#=0|rUN6InOzF^U6CH7dbMkbrbUO+b-cHh5L; zeuxF941lC2MKa@2fSc+ZRD+mB&CU)frgTE|R`5Yj)A0Kvqc2A-vquB;^@NT|WHqW^ z-k?;)`yrTOqy>_Q3`P45L;}S~A^?H5Anm3=ldhi{VGY)Cerg!urA*gD8loHN#?4EbZYsluCzSZ zZGq4QTwU(JlP0y<0oxJ`=Q@{yDtKHi3{WT{4b<+JGjSn^! zf(UOyKG+7RhKj5x_~F$2^dFz1Yc%`V`Yf)qC1_S-O$pNQo>g`Q^fejx6=M@4=pEIfvEbM5x z8!EQzzmUGK5N4|$wir%lGbZe5B_!wQyK=U_!t}yIZ0MWK(1UFs8?iI>@e`}l`)?)# z%|n0BX)(OisgYH-Wz0h^YO$e2V9F{I}`Mm{>d^C1uK88Wjb^(I~^gNL|3|%`8 zoi%Z?6u%<;Ue-nIb?SP_Y1mxQM6JgNbvbRwtbT6yijem94T<+1jH!=IP$W+Yy-2c_ zbwz1B7PAX!yrBtplX`!6R&Xf`QNM`OkF;0EWSw8Aj>;y}Vlv4vS+66#Tp80^a(TKt zQ(Q%{DZkPk&(H;O8P;!}+`}Y1cw^!ACZucV-cDkXq-%iLPR>9Vxx$4T@k71uKF@y2 zsl9uH>KuHseh^9f$Yd+ZZC^gou{}NT{CRof^KyAj?ze@VQL5Z;B`>;czSmfD@L3;3 zJv#A}(PgjO+pf#Xi|KeId%)MQ&ezbJC+pm$xvIc1l&BJxr~TuRLc(;-aITc$&SBA` zS2qOFywU0sin85rTU&D*Iu%}ND{>hAC;L@i5u_*!`Y*o4{2$FoyqW=}m`WO{?oY2?{yiJgzNq}K ztS?ky^pmVA{}uA+k=n|m;X5q%yw6KB|Gd%ed}gjtH5X}`b&(nU?!}AhinZxj*|QIn z%J1vn<^76z&-bj#^G|;Kq_09rfQ-S5>cK!Hd73)bmxU z>p8LZRkG`sc{j26Zx=2+Z@0Gx3m#)0yZUebimtr(W}HvObUQXaCFWa%g3AlrSnGhr z=wFKjv2VGqF+x3G&-wclRfb!?e#ug~e4p2u=vC7|j%eAHy#vwvnmaDRmXC65i(7oYwT=w&MC9 zYjy1%=n!-_ywtL`DZ7yWvgTyykz6rc|@%nmLJUrB4!Q zT0|~UCy+gPwH~q}&b(Ox@RA5{s$(IP((NbPHjCN4mvOOw&yTm~dSAxJ-`s%6P4FNR;c+|xwSh?= zA*0`TA2CO|Nk54|!+1Ygr_Y|$E0<<2STJS(7PZ1Pwi5AxNtN(!98-=f9Ag4<%hVyA zte{kVa-$1vPsAm9=gTv!ZsQzjauTz>h}O1gRd(hfEsm#0T-u4F&jvGpP>_>>oN zDkwyDH7IppEt@cTN{}fkx~@Jm|Gk&0@e3G7?Ld|_X^3`?99u#PpBOdRoJL+swT4c0 z!-@N4f{Ayl!o8clWBrf0yWC(72mU^$#960OC<~L08;*s>2}w4B0YIrFXL3*oTiOaf zIU1tVpNMcNT%l#-VQrYpxxxae)F?SG62{D+Qm{D$H$;F)#yO=9*wms@nB`Du2&4%E zI)$i(>lP0iv~w~?4ze7fAocTK!?F9waS~D<*%1K@wp>(V#+*B83lO&t)10c{bu)uRdP}n+q_r`3-=Oumm5NSRtuWuLh|-avsehj2rHq2 zEDODB^NRyzTqFs1S%5tDyLM@qSLX+GK38o`ip%&;G{yjRR z=0NR1#f{K`)dj(n2ayEExS6|xL5Xmr6AT?p1lUTzl%<9d)z}0Q8>cdJ7(gUvk^q&_ zx%2*%ij(SCZI7r7{euBRE>VLzCT$^V1z{61)^C;!0zd#Q34+Q>YUD25l$Z)rieQBs z&@4*BwpcZ2lfBeBU|#5k%`e{OcDkIRNEkoMD&mz1hDp!~iq>#}DeI_yU+brWz|&IU za#%TdGcj$~CnnA#41gQypbz1(hrS_TCKSh5-W8;F6~_S=pf*_zlvSiW5nv~gts>ll z_+o-#MII4?V!(hauuTC(L%C9FIvD2Tq~6S)|w_F{UO;_NJ(8 zQy88pVjQ5!MxjOZ^5RKV8P#sEI@wH4!W^BFSZSb1;~hUr->2}t8e1O#It2q7v?vDN zx-oAvBA39X&qyWQC(J&s61)QepNzchkO+{l&H-`y;&tN|!CsKnL>Hp954}od;LFE@ z5F|VUMZLj>Xi5YcR?%Gijo#^d+guWBnWQ71S?@SufW-;vL<3MZ#;4;g+`E?edCr3azz2tQo5 z(Xa&cywD8KZ?#2-8z2%EIS|drEjDHvPtF1xKxUdiKyGD3wijw-8Y|==xGLzQCR&Nl z{eBqhZ!V8{6r&#=%)!_XBFO234E4UT9U1dZ2_>cZ6F zyiJ6O8hM?$EyAhPYJ{*tRab&%iNr+xXhCcrF=gZy3kFE$*8s``qA&zqO&C(_AUzN{ zMGRs|$R=9LHp3$M*|yyDEC-2&LZofG^ zOA&ad8V^QjMndpVF_YU7W0WRy)lt&43@@z>K+rODOq7tWMp3+_p~~OvZUrSYiK+O` zQh`q?w^zd)-2&X}5Gh0N*C@WcA0Lt^3C;*CT4z1K7*=Hq$;m3(;F10F!L%f#;C0ca zNW`B{&TOI2#)`J2JO6wRE(tCES+uQu{%0(KEv%HPct=zAaw4ZBtWw`gJqm^AlbOa) z=12dq?0htAoR|SsT9umcLgHStJ#2R5-=!WW(pUyi_8G+o{_*3HE%pOO@+$}jN5To>I5=VjFjhqyp zE4dj>k%Hf?{Hl~ywv}-s0ory?UqvYQvFB2;cmaj4JO3SY|I6aGK>;ZIzn=*|v!`G# zl)h9w31IO5Cy6K&KYyux{QdtyB3d-#w$&`4ItNgkD?FnwC>c3SE%G>x&_~%$KfEO> zIJq;h*LJrgBJv;L9+-9mQbBn}GY29Sf2+j4|Rw%_d1R6tXOWZIw7|6IceR>)#7 z@wc;9VtrH&Ar(1*BMhSYZ1p0p6NFPWzG^z2;URCVh6%+kp1e#ZW_3*<3!m+t zo^yox$j+zm7HPx%4RYrnJ(Jr-aZ z`BUfy%LNF4`%+i$9cid(GX!HM8Tp<;;ZVkqw#ly|=%(kx{8rvAslf2Qgce(9qx=6* zmvVmS`zCY3KI8?dK>&ySMR{*>TT7A}CN!PaGle_Dhi)ROKQCow}<(@7n0+fFM=k>1QpWp!;UZ8t2pbNQk? z{N;G8KuqN3qYo#SckMJaAZ|LvL5GsI!O@jg&faST@cjr1=+O*>;BS61K^h-|L^DkT z*9FL+45^`jMSsF3pNZQDVOnUmZt}|n)vir~ngeY#ZmETD*NFtzw@v2^0+^)%CwV}< z>z5gWzFVB7>SOX1_E(et@>Gw&pO@zt4ES&8$UnyVjPtPZm#A`CeE{&BJYXb9^PwKB?IXj5yDMt^e%4tz#8hIFKz$$xmDu@;CBrkl$ z1uG(Bqq1AeBSqk7>;LM3Pn`;6q5P4SHBbW1CM;A~44f*i&){%D$9!7G`TCXzbaR0R zKB@MB!KNih8IGq^q17^Q3X^q$WrZaG%oY$fIv9u#>qcjZBNT>>Bw9WJ zfO{**7ytoozV1UqiO`(GD}6CNW`MxpPz<;h0x%$?F*ay$d1ykX;N1#s?1~Wc{0o3h zgIdQ6f##rI)OP^@DyuaBdZflLW7CzcMK#9{0U0Y4C{O~v)T9neAhNl6{ zVJJ?xYEe%R4jj~lL8t&I22oEs7z3VG;h01ijsT_qP5CP|j#kt`CuQ>k1dB~+21j^s zVy%wU?RHixeT}L+hh7s>lRz`7N)uklqY9g+)j~>=KOG;Wzvb7ZPN-3n2I1A{Bsz^_ z*T?}>pM`0HDqw*GnIZ?dIFGYrH=L;am^4`PoC-+c2m%!y4W2p^6yZ3Uvz#9wJVBCL zD6Nrhl|czM+A+pBFgdXaARu_cNIKmI&qCc&Oo2*-84_eHH^?RP;Eo`_1@)KgPj`T9 z!paQ*NWMss;YI0WQ$Z5e}HYt-cJ3zvmPwCjc%Ic(iho3CUMrbk1DF z$R=XLX;4lC4$Jc#Kyk%9Fk&~+Ti045WN1bUZOa>_c7(qR`E`j(+ zB6s@x&iHf}5Cn(jQ&6SN@yg{y6^_}b2@ur}hIG^zJQnONOHMml&q?mL%zlpr$YcB?VA}HU%<|?F^{bSy$k6sYAD!oJ87U zO427?FbHcs{=;HhL7)-KM|70%0halS?hV*qa7_hPs0XN*scW8;q6^Kq$xb=+gcwXf z+yB&2bkKtk>}6I=B<=>tYD#0eW!{yH)F^K2j_Dg57f8JO$i#v~P19&&05I~CJ0Xe@ zo`++#(Ik_)Op!(aDC%>e*f^XHjLwao#juKwa2_xGMh6smrJk)eV&qT3ffAqQChj`$ z*Ypucy#Gb@3EX*|aQcc0x`yM^F-uDdLFPM}pt7555r+BPs2F%tKb+Bw#NZ(B@&o|P znwqrU^#j}pXDI&#DeQXUF-Q)Dq5pxwJj&G@p~zjJFFi!~n5}VRwMhYlhOtQsv>pit z?wXLwkm6a9aav>WXBps8KkC?%1;jG|347$CB-m4dCb?BXGfAM_Z^}pDsuSU6|8mK= zku`)jt0_Ac&UE(NE5K&xcV?{1V~_=~4Bi=d%nx3qAme_LUy}-i&#=lEbJp)EposTb zTr@e#v0FXMx&hY^P01(q;4gk=?K985Gv9o+IiXb2~%+r!MJlZPC7X+1td8H9R=~k_* zpFjbpz?&fQTVS;wp18`Dn#4>+Ge<>^*TEPEN9RZ0z%*F#bm7+FQ2?Nc4*>9TS0+em z7$g`Lo4^Na|4n6@tq^NU-|g-R9I0!yIK-LI`dK84H3M*`DBU$$((zzcejr!VbxU0? zx|%&Jn}7|k{@;)e;KZcb^5{$&VUr7U$N}9#hUEDHaUEUFn`UL@v*_G%c>4y?>)EI@ z2~Ub~0tE%g&1bOeYV z@DqrEfF~C;Fe%8_TM2d$=}07L)*x{;j_y{Kb|2<-X@0RV(FAuO>$ zYN=E6R>0F>iOLhC8c6RkYRKzzDsmGI8B=WoHzj{B>dh_%O(-CM!W9cAg`yo13Gg8$1<35MZY&7vl84IJ@tsroQ-H^gAJq zp3s{RdX*+sDWP`+l%@iq_g)2r5L!gK3P=qINEZ|l6ftxVkW|`Uo)vE*u&d+jtNMiHRf10D&t@}S&w9y zFL3)*08yJQ17dtgg1!S$$wPoO5#;Y)>&laS4K2!4w5|k@t7;Vvw$PeNP`FPPN1o49 zd*j%+kR^v=57l$PU@JaVZ#+{i))fK7qaQUKGwI#EE0X}gF<0h{kPomXwjRjyAP@pu z$kGBmKV#IXc&y)}d~YxZ^v2)CTVoId(C-En{tsT2l*O#-f5!CKjycrBAw(;qYgiaS zrq%T3BTgT)N+1)?(ppp=q}Vh65xNeR^-T9h0T@3SEtLSGKUfw%x9Sh(2el?ZK7%~M zgDy!`JUP6ZWt-&6>P(Bk0l>OOjX3Z|7GNO-Q7TpDUW0xV@V~SV+dgF^d*qGer2R-J zQAdVTpE4PUR%(=Ahn_LQ&zPvi6IYk$2tp~;x$0y}z0MdAOin;NJSxbkF1h2Z77@hd zCQfyNBX&IvKDRK~6lAwQWh?^$FPY19PZ=HZbk-o(WQX<7elrV1`JS9GF%u%M(6|gz z@$8~0@&(X+!esm8@ojHmJc99Bgz?D`ip&~yK?So3_O}>QITWu5;7o7H25690wx9=m zy9VU!?8~=MGJlv(D1nR@^C%h#g9A;5sKonE7ews~PZ&p=)w{kHK%4Cfr=q#r;NHN) zD-!X6z!j@HmaT{^V+#k}ab8u7`wx|deinEPQ^4N?cdhkCa847rrP_MX;{;>*B&BIx z0t}IjM2yosw8Kk&C~`Mq!NP%if1YWeY7|ko*2xkjK(iq=p325qO$URjx0WR1=t{KyQR zXgD7sZ9yE*X0$dzB3psFb>=f9TyBX0VF9WRp@xj{^>CHrPZ?WS8nGS7kz2?@900{Z z3(?dM?LnyFyvgs(6uQYJi26x0T!n~WDZj3bp|)KCRE3+KdNF6smziM^B}9Y|5sYAq zQe1CRzE!X=NJL{0Ph}CpW85b+m0ToHJccF_chyI*k<8Mp{g)9X3bH1_0%TF|1v0Fo zkxisZ6U_e*Mv!Iz*r@6y8&gAxfCrjYImn1r(pz{D9GOj>8wA(30I_zr41e%Q8*Zrq~aqU17C&?Q3(IwX7T-Q7H|LP-7?^|c9ZIp1PjTCsHy*oTCu1gIaX zYT>H@CJRX37&UJ{AaTs-E(r>przTh!$nF~C`Y`7Mz~~Gtpt<%$+O;#%;&xKc?Jp6i!1w7MyQE?YQK`9-W*X zWP~L*#SOpau1BTjZ1Y;-;y;!Jt_E$WYc)j}uX!Lc{R$03-ev0(d%r=ziS6J`}1Ack~#8mICfc?ZvXP5=39Y5RKKqHG85YCSQs4uw zD8oBQ>|e%43k+5Zq;Jyyye`q~gfWshtp9-CG&^rP7LdbK!xtQ$E&&$klxlLe1~vy0 z(lN;JeGtDvc#QorEyYCfb?Rj~SH}D2?;dt!rN0E`n5TPfGt+L;GqmheM`KGv5hxR#*k#*1ktSjVXVW^fFo(vwNb0G)D(g!fjsv0iV!e`M$Bad*ap)j zqGuw1Gh3NWwm5%-`XK8qzLw-L7VX0QN$}uzJPrOoTI43~ICg8QN2*_br81%?a&9zn7mv6xnun|{X)OX>m3nhP{(^EOSmC1c(> zi>Bq9jw?2CD~N>U8<{KO;K+1*fr4nV!=9tgyEdJ9_xKZb;d{G&&U>N>yFBlC_e;0v z%GUX^n1y$c%$nPxjLeenQ5=CtE;7qya{M0W^Id`KO!PY_xgC}(&ynI~sB1r2)U!}B z?|1KL9P%#gDUr8%$__4}4owpd;d=)hpd%ChBL>Su<*XIEoqff!U;O_a3TiUhkeMB> zBX7o|+ynO&nvPuJ4<{~;qIi$Ls2}&m9skf^7Y}5Ob>i`jXO4P~3~)LLl36|_G8_{R zu~}PznoQZr_5ghit((9=IQ?x#K&2^5q{>)6W(RMrQr}#pch8ZSut~ zA9-JseCR~pa)P`OxR@wI4VCQyd)J8oo{F0He@jG^!XC9##zjhDPrjvs9jYAjKZQLI zPOD|ZTw$})WkUMgdw1{_t7}_erG6nby@%9SxeDD(aCFFK%V2e1vRmnd?p2hhRkc~@ zMSV|I<(K5uKJ`PDN9$9Sx*Z|!Y9@R?RXKesoh1C1k86g^tZ)rpceZa;-5P!OWLngc zsI8o-=hZ50^(OIcUOLU!U9EarO?j!#(|VU-<{6i&bh%LX(c90hL#u*A+B;zTx+Hc{S?|#8%R_?6Sif^^>|%Y0<3+ z7sKWgo|*L8IRya;iD8V76e&&MT6Q%=veWcEtztuSZ{cA=^^-G}eM&}G6SK=A(@Du+ zK@HAN)AR&BKpx2XEqD{VOm7TfDl2n5UeI%E4>!X)FeX9+O;f?0cm0oj(+L5n>GCDwBOML6sT29JJG3>%L~IobuCTAyMctp z0kX{kL!!!R!(^#YS%IPMY7ZAN?VhH-&(+4vxlHoLWC7YrlmEE9IOC$erSiwc<`{f@ zo`=yU3O{O=MA6TliRRF4qtGyU2!4T1jr#MAo}}1H!#pHJPYH)~HKhWky@hxqn5&RtCs-zr%GOQ`Hh8i~P-8J(0{bz93>L?%S}Y>2 zl2&?{C2HQ;^+vV^iVKib5x9VHUuHNDQM20K?$W^k70F_|F*J({7P$mgLpV z#w3vVTv&+9455p@Nrd8W;vfO1i9kR#6m_mehs<{9sv|I zh3Rp-u87k3{o^nF%vCCS5;o&$2I&?5UZB#^g^BD(CKb!M@^}s8GNXW@AuA4p^k*Tl zoEwrv5c|nIb{}O-HY|UL$WxK|ePMqLpJ<=!)3PfF&{?QJdJJ1|*QiNQAHqBnLLfD* zaTBeKrP8wD*GM8@>2q%NqcLMWS9x^roLFE)?mUL%tbJ6`C}JNI5mNZXLhrri^4-{Co|}vwEHi4=k91YakF|xrDL91*#D8Fo+G3oyF4EovFr^ z$ID-ls6k^4=i*%EA;{v*g{*)Sj&3a?DG3p01teh;04XCR!%Z9&8G?~P=7LcoeO#)P zXKcH9pzJ1wnFlp3L6gmx@Noe;8SL(fy(?`m|G`0r>eqh?p{+R=LI%@&#xmrm%xVD! zRbRY~wDhgHIvc9wo7zbXQ9%hdNHuUL>T1 zzySI+2ynRqL~-DIOLB%tT4_Pa(M*ssumyA)Vgc4sSf-XH{l^u6Mw%#K(5$-<-N0Zv z0Am4o)I6;U@n~A|Yt6e9&ULxpW#sn0UyBI+7}>;{i<3MLuY#ogcAOZe3;I{Zxj+9= zZa+I!pJpBf{vjf;m|dONiD$r#>Fbov~iYD{=^|cHvAf)hR$1{xKEVo??3=(*$aGYXC7Tn;-IS zu=#gJ+`mc`zR7lN#>dR~=_!c0JW!`q zdRlxpFm6QcZ5D6aaK_||?5V2SmYQ_|mAf$2R_%1XYeyfC%|d^ee_oBpf*GSox=~jh zvX9@0j$1k&=@UQl-<^C=)uR6_KWhBj?;x&e(jSEZAK#gozWr$p?{McQYQLSPr)AMA zHyab%R$X-ltuA7Z5mC4jvur+*-XKi+7lo#SK?^gB+r&F@3eMo-~$wFJG3uW+}$6vTJ?o? z?Bz2I*RC!w#}HJ1@zaM7C`;o+hA^ne8jPq*3l&-nzXl(tqGBmW_}y`)m_HE7KNfJq zW@qqoB#B3)8KQ?EYr()#{g6}H`>I1II4d?$z!+EQYDc6=AJU@#Xp6sw7GMH6k^~?= zA?{Rh<9Gww1ug$mD&e`xG@0CIcus64X70w{-To^z-47z2G``Pi7+%e8iN84cNhZTd zWD|JuuIeod;60csdc8f1Ru$h4=D;ALypnIUC&U#c`ZD3{Fu2$uNU1i0r(GFDgzVW< zwKD;pSe!W$SP&%SNOmNA5ql)~-j3@1OQdEhmFQtju0vYB;)pzOCVcRgddTE;BnIxd zq*U_s@~118A+iaghk(Z|QWDUS*bX+57o?9$xHONG8G4t7!o{Ff$P6CcmHwGH%gT9`644_(zzk4J1~NBmwJFdXYphKyc8J7I`aTt z7RoUMAjfbVA<67xH~~X~)K`GP3o6sBiziS~FbXyV_zDuIX7^M!3GggPqTK};4HHUx zKtceBK@8Nzj8m$?l|0g;vLxuPidW0PoIeH@jmb#u)Yi*{ z!|pmYWLoRcD3Xeq1rfSiUl|0Sh$gr;rzDaRRB)+nYKYF*7jfxY4R>T;%%;^B8!urr zJ#Rd|0H;5*RQPN1+8~zEuLcC;Na|Tie-q2Zp{u|d)|$A{-+$h_gc(YHi|lqY{h($t zjDzb0B@b-U>0&QKyFcEUFm+lsjo|CWrj8PlIE`swv7_xqR@KbpQzm-!KvHfP$ga))j!UGXKId4BKc7lPUFSbx&BwmmnR z9Y6DJp3dWQbK$V&z#IR;#sBM9xt?coefiw%H0*l9;eX~-*Z=U0{#8gnKh)9KG_{-g zM0PX(9%eqp0w@_$P>(U%{xQ1AG5VD;hNCe?=s1#f9MwMt$sT@x!(6ofdL{Nh@f%s} z|1xEY(!!q(#jYiD_mA^Tj$iUmzH~Is2mOp@{md`?S>W<#&4(XgRmK;wqjwX=MUNOb z`(GleK2{^>UuK(&+FPb##+H}$X6P(fFTXVX_W6WpC<%Qm-$+YVY)t!hXbOeiKsZ>5 z3f_S05w5tWNj`4IkW1jnMS}Oro8TV7;Mj zCa=@~rP5-e5j(*UJduREsns~4a_@_(L-SR|37vmm)Xctsw{9rAk9|LX#CB=&RNLBA zZ{qpan{{gwy$9JARTJ-vC-$zHo3KjVaj-V?x7KJxVuh!)geUEiZ`{6o^V+AIm0u@y zf+szaCmkM5nv`2RE85tbO!_w7_q+G#dP%y|md)Y$XM6e^!RnJf;TEA))M2m8`>dvg zho>{Y+omF>H+XJD|GOSDiHJ3`ysM7%+?w3yo=S0OPk49J_mefb31cVxc*1sTIwBeHHyTnsHe3Z9)to8TSQ| z*hqL*(p{3)IMY@TP_Ho6-%(TKp3?H^aZ$K7Th(Gh1sb{f!+?bj;7oCduh&+VA+Gh^9e~57czpQALqVD(;;4Ibb;h?`GY4{QiT%^Y?^f@==LvsZItBSN z0dZou>99*oDg+)xi;5utDZq&Vx08nw6jYM8x5Np;gt1q*7Sw0vt8Trz^z*>_$CCO3 z+XDPa@=tNuYupGqyccj?ji5XvibvwbF_N(|_jBE=ikp(8D1%|j}W}5|8j|H}_d6u|&W+`W( zP{eISBKN?8>{_kBu2U~3P$5LXa0uhuK~7o-rLRuOr?dBwPK&}$6^cJw8z12m9ZEml zI+3N~L=tv~=ce^=uBWN7h@!_di5$(Bt)X|wHmtM$4qqcCuRknt8GmO#urf%~0)-P2 zuLmVCMdMAG04_B6BM8)CN2Rx$bd>;HRap{FA&BJJyi9f}Pj-_kU+lj$J#bmmD4Wuo z0uIhb$b97iH76&316AClV&_QUnolHayINXLDSAvPDcyy*oO|*7-{FTdV#oT|$YRA=;tf;!3AVaZNtG@cw2c%X1)zzHr&jB#c zfD4a#LZ;;3EQsFFrQlj~R*#8{??M?a$$CzrHcs}p9QKx1c-&O55rl}irJu>3Mj{@@ zUGBF=-Ltk{pj#WNEIn;S?Cnxq=ULatq9SXDk6mIse$F0#s8oHQIm$doKdYXxhErNi z&|k%0Ji0Z|oId518b@C-|0`wp7esw^QTO)UOxFhk-sz6FPSU+o3cS6Vey>Y8m}uOJ z%90|k#pQm{%6*eAq`aTae930~8^Sh>> znfn}sxfY6SFc__>b}e7k*udWN%7Lxbl&(c=|Zt+Dz2_V7193dpMa z_Elr+TZHd?oBwD;;BfW!X502kz~+mtz%J>H(+HYf2B%lYJ5=wsn;85*#w|m4e2*Q? zA(~py!N8U3!0ooc&C%Vvjy~1lyDj}eV40n9jm`Pvjf1#tWY#tc{)0(0kp8tFTk39| zQt+YDZgq3e9?WShX^U%Ti<@tQQFMQTZEtdQXDVXb#oSLYi)o?Md{N&<`1;1Mc|aR% zcY!U4@xNf?pxY$OpJ_1Uh?kC>@+0_cJ%r;|P(%3MvB!aa-X4qQ-p`Buldl1*+X4SF z53r>NBY9re%7VA@LM~VBzv12a?Xhonye0bnfWidv|MI4JHvX?`{~~4oN??#={O(ca zuBmOXvCJpk_&`UqgLlP&{5yx#R(0hS>*(%F66}r26Jj4(6TgIi{wgl>?39kGw^X0}b}s zZIA6ekAotQFPH5r%A9yP{UkL7nP}Q!Pa@v29lDAh8af?;uSa<0hu(sRx3-7tYwm*# zPJB{NMx!7CXndtEA~Fg>md^(3{i8w~;;$aIYV3GM|2(4EdV$ zK!Hp+9xQ(`n@P{<7`-Gxm?Q=}LX{{XCP)x(NcH<+^jzsl z-LGi9yAiMR{STF*O4(0XGhnv!f4d9@VFeI;dlFPErU2fBb17!R5}1(*>_M?S7FhO( z6zaV553kQheqxaW=bwI^k4C~cj?c%~|1rb4`$-1Tr@fKY1g`U?_E-{bE7%Vo^D6Q8Q)9_F~2JVm0#OSL(%D{>5*;IDZms zeehy)`eN(X#qaAE+i>zOJ9*FZVn>u*Et_EV{dT`C;-x48Msku0auCitad$dwIEl(R znOGG$HToZk2zt)_za=7eu5$rFzV}>?koCKYyKKNMs{2wX9DN^OvidR4xotMTaq_6u z3k9zi!XFFdnM;ekuTYeCW$LNf-v^%mm1)DJea}L~te$8+lxMYIS@>KnmQ^BV+0!SJ zK+8gXNCe?v3}8!tuZ0DeT8@x|{=bgg-~UNje~eb@EepvBwGUKaYs_YS@Xdl71HU~2JU`fZc=>MM{pD}cBR*3ADpl~b z3a=Ot^|q3x5z~qT4|v_f`}`&vJ&CCHjxFA=6t6H8rxB`rL__>lS!FCyT#K^iin(aDf-tarI;EJ1uH5GEYaQ*m5Z*fQYh)uMjsv3Ha9)|;}r?(z>luU1iS z{hEgasvGbeQxcM|)fNovo9H}DW?nUO`p(vEH*qf!={`q)erb6(TJn8=X^adB1V67O zLAhgPd#EKlWqavqiy!u)Ow{E1S(Q7}`#F6(9rv=oX4f_TcxWuD z9~K%()fR?}i=>yV^yx;deo*i=Yn=Tte)%*f(6R7TD`uvzZQ8$(CTbyPaQ1HDBhmXR zt50q?1XN_i|BD){Fi`GT2z4rbgDL#4@2u=a7VOVxm!QGh-Bi&BZ?)cx^u^Tm)56Xd zGv69?9^RhIe7i63W?OZWlI?RJJ-?lKb>I8BM(D=9Yk`F$*|vc(J3C)u?yZ08?Ne(b zZ)`x-^Y*iN-=8)ZXe@twE`0hh|6;x8eVwp{;=>sG?FFx@HPvv-@h5=)jkE#e+sNn0DKSPmly zacEcu{;HorzW$}tuAY{h{Cfc&&ru_T&q)Z&b>;nykdnq<&(L>S0$NT6ctHEfKdw|} zL?MPb_^t3O4;Ev&I(iL6f-_BY(fnjjBe3*mAJ(39m<)A_h<=HVr0WRIzkK!Q&qsLw$8O3*mx%7tnY@@|e?it~scPv0= z=w%o!fZ>BNr9y*<#f3&g^33x6H2R@lb;Tan$`TC>^vCjFl=ngW_yOrLfImH|pW@1A ztIVT?f9noi?dACI{kt!ZY3WDRlXL?nmuP$Mg5uIKs|Ekvf zp2W?k5|g!7uj=$BVM+~klZ_#->Kz-`t=>yawdB5PFsHA#zkyHVX(qpFR7E5M0YFNE zERjj^(vZyOiU%whEq)PXH!b)SnfIjJ1SP)>TeZE&d$;Kv z9!&c&r0r$tKPfMnziDH+ZLQVn{%!_Eb|9S6Wja-Tw2R~nW=$I~SgQwGL4eIHD}S(I z!XisyQ?AD0U3ztAX#-|UPxG*>j=PC8kO~6r?9>?c z_ghTUuSm#3wPGpzfJ=DHF_1z7fap4_dbq&BP$*jatsT!c)ba_-m7bQXxtnfisLF?_ zVi#&P9F-}zhSztZ$bFWT)pJ7aWqQo!r>O`Y0@?k{IKmDz{2 zc*G-(6x^8krc=OEBaZ~{y0HxE4#S-H3ro) z(v#ef)u&J3_|+@mv&!(k(1dxv(!8rDAJi|Nr1wh=HS)iaxwpDf_AuSuQt$hJ44N^z^(a(zr|yIm{O@f#HxIda$I3ad_|ix*q8w_A!45h}k1Hux3V z9;XnhX*4Gmx!Y+`tXQ|xutBHYG2I*UD%$1W;*FUneP6oBE9LJSO?X6S^rzBqG~3U3 zo5n{cE{e!^)HW>Xk8pj9eW>(uB+4(~S5&8Cz)?H9lu1lrz>ms+6B>|4z9o0Zhxcs^ zt#2JR)M=9^cLJO{h1CNkr;C32UWw{GXx$OH{r3~+$>9Lsb`?SA>ZFuo=qu~XpSVWO zF~0(Cyh&{giH6@@4&Oe>xa$z=^q=Z4bQb0F^T+nAT>Uv6(Z)^P_4cVu;lPM=N6lkL zKmQvwZlAdFzhV0Kv)=Nosb`&yB=XLc7un9cUYnVIUnX$t-$vf~lra}>iLgh1uYcn5?&G^pCF>LA6@2>g#`N|)Af1F+Od8c`2+T#6~r=*%z{ofnp zu7O@n!}p@McHq}lLn@A2n@8TE34_X0>Q7Fg#7B>vE=u_Rl$d@ipuZjTfgH>W!q1#% zIQ_d{x@g2Z|6`cSytwCIQokj!igO-^o_{%6a!lg;Fw9pq?u7X6H1uRrDNgZ|vZdfX72a=;u5fz6^a9cMZ?vhL2V2BT>O`r%FdoqEpa z-MKT5i9FFxNE?0~R5{D&>|}X4f2OnV7>Kr+#Dj*2ih*d`F&ym_^+JcE5}-TGk5?@1 z^XBZoi(Wz%oxS5{eZ&9rNt%EmAgIs-u_(~0>1H>@3q+Av5Pe*+IN?(*s%&l1+={EJ z3!k-|x!KB%x3H6{JR$QKQ)&|XEJ?dhiy8qz>?UC7Kmq)HFuV(eZoecT5Q8gE%qC)k z08!~4m=uKhlvGQHOQ9xl9Wq~)D+f`Nm!?ol;#^B#emm3b^YbVrORC{9l#N3KgvtVs zal?bfAc875aRg2hz}O%#yxBPIbP~i5r=JHnm*-tk$TLW(G|Y5!_hvIH6*8`_yi${A z+*WCl!e+wD=6f&C_c8=c0?bz{=@7b5Sv*Ef8!80RxQxf>QUUGS$sIWDWenF%eaR@7 z5vYI!!vcU8K2umfUWD!MKJbN$DO7rq>I}6<6 z<<*$e6dB+uz$p=^Xc`hQLESnb+E7T3mVy?;ZsO%TfbB;?wyCGL_tESkcP_>8%P%@G zu2M4^;vl;?RRlz`nk)=S5`n~0%oDtlDn`jiP(3eOJ+ES@-(7Rm{mbOa&m(7-Lv5KM z$Yrq)6sWVYiplT$JPU6Hy4q#DQH1{0DriwK*nFjl)z#)!dF|r`(LWwy(Mw|6#R9y7 znlz%Y@6~kto;>Ov@?9R*Y@Ytw&+hmLNBIz=jB`RV(V@pB?9#<5Of;$~o~|!M?%win zn-fiz{So))ndbIa(!YhjMpYWOEF&&FXd`~Hv5EcH&mXS8!dc*B>5gQt3}a%-XAfvyP2`K3gv@M$JoA0F-|=%|c?_cWuGVI>J)>j#P585x z1{Tkd_KJ2{$tqk-;$3?%%CBth(XY4`t_1DXs!j?JeVkVNIM@48;qUt{Yx&x>*~Z>Q z+v51o#4Kc_it3?C|DFsy?3l&p7 zPXpGU=KidE2zIuf}G*USzFj(WjU4j94w!EnnBo`>g+1a=>__ zqr$JHZhc_UtCY9Fr)x9!Y(r&K)PZI*kxAlZTLa_%=94q2IPjJqjsG(y|2D2IRuQS# zfz6P@ny1DMADT9L+v-QGwhHq6x=a10s--Hm{oirbHKlFV^!RjM-LfFoebe6f6yV*} z)YzWcP?2_dB)9P;C4z188|V5pj`uIy-!(hVG8+ztKzUFShr&zAr}jFEQ&{y&_QN%b%5mTch6SG%kAdR9c2@k3LyGx z%$;%eb8qJ>NXJ~iHJcM=@KwQ zTGX=uJR7Gsf1i%0o2xIFry%j#M9Zb0a=gDaryj(EaMe9_Lp*eSL8)s%F7%`^YzNf zUQsZ3sc`*@qD-i)?G+`@mr8+G+ETJC5onBQH{aN3TrVVxPjIdEnGLePh0yV zxtqFE^0N5zAJIYIXm+Qf8#HEwk<I#5I24~*~7ztX?uL+p17*+%zNQa?EgN%D$BGt4w&M{Otj-K_cs;KuBAn4A0GTWa*hKoYc+I0J^r*u;3!SsL`}&qkwQaWb2it zj&C%T+_)LKmmU`cI#4(~4&4n2pUIUn^K7~FxwclmzXTt?`Nrqg&epA>S7r|s86Lhe ze|ZF)gcazA@5jBe`6c`7gJkM)Gb_2d>&4~gxjySxy>5r@swXxemRdpA{cWAdlFpuC zcDIl0T#wvE13dVCyS{BC3n(?uDR>_!?nHa7!Hzv1`g+1SSgt(8;Tw`xWh)m&EG4nNpBqm z4R?Ded+jJbTx`=Lhuc4otU`18nx=Mb`rbBf{V4xD;&q$X!ONIlXpY^JT}v;A|H4B5 z9(6`2hwMbgI30~62V$3uEFmhd1_*cSl@p&KgMUU2N=JE(5FnpkCvigt*2E$NWmsok zGu~)Tjy%-}Rf+D^cfH2GKyQ&@x)*x0o#9&K?3-7`A`w5>PJE)^!>{^3d67jk`Pzb> zN5mPt#-D@-*p9Z$XFSM1_1!3T+lfkf)*j5L;(b8aolHtt^V=?n`fMW??i8HK-Ja#z z>R+Zjp`QFw>~+Rc(-X2(puE%kJbvOURYcX{esGf9`yk3t)q!wU@Uux{tyj7@5!06lto16bB?1M1>gwMRixB04 z(bZr4t9(x@s7|X?Xr0tf?`EqIA9&RaCe||km0s&@E_>6=*r(KRwY0t?_iab{>-L71 zr|JK}o=WmR7WHd>`=)uYS821SrR)!;;7z^q--oWM_?R}$9VNTh$;;+s6%$>RPMtq= zxqsX9uWE0CH4S@f-~M?)tK0GZ4YncR&Fizs>#s}Re_AXxeg5Cy+!`}ANG$0=OkaI; z&GV$@GOBumh!U`D7CF$WFC1@>_Oz(!xny72muoM|-!unO)ffGF@hrNXmLyG=R3{pf zC)1Yp?5tzsZlka2qqikbM|3}EcCK>%Z5EB`yYlzlVB(det7#i*aXQx?@?DK$d?Tpmmetks+?XAdzW)cH~Rd|S6lyy>wiXz zV&cC<+tkNA*nX3Y{rlYZ>|5$d32p2=b7M`XKmG@?D;rAHFHhg-#4RXy0cdT*$W-W1H zl|{6tZgV360bbpg*T}z%Hk}5@8k)(Q~(zK9UHHgFe zz~jGEwR@Sm<3xcmq5(CR9?eVAgGA$eeZ^C+Y=L@PR_Noz8uByiTFaMl)~Bie89sN( zO3^bxSr(^xPR}KAM=o(Eh5lZhe48KW^gbR0XHzQ(a_&tUB&Xfe9X*4o%b(hg0E|I2-ZSgSG3HdlH=?a`zOI$S6*wiNV2s5SS-2^ zmw*hxp|2Sz1CfGIF6Yen;#z>o7~0r6X#`KFoH9*vOH4lcKC_&}-o*lB@&qNnBH>%- zozcNaJNj~4rXfaxB#f&Hcg^|nqpQw=kJcu!&o9-o0uVJYO>)rCV!s+oxv-G0>!&T# z)~S28U6-@0&<_*3C};hR>@dj_)-V+-K%kP0Rs7PvXf5_sJjbQS666P(&$|o7!IMqh z)>s)hki(Uo8*Pg8_eBwP7?Z>bTsdA17E+#(Pz)lnMqd8GU`ZJPKl-=ki+xAOeafOixV(gQOgB2%aMz7h5L(cekY0!ASq15^ zJy19DbyKO~=|m$y=3-MWY4P&BVhqg6V*G5Hsfsm(VEAWrPNKY=8#QAz3I}})A;ECx zg$;#UMW9Jlo!XctLnb&v;+Sa1V&4naguU@3>LH`_Lcz-a+02xb+~M%d5omKKUNgpg zn{6pUp_vf!Jw2(fmVVr;eH~2BdUXAlXU_sHezW9+8P&Y-)^?g4{47OKMW&M|k>ur& zV9s*2Tbj3>1MwL2vHZ!RNy}08?X6>q)#?v>kt8D4NAH+81Ys*ztvOE&v8@1|g@fl4IBimOJ z9k)s^CMg>NvRI@THDFppEIo+Fl}ZoLfza)#UN*iT!Ru1~L@BjDiBt}D8v;>p9}>V6 z7Sj^hi{i*;)gPm$IQqpLIDd)l47!!0XTeWDiXutQ%OXvZv}n9{vw%3cR0*#H$;t9H zP4brE=%sfok%k?8tUc(rAKsNmL4s4bXM?%*#=#U;7SJ*v>JryuK!sL7a zS%Neaj;c$sJw-kaf3@MTS7`fg`|Swy?S*S z>oosrrWNzr=-pOeg735jFz-l4^aHcnGxO5<9aRYi&_`pXA}Z+nUH;qQEhA4PWU-u! z*|?{ViX8Sb^W_`F0G>?%FiU^fxfTB0H7Fa*UW0qL^J?cFZ6X4oo4>ixzY`B?P|laR zO5(bp-%UXAu=-+f)LX{8iTvqovXryRM;W`xaDk7e&XzESJ-7cu zOGXEjKuTxYeZKhrW68wcSZ2|CAi-^=9kk@wA1@cGahS9`YEpca+T3XWhMTBROd8CA zV#$2TIWsk?W7!ZH%Q#E3u#EnEiDJpn7zQm2h?pj00K>&UH!;uYMJw$6C7DL1Rcs78 zI&QL{fC}XjA2HIDAU|M6!*{-N_RDNmT3Ejvx{NMb$T5_=Gt+c<*RLHwrpp$T6NP_Ur2Tio1D|JmO9M|i>+^sBu|@X5T@ z(&Iq^t+m>d#Z=x7_|FVs{{b+l-Yz^He0e#wT>sy{K|!4cLx9B8@+0XJJ0?oSBGJZ$ z#Tjb=Ap1;qrE&*2Q@pOQOXTYw4j!*#LC#aMQc=I(FG4@^ zx-RdHXeQoG`M~2mleReOzC-G$Z7`>Y11ejQeR6+b4d%0_Rkbri+7N;avhV zg`4S=|1KY2(4sFSOxssoB*!hE=3qoO>l;*b$7RY|>(>pGT1KDT08e&%;(|vIKuWd_ zH1u@yC~4;(xD*Z39}#Xv>>3TFKWa$h24-cON0d8UQaJ*XT>NgSHiwU3M0T80xUx9N z^baNSr37(8<*SMA*p!q%Yq<>m-Z>n=7{*eBw>6?$z^3YzjUJt$#V`~c`-+4P{b#A= z3k^H|PmH})ghX9umrMl^hyV_tzZrHv5KEbMO#!hReznygF%SQCvd5%ZE6txg22khD zla~Ox@V~aQ&9}#SOnC6$#i-8>e0gNL=idM^rxF+@4?0F1!tcFAwnSSZG+~|fG6=(~ zaOXcM!G^OmD!TE;B0E?N{JOGm^oPqipQc6_J zPLB%-GQ5cnQ;tf&l#1ds(o=Nri+!Mw1K_mS3aX|9(ie(7Lmx$Slk&nzH`(MkWh11h z5sB6x0pQA-OxT+ieZ90G4b_X@OJ;=813b3+-)sdyb=sHX*uvS203d0dM)?=J_>Cu2 zyx^ehM*XouYKV5+tv_i=QWfv{0FzX+`99GX769a2H&n(M2Ntt{=vjbisDg0E7qS2} zD1o_Lwhy&zkz?FCPoE>JCm5Ywn)}I|N}@SY=qfV}42`9EwA;tUg~ORjiD9{da9mO- z!Y40&umM(ANC-hy-;SnDYyQgK@cVv|#d9$85S64Dik#T$zODXf7)~ohe75&ah}jar zAz8Y|>Q3FM=s2i^SuBNkyM{O)A87r*#!BQF6%K~kg&8e_xNESKgTz5;*A)^#^kO8l z{c%kWvNnJLV$ds1YD!j!K^}k!aB{`dh-L(F$8_VUYF+ z3*4NCNJ@d===5M#Ya~WUOgjxkMr(2VeH^57-bLK_ng9k2d(GB{5@<*ZObInSY!dtT zQJ;bOmcIr_00-7ecR~I8Up(DuIF#=nH~woDv)N|syRq+UwiITNEn9Z7?_@2>mS(I& z2q7Yd?8#D;HjRCW!dH^0v9Ads3iJ27kNSF*NQoj+5> zniu(iLhM;4y+U}pmICw)wSUFWi$7n$3CRdUfT>RD6r-yi;DhdB!m_b?cxuwk9qhW? zoY=(u&t^R>MRj)i2*@bdX8<5n9(R)`T9_hX?hAMJx*js-xp75UKhp%Lkj8OAXoyF? zeD8s{F5-jPnb5+WH_XF>1HK8605R8OtnO1IMnDn%L=;Q|;EhHZ!(Q1uQev7$8o42$ z(X`^>Y`XY={Tx8plA*Vsj<#&)=w5c|gRo~KOdHLdA>#nhuBND2k#Sy>ObE6W737x0 z*=B(N_6WaoPip0eH2ky?)lP>7=m#4dF&hIE(0;{ZaNblJh(HxHmPU!3VH`EKivprX zl|fN)5MXELKKt4@wDr%uLpuLCu8weH;1A4<*YstK9;mj{YKzfSs*cH8C7B11V+DIWl&62IM00^=N`e1BD zks=S8Zz5oT?E}}N97tgEMfLGpwm0DM;d;~9v#MQ|1*JR0PDfW9CSos{s3b7D%be|p zDT#n`N&+mc&}S{)w_Zj+!k)E-hq#ABb0@qmg=-w)04VMnSV>QF74vEbbq2|N`I7Ju z%C`I;f{o@8E6v9B>_u$l&FFs~h^G+{YXIi1=yD}2u4J1v_RPltK-CBkG(2P&bMX@9 z%o1k%>vg6)&=+3;TQt*^7@h6f#=r5y2zm!*c)BZuQY z7C0gpz7&Cp+W@K}fYF(k^oRMc9zw?hC5T{U3nS370Z3SStp?g@n=m6uU2kCSl?(}hq5Xm6}a4h7?Hl2HO=B4b^e=J<73ugpadQqoo zJUIpcNRV*)m*TN#``AFth>VSXawI9PkJth$pvO!#PYFx|8-{HJ)Qfh6u_$@I{n5O0nnMQISB4>PCM@ z0Msbf7Wc?le}Y0MkIEM!cpEp1FbO#D<(DW16Yi}jW#PhgFLg5WgaHrT+28fkS;GOO z6hQwqn` zK1I>~9GykXUEt|ktlQZjX)dd}01PWO&@Kn5-tPfm5$X8iZ6i#pB7jj$g6DvNFnRLg zBe5_)ZcDazVd2Cp*@Lf2Mg}>KsCrdrCN1rNb$e9v={EDcKPWOij9SOm6-DD2 zwR3VIdvjcJ^D7L?*~{^{?(9=!z1psFuUCS9yK`t^!QuWDxwY18b4;AuSDs-&^p*-V z9E#nuh=zN7X-p>`%KDL@4u=CzCLcE)K29;l7?V@`m#g0RSGo}qR?n`F)H?)Fl8e>R zn}3*7UPO&JusQ#gj@Sbemj%qCANr)Tew(_lj+ark#W?$duXtjn(G6iSA^``?U(W{= z?KFaOAm~&cdK~DCz@pUUBWQ}C)&k_1N49ch$-VGe8k+GKi^ki*hRg%7 zd9=|486K|gNsx{gW{b)dA&xE}08jv4>VZ%=U>3jutzoQ9+adPcr*G*NhraYzJRcFrF2^m@UJ6Q-~bu*D)Dp%Hr9F!s4;O52FXI5=lB_iBA3(F3I! z;rM725o!rh+cw*sPTw~%`SX{V*$H$j%tfUc^jb3hY_1JcL}e)Io!_>&aJ?Cv(=1#M zSe$7rVIdD`uc`pW%4cbe9XXJDqeu@$dq%zLOP#1xTe?SKNaM5S-q99|3m1g9VR`Pz z+oMo)GoRSC;hV}Y?x9fuWUEV)h%?N_gG`a%0A=qoThp_?AOI+U z?)$%pCQnd53Mq9*=f{Mr5O%L0_G_+ek zS|5i-7N6x!!+`sgO3pDi*c`G1%E9OUfc&PQtWuPXxpgbV|E;swe8IV z6FlnNq7jBl7~_1Kc>b*hsPfF@x=g*;wu7V_ZL&iFHlt7o!B8F7SQhuLAfs83lPk`B zNUK`=qa?umq_|P>gBu=XyWUZRL2>{bm}Uf>4Q3flC(gwoPmzZVS4zm#EiV|Mo1NJ` z7;)4bVjH$R8;q>9)DmjkJwVbYm}AR~uMX%V-2bs& z2$32X`pU3mn@8Ci7{;0~b>bWoJs+GjDwPgKhFik|789ejhgp zBQn;IYdFeL{48AmGg-D-A2-88M-gg7l%w--iw`Pd8+JLL+xOiUf-!v!R-@B{vDZjC z=joINembjDq(l)Ol#LL&%X*LhYbTL0aTNA=m-&giFL;MOg#x=lMznmTugc_^X{!W# zprRG0aut*8$G&XU6>m{cHQDW`LH004cqDB!>_Zsp`akBzFjS#v%o%Z`5YAjgg$GmN z<$--KsZ8mkuvl`2ACYli3m#g+T}z&%BTmBWp44&&g1tZRCnxL=F zPASe^4ZzH6P6WG5dcw4~a}h&Y{jEoG>yXA{cXwLte+h zZ&x#>ov_@?WNcxeGM|H=^^$t0i5Pt6uzx6Km?aVf0Dk1f%OPm(#mP^6|FdKqN|#1* z7T?w{jd;-KQj9OzExE>{t-rtYDP0ciSPp8$IA^^J-ePM&0ov}e;pS*Rrj=VAD{x{zqTnsvIGEwGlWy_V;?RuI2dSi1J`|5-8u>lNDT zm9Fd6@$0pv>-8P$4d2%rPuH6THlAs3w7PD*h~FqXMdsO~GrwcJw=n-nuIqh3ziV9X zc3pm7is=+s|FDG~Y+R1q7JGZT+0n?7(7l;swmH$bJQch+j*rWoU+`HU2wjUcn{wk6%J=+mo(4+l^>g*%Eit zl2|BO@ZOpd?bF7;tSyD6Us6iH^Fwxa;(r@{-*w#j4JrSfZ@#C0^*2V4RhRiJHL`t~ zCWO1UWD&Y|-+bSKhPe|47PO@M?ux!<2~~0@Bb0WdZtSa+{WiO^lPj=quf0!y599j@ zQ#J~aa44~`Xci`@HwAdEdT{J|z;b7IYHN?{$39Qfwqpo$`uoHEQKl@~;XNADs^U?e z+fjkV(JwN?FW@Lkhxu;P;Xn74;4vr-gn1E;#*F@f;}2YU5B+rx0|nQDLYG2l=wo;0 zOogL`QN}Npj1$=mBNT=K0z(Iup^HjCfMXcAbKHwN?j$gDS{@JnqW@%Z+<{~0E;|`% zKAEAtKbhD*p$eYP>zvM&F;I0FDL+m|vQN5y(NhQvyLUtCtU|5yLYyv@nf7xsq&o@LmN2^x6zy|wu9b64t;jg#ACI54CbXRo+i_Dh4JTkwqM_Nc~x{dsj=O=vRR$=UPL<@LS?;BF`S9%K$T;yKP{*xn$$oY%*9yB`)fN&<+8iGT>l$6S35q~F z`Q9@jk+Tw9i*N*cjR&fUX8P)gbky>IcQ)S^I!>sI(G3xPuh_M1H@9Nhe)pdItq#$3 zA?ZiqYd*VgH$N${z4=K}lZ_Wvv9kDvHFcuJSFjWi%CU+C%`U?DT!QZX1ko`FMz|R$ z0JtonQV#Qi?+Nt2)gFAs4)djp9te*@s?HXGJO`blaU|U(i9*j<1**Ir ziPa7DZJCAr#b~lZk_UrF6f5`SXo`BzoK8WGp1{Fqs?^sx=Gb=DkI}!}G03vRffdcn zVc@p*ITHKOindM|))8B)e=<%XYBvah9c>a}1y~aAHV()o5xD*m(!I{|!l@bw4DQu* z98@HIj0P0r4PXTParAMAbO?4Okj6|WINw7Ub!R|VNNqevx^hlL?ED}Jnv?q=s8UR6 zO;^~rDZ*6Wb9E0UQ8G(^(?W%WnR?lrnnz`}AMFygqGtTHb;n>{ftgRsVJvJtY)k~w z7M2Bu)fW}yUDY?ur9v#1y4kDU335pV+e)qhbKNDGSP zef3?VraxD)r9Rwc&9$FP^%E?G#Y0{1JKk=)2jJ>KJ~1tnxzY&|Z6+2pwGS%@vmjVD zbBn+lFkp9w+2d3XfuZ6ISh0wF96n3zbr+p8IuR;*A0F83i#;s|86EBd$D|eYH_zH* z>z`j*nwUDTnrmLXmG?;O`br@#K)2#lB<*nVkq#qaD1qvc{`5EzaHbGk`St|hMw2?r z)C3oBITrKC|5A}69doZJ8jT>o)4T$LFL{BA58=#H1R-=50ZsQR3Ho}FwWw6GD=yN0gnJy7KAc&O~y%6;SGs1TaYxcq~nL zWdS{VA@Jm#JZdA&U;k`G#aI_6UfJHhssIhUcLD3k!a14(OrJdn4yjhrNC}M8PG(^Q zzVy53nB+~}|AvGkn|A|)JTb9tWp;laH9wU7n(KtVO(m8wQ}n;Na@r;i*P$~4T z#PY=bo3HQCeT@|KYugl9Y!L~)-e*-KA@jB8?1Y5p%C9cXRQ}7htIY4F z8-qzBJkd@w!g>#_vqH|%mgh<=Z}n=u+iEun%4WUm&@z3laKQQEYb&QG289%eK#=pN zUlr|G(@9oROVDzH{@1J4FBpn_uKN@ynSZF*6Mf(jgytW7CGKCHcK_B}7xhs3k5UKE z_idcN>h=46fCKKf0B>$!2K3_s(Iqrqk+II|~F+7QXZ%%AVg1kC3j9}C6Cu`0%S7P> zGW=>32w|wGuOE^_M>9KvR*DED=~A3o^2G|~Ff_oyx5pfwga@pqnt{!2gu*tJiJeMh z<0{X^wB3lFE;#qnW9esTEOcU8X8zH+6HmuCCbRL|I2+?_*bRRVD3~kSL_>(EE;-Mh zM!+#Kw4|99&SCCM0m7#qC@7VR_Q<9{4Y!j`08ccSOAlJQO%fahgjEMXBDI!8uVWE7 zH&>#NG6<|731$~nAP#n>T{l~3^#)x#(lqmw6VHlSu9hEA$slsRZSUh%?oN4)CnHGu zo=}?qi;+IgpZXdU9`5vBsb^tOP@yN#N+Q99cbH+VDq>#LYM^{pS)$V7{o?&G@?}|KH5b^tV#fD+G*#Hm7T|{ z#aPmVZ}KY}%B$8d5hSc4CP`BoX0UYO(ZEM@yZ3W-9Tcuj}i##sZMBukweq!&8=wMsYwLOBW5oZ??gpw<4ZGR?*_ zyaMHEJ_A(J=DJ_ZizqEZbbs<(R1@jq-%KYBG5BdDpwL8AI~X(o7a9dZ>T7TSkr99z zM1dH}q54peq~c?u36jSs$^Q^wSt5*_)LogMDqnV_4Mzu<3v@1qqQ~5lb{56;sD%b^i2*m^{NKXJFGb1ED@`8(a@cKj3brL?PkTQQ!3vQm|}ST61?Uwm$Ld_S zXU20KmFJP79n1kq7J#(gT#{jXe>bN8{*8xu8-`tf4GGTuG>Y)RMW|81fMM>GVcJah z)V4~`>j5FtKD=XJ=JE5?nKz`(H`z&rjW+8CJS&ZF zJ~NInZO!6KyB9ZDV{C}!8w!^;DRCZ5F*PZb9iV9T>jjuV*p{Vk;AH&fJSMEHSNZFy$!k@3pBJW>e~9VC!PI z*xkU_6PG#GW7_uCI1_KCb7iE!%d9`#>>T=4JfmllYr=zJ56EV6*$rOxxyW+s~ent)P+pV>Fmf z7h+qp9LG(UY!3Tu2G3+fT*4vwB~a|r^e3u->P65j@|exy1Ug7%8$9Zo}amLUh z1ellb(4T6UM=C7*T>mzaOlI1=HwDmb!yLWF0w}+f|E!bU#2FAwp^~OiWIPI>C zgM7xpH?8^?KQ)rCtQ1)tcvnTs*2`#(ac7!QE}GH!TwY1;KUbW!Y&JHE(L|i9LSh*& z3O(f$W;avMKc|t5nK2$%ssE4b_K0lesNCmac`-Ilb|XDjn|DV%`9>8=S~e7EvLz6$2QyiTHC8G?43I$ z0ed_b9w9FVpVzv{r>*tTe0IQM$;^bDpwRwEF*;eHHo@f3R&U8n|EJ|87wfYypUCYi zns_J(NEB%&ymd@-Z3aXE2wYN#NyheCm3a`ORq(9Mja_RsYrDZPkY*C-Tr;<_M&})) z#LE%(g9%^$^-LU3*laFNI)+bp%@o8+60S&+Xo?hKayv*#l5|B9Sb*4V<$SqVWuM|R zRv71y>tKFA>TJ(RSrbQ0)&OZrlH347##MyUDnVrQtLQ2;c>8M^-87kfx?F6!LUsDF zs?$~6bd}F^_08!TIj3u*bhTB}^=(eIKa>62r=KoOH|{%D?N2wef2*eZ)>1Wn%^P_Y zAY7FsX^?Sem3QYQ5pDU^sSb&3?ul=G67AblJNCc5r<Gj!Y8PZ9p%^UTQ7Oo!RbN4nWjpP5hWvxD!@ad^O7k|d}2IB@_Z zFG(`P5&rWbC7z6B^H1i8eacn+bU!(b7Cs1)oqEcW?HC>fy@4j2R|J)`C-AwmesdX5 zG8;>tbum|U483g=FqniuCvX@Msh)Jh+3#5WK|TxAqY5{$8Jz`h-bDQVT#m&3T z2+TCkyU>V)!o|~lH@MaO=bB^z2Ni1?Vo#2ITg-7XCX5uknAd(|6RPw_0W`h zy62*eH`u>9$1^$3t38_XG>s{e@9$G~xUYMH5_Q?}%Er%GI)kqQYFF4`^ZM-bNJbCA zIFHGhPUCTqu1zX~gl>SinkW z(ggQH3Llbhxa?v6(Z%AswWWaR6@yO(1)SD)UN#|av%MaYcJ3C*OW`>_rqw>|FP4O~ z7Yy<}jY8aYLl)fP7u+Z3OK{_z$1A@O%)d+vIa#@=?JFqn7w3EKb}484_r+9S?^HG8jI0$UyD3tm zeUhtpJ6pgj(Y1K<)uB26=$+Llmw>^bfT6gxdunTImjZHoefZ^ij&uXcZVqcugRC`_|@Zh0=L$+@KVQcx(i?zCx)%t?f zC)KOb9|K19H(IvV+6=sd&MKz*0-pB`q%2>%Q@#Gibv+2SNuRYbU$XISKadS_EfjOD zck8}HR{BLRZ9K5M*xvHH3%=!N;(`!@lD2b&%YKNH%D zZ#@m-=?IejxOw$^Q2EEeise>Xp%)jaMdEQm;D0ZICt&L{A?vg8>)*vY-p%thMzX3i z`T1^n`N_N294vLpmPY;kDF`XM|Ms&f>er5Wnw{9MtC^L*J3c$x{<8H6b)5bDYixdJo%~B5$qAU!DYX-`8|+*C79#o!@lnY{Vz7VnARo> zHW<&?==g0*-p#jtyU)aTo-bdg$#I6iQS*OWu&wlCL;2UnR}L?!J3P`4IAm&q)%}7s z1lP{3-1umB1L603;c76-@W#-=Z+3+}8}nV?lyHRyJFzK&X6D!C4X!Ut1}VY!WN9}Z zneR!u?K#;kdHO6(RQ|5vzJ5J%cS-wZPRnoq&fn+1{KVMrY0x6H!DG*^?ic4j3p-_CHJ|K)5WEitUrqu9|zW?_d8D9(ZRt@5_$f7*s&<@8cCv zfHdgBq4dseQjr@%o=o5*|K%h={V0DMzWjZ<^0)C%%u~*%O`QK)zWlYv{(Eltuhsrv z8!cwm{ol*ff9-y;S2bX-UjBR2AKRe*@9oOJ4vT;9{``As_$`f;tfP3`O-p=GOAKNG zY_NpT2S@jsX2S%xZqpvbtM|L!GXFq(;O>W%ogyaGCT2y&3@X?Rt!!gkmzhI1(08tN zYwzI#=-^z5xOT!2n!uTTl?Ea}6fFTUAo1DV###QcAj44g&w|F>kAT3LIj@9!{3DCZgNcy{`5sbAk*9dp;d#wrpo z8?Y<|1RHA`QB;)1#bzif5F2|b{zXO7^i1qNda0L%q6-h|E!0{H=y)5Ocn%aiF$KsIqSfGJM^uqi{6}@llW`D{jKZ)52 zs>$tNcb;ryyk2^8t~R)r*JmaE_`bR!mD70T6!GnO*tfP|2@9jQ?fom@hj$OO9{n|{ z7%%s_7_WHlPx1#pFZFhuQ00f0COW^*=QH}>oFJbX$D@ok#x?rPk?!D)0=Td05C9{*A*`tIF`KOaT z+!@l%8tCKJ188s_w{I7ctgt}q_1G&Nm8e zzjpsAyb%Ij+#6Pgcuzd`~KpSy)O3& z`Jyl65B#O^b^G*#w7@sLk&j}2^#2Leq?xHVMp|e+{7?5oM)hrJHGUPUAgYvOE|^DK za9;4}k^eGpNQm8vPkff^sz9cI{~BAVfZe)tqk!v1pp?1hLjEl|)#xZ%%!OO8;4d$1 zzOye;+y0Bx*%)Qx5qx*Yyx-OTH=}l_?7qE>ndH#Gm*{s1&l7E9^LzBvPZrNV4a6S7 z9^PU9Yf$gT_m8IT!gS*p_^4xh5)<+Mdz^xG6K~n>1e>a7Fthh8?^TfX()~Z6+B+vl zWj0`k$DnEPJINTgV%aD`2DM9xvh&oSi-nI)>P(Y<3zb9Pv7BdnZIEo|F*nIVs;7%- zAO^=$zX|)lLONNb?t2PAgjQ5|9`>c&0eKWTlLWY!uB2Rs&VNrDP!ab0NV=@&$(+xn zB5r4R_i}>pgGw#|>5#E>ub%n2;aV}i(viE=`)&umi``wFn277gtUOOD4YrzhGCUic z1RekM8`F&&B_^2*tvI}sc@e5--eW2fyEibe&ytJQXpoGg?b*Dm8qbVq@X-5-Mq{eZa#+QuJXLbgDdW6GxrXE0^`rmo5m z^^a2d);Cv7huEXA+2)cs-p`8^9`NF5J3c~>MRmj^^XvH4jtSYbXJ&CKC`lM0%9wyA z$Y_ivS#MAB!`H-#0(U6`fg#Vl>KlH_7w2i15cyZV~179!8Wsbs-pz8E<8VWH>#x_`aYWLw%GnSRx3M`|X`^cwR^xTo4 zUdZ+AGSfwpR+M-9v(NYV>8R-sTa#7f8#CQ>@j%XwmP2G7ScJ}NER!qV4HjDHsJwid z$L(cXFi;Ts!uLzttAx-3m#FhM-9QEQ%C|bqlZ;vB#|Jbr@ASErlq+}ZDx|4ibyV^G zJ5zQLx%`gVWt*9|Vc=)Xvk&Kw<;fyX9~j?t%ByUws@ot18u=ae0VCl_inogm=y%7K z=p!0n@9-uMc0QkOhH(0wT(d3q{`jZvT zw>W4gYYxTNsj31mOFo=*iW>imn&?w_qp-Tw)cLJs_hVI;aqNzR)0^3;Q_}Ml$j>v! zLGxh;bB*dkKo0N4?}&R|15y{ShZQ(4NZiZnu{Uy~dvRsz@8%Igy+iGBng3E+z!8YK zWT%ogW6<^XmEa8luarOIbM7ham2Fx(<-eL&`ETt_xYh1;DxK(=OE65hX_pn+`z~uX zz3Ok#UjJL5NoAzv#y`4suo%yGhh5@D(c6ui8i}_*dvg9wo$vVlxaM~HwH4=Yw983R zBSxhg1I}^vygxR{Ke9JvQ`&yKVLF6z#{Fpc{N~9~*5Bc)?Yr0BUR?JVEPn~F{#{2q zUjKdD^UH@@n>jjhbNI)HRMxonQ7?mbFOcGc7Y-#&AfiJ1w~O$+vEk=uRTdW5jzQshm3URoy~=zA$hAPpYFiePau zJ}HGL|L6{PpE~2NY^h);X9&{+*h6P%1>c$&dF^)2Z4d0=oS?*-;7JDc`4LU3=PT+Mg!dh1 zU;iY3+IQc7HOJk^RUrf~Wh~^5cV{wrBxc1gZZ-c@X`Z@hGK-z&tA^!OU6vL9nlmDt zBUdD+osqXRPuZOBw&Wfc{gD52T1J;k;rd+#0g<;870Ln(@@ifRx(i*R3thnDkqGb^ zg(U%`$Ti?uFM_ZoU+zx)_`Uy-E&V?vhbIbV?-d1xgmrSNP}I5xMMY_N9uf$CR=%43 zSh!k9K)8aMFA|NZu;2r+>i4knb-r62#ClUCP@aewUe4>OoZ>L9_%htIh2X;;I6_yS zE5WEUt#k&$Hbc>qc9N{8N`9O=zst(*JF0)Z|5y&HLrFCIzUZz&5Je=3DH5V_IB*2Ld5J%s?JU6+NV@GWck>C z?^4bdbE>X#l3%iIth(A!W%okNIi*TNxQ9m+a9yslKvAG)3XZ-mlnbh}2bN~T({Fd< zoAIb-kXHvtZU*9QQ0;9l?qgT&<0|g!EAD%m;2T-(7f%!SPg(YP-K|Wj4k#55Os_sy zs2BL6`dWv$_jU20kK)1c)n|%FfN-^8HckMcFPMSTodN@IyF#l(FH{Ig)e9}O%&k6s z9AgXPpb~J46m~?C@Kl}|8VsT6g_~4JM`GLa=MNuw9-WXS#Z%;>2xpra@X-XEEa5Ca z#g+#!_Yfd6oko|uU-x>4+lYENdjr0r<(Ntf_e3Esuo?qY!oNq$xl2$oL7uN5Tzkc& z;!zX_Hd=rzURuMr?)PrTFXYfK;)Ai3sxiogvMY}ReRu4qY0(P|J$ z(hZP=96TNwl>9ih+9f1$*|iqwD~SrJHHoANW{;O-JNe)B{IUJiKSSGtJ4PaZcQspE z3ffW2tm#Lj^YEgp%X|&XLLt-ovh%9v^GmfeU?BT|izy zVMzdcmDKwq|H-xhuJt5F1-4;fhJ)WC6G4=2I+-sHBYdh8-D+hJHE^)Ek zR6B-F&Wq4#egg1qyH_5rO_*L1D+H&vO8+x1?dR_n!;=0CNiagGGG3R%r?&Thg=(o z+!&~qZ`<-XY+Ka#x%N{{{(H>R@8esWU$=mH`M|Z1?cI>Z#*G$mQxW4OK@Bt6L$T+} z2BNJA{Td{})#{-$dmu>k#LWLakG_f|;lDjR6S~PCLF98*FgF4sIvKH)f&juSRO^mApD z0dTh|OKKpEHw|DDNKrakmujOYkJ#7wg( zmOu|>M5#~=wiT1#cJWKnz$_9`tYr@c=%^&{C3OkXJbYTg{9Fm4 z?E2c4T~ZRYfI}jSOv3(j0?T^^`ylQlPz4^kE5Vl}4Nc&?m~hbbKafWT4V4-06bh4w zX-^co8j9cUme>RF`*-yjf%*9o&aWaxMO#$$Hs6o`+MieM!42a@iEz_=Hayhmmq<_qibB|#hhA*Qp%6DkS(D@p((dG^)c-fIzo$x zI-%qqz(}EhD?4@9>E$nEX7Vmbtl!0pF5)sMzj>hi-h}9WReFZ@D*7a893UJ9*TE9* z>*zB6*GIp3sKd}FV@bHDKzu-d_8W^m?J-`G6A4Y7VZ1#uQ9uYQl)ILKV=&N05G#47 zOUn+%XXqN}lMut2_%K?65RM2#`!SvwRaihGN*7e}fLmW9VgUDY1@f3TNt7XhxssAV zPmvCya9n+@uMY;-COEP#6iTE=d>QFw)#oz$3)N4+Z{q0&Uf~=P>G_D+%sq^8_^2Sj z5{VPcCg4eWj6i4fnhCSb3dg3Zjs{?ni84^oSBYxJxf69bljKMMCsz+b<*nZ}id@;h z)``npBz3o#i@Fq?d1gCq4-8Co$wj=wnSz4D`_b)(*$|w_-Aiw*G*M2&zjLxcKHy~wB*)WvY^8L;Q6F7l8aZ`lRr>&6Fl`v2Gs zFx2YZJNW@Wm0>;Y%cHP<10k{10zeIr0mSbnB8`-84R@Y>*`e=IYTw0aBtoJt$`L4> z)OWyJFgQqeR%CnjYHCDdE zB=zuRXD&%yE+Iav6!7R}LM8&6(_kD`N$L_e?O}5y8~NF$s0I(&)aKKC&5~8z3wOwL zLiYv1+JghTOUbETB07iYa~{mP+N?dm4tXTd?LDR?8es8F5KK~RM<99@?iOH_w~%2< zpta&VIbmUgU7h{9#V)T-*|i?Fnl~YydzwYPF4s`E28-qO7!l;uUxq$sX-2%{?cP3i zf0f(s60mSvFW_r}v`~oySYUrr1S^P@wO!}4Nedof)2*=;F1B$9P1Y(GFS}= zrOA#Dh~$`B4T=>7jSotcXIKqM)isO{$+QexeUN*#IsQSRlfimeX;AjR;d5iA)+4H4 zgZ>*)pUbfRcz&(nzmFGohOIwo9c}*iNe9GeGm1ybO^oVc%=QNTm1`?xOt4&)GMA*D zPFN}4&!&46b0-K%3i0v1bo#)+l zAd~D)9oICu$*JO=A{@#DIP{wGD$ksBkQ7BHfN$yExBC`+Lp7NIs*Wo77C!jY1_n0A zyqvlDl|2H=6Bca$J^CLMO3DMwbaiMaU8CE3w^tKvg3V#c$HOsAHEW`E>VCVJN4F zroteK2K90VF}EPj5>e$B*m>h3*#~U__5^Kib`>#fp94q{AhU3r5E#?bp%XTTp&v_L zp8Jm}Ur6yT-UbQ<{OOc^P44wK8}Zkcn>1x!Vf~OHjZ3Cr=%9HH%iE!@6fjLIU=+FE z?|^}p@^cvj*=@l;`X2G-<`bmZq7mfQ?J@|W(ZYaD*#QfWr+W@?HFJr2ahxTo&{Qmf zQ^BY*hBjHqU2kInIoCUx`?lhO&eLyRAIHcf$Aq>}R_~3-&5(&MO#heg-JDkE8|jx+ z&^mlU?)aO6E?>r!zs-^9@qZ|DU|$~pJ{G@K#=YdTn_FX$$NMl z$QjG?5c=8XKZ%fx&RPv3LNV2XrW(`F72Kmfnw;?noXXX~-6MJxdh*z~;tEr%m`4PH z7BN^rcXAyGVPx>G0!p2`?wxnt&6$>nEiCU7X=PemP^KB>rtlPTc{7QGe8d=+fE&0+ zw9-q)VD)rqHwL%^BP=7XiJw#E*nle@U|Y3-?OJ2(Sg8l^aBTs zm3AE5IE_)M8%av3_n=Q#d1XRat~cVE_=ExE5KHA{LGK0+q@GiLSc`7$agG5GiPT*I z_(zVzxZmeJ2ow*>Xi2@xPc*Wu;-fmw?^IA_h= zgKvf4g#i9rQg*D;Q;a>pTja=o7e9(&qD#3lPSFyQjc(QVhe(CN@ICu90QMc6(L8}m zi5nS}V{50}d-NQcorHHrP}~F=7;K0&$dl_3JTeJC`rV67mNHNZl|zF=y`?EyR#-(e zaGp)tQUGiU>IJ~;Ax$pOr{iEeeX|hyJ{<^q0e=r;^8yYyc>YC#dp!T*uyMMh*2HZo zG+>02uoUNI^X|fFA<#xh^J|wzMYz!uodb}3fFNp}xNU#hJk8;B}g8C0eSGAy#Hv6AH6fw!mOJ${f^$UR!KI6=V1lP%Dl0w9#omA%XWUoBBc z9s`52x!XU!j02Iw^e^E$17CA>atpH{#nEJN|L=#uMW9Jbwwr@rw@btzJQZ$>61q`G z0k`6imvEs-fp(Cv^cWNrMiqb@b+R(;Ak7=f!2qrY2dxBDYdu-<2)=x1MZW1S9RkrT zun^L&E`aiu4{D)+>wz>w1pGE?us_B9e`bM4asb!Bcc?p21t*MdbVz{#lq8Fid3uC{ zQ0QrSQs#*e+r24gCYbI8kUoy#o(5EEx%UEb)e{2M=;Heo209xMfUDD%G&bTu!jvwC zp|%7kErebUpu%ov>sMKZ(-Ks1UH>0vcOBK_1NeRaTEI3KaM2B;J49mi2BTY$1_4oN z0a1{0qowsLDIg^!X`%v-25IST1q1{P40QK?&vT#Woag@Y{?3~qgZP(}ZX3L78 zL#Rp-|74Uh73O!t0mbU*+eEKkMJ?Vd25`1{258q9Fk1k4J+tsjp3|4Ned_(8X7@5g?lJ7MU35r;x93Xe^wbo ztqDp1#3R0^x;=Dce{}0-TxeYfCqFJIg3Z{*io0-xQe{XpVulQPuEs}7SG~kr*Z`or z`4ZWJ=%L(VfdTQnz>W##bPWJz9)LJxDJ<|JD%|_kE2tw=69@Yf*N;*F2&4;DuWwO4>rUa zW#bpIWY&G-P|WEZ0BpoNO(1a;IoROPW}PU&P?yh!8vOj4F$60c4O4qyT+w5Az23-(RS-aul40X$o@v&KPxA?@w5etM-m2%YG2 zC9!TRTCWU+%2H@6>j2!R`kG>?yJaIDH$;AQ+PD1P|B=MtJ?1> z!@KhtYGp09OQfZ%$Y(N=`jI2zko`OipXNx*cYpAsK{loYgd(?4fj+N}x)46A*M|B5 zfqK%LEmpER>Vk3Ub8-J#Cm;BBvH__^Q|J{AN3&4NE}2yWsDQ9pHm@&+Xij$cA6eTp zNumoYA%aGxXy<6?MFPEdVS|7%^0rI%jkuda^^S4KfAU0z5o_R{8G9dP0s=&bW32Eh z6hrJY7Kq2^XEc)JJN%h1RfoQCp3k_Q#-EvOp`cH;+dS8>$xTY z*yi(G+__shPOGpM?q#E++<*J*a%$mO5DtWlQYz6Z?z@2!VifOgh36F-IC?qKy7vlNuYs8i@*m^NmL)5=*!d!Dc zGxG%)9nJ(Q0=+)qE7E^}DkNPE{FyJ!TnhM32iYLAYn8GAaXwxLos6$ebIi;ivjHSA zFzKTJsgH&*v1bGCJOs0DfxjvY5zO~fgn)r7_n{=$7*+7caa`ig{bVj}Q5JqE zNaakhH+(@!0FYM$k2e0(;d}t2*m(N?Vp8~)Xk6=vXi<~Tmc1hc&D%~jWle*gORK%- zj;<-D-oKqla{YA&de8QB6ZBRGuW}RmB|%tT%%hvUBUoQ3bN)^OzllB{d=7NaOPOyC zjlB(;PeA}yX69gzM0GGbC;GCH&$lp0&TXcj8=2Yj7AHBLpQ~>{aTzE))aG`UalW(w zt{~>VOa*uLqbr4Tn7dFLv(Mmg=*^>y-!oxlD_;_J!VK zB8h`{@E608*C^I%d88uf5%moSc*fD$!_SQs+&=n`>Eh2z)zshrh_^j?SdkNSNf&9t z?NM~90sAQocvuOJayvx8OIajXDe*EyFQ=p`0-PK7RzE@(gS2#1R|T2#O$zuS1r{{} z)a`xN8Y*cVzBm&kR(g&I*i)Rq_GW$+GNKSbg^^)L_CBhU1dWMwT4WGSAmg9r_83n~?{q zIGCo+$cM6~!ktZ<)r=zHXgJ8172n4nf2Uu>!=g%2_pA{*K>Cd?$iOyj4qc!^X;}DF z0sI&%U5czABTja*#to^CXyJVi$VCt2qh^#B5kO~W8zmzvJP_I5&Xr^U4$>6hP$LvJ zNV3C2AKIHH0Nb;0P?56~?#aN|48PNiDp5pOCzr$}B?B*`C`VX~wNx~y+~rgaJ-%Oi z?5EwVMz^8P3eu*JqvA_x_^5J5C-Sut)XM{zOr}*)1e)Pa0@hMVxWM$iyIj{|ON3x) zYbZZ*x_gdeUL@EQoDDk%0i^3Ln1H!QdX}3`6F4r|G1SlI2@RfJ9lQxG17Oa?6#vrh z)Kc_Mrpo}9?FcD&RN6lMf*21CnM*C%0^JeJ@2Ii!I(Gg@aEJ^m8Uk3PfzQ%l<3XX8F?WU(p@JObnD9`p>)&RBcb+>GVF3)G1I$ z`-=Ud%1PqEznE$iv5&r^a_%D@5G%L!QNIAxbq_?!eoodAZ3qTs{Kn%!G#DTYR78S4 z8`ZEDx`ZRzu(clgbylk)o+rS7YBeGLeknA!#`<=fkLi_M|e!ZBjL65?ef}(LSlQJgM_{630KKr#(e*n=*` zOmQQVME-dli#ffRxf>(k1MSIh29Jk=-m$86uSSYDkY#dqS{J5yXu!NUe(zRGZ1uoUb zEtL!`N%Jq_4wmBG7C9*l^J@nS*~Q?8jPa=$&za@L_rKqJs5iB zw)A>rAzgb#yJ1;(Wcj!3DpY5UT6w1#m4$UM!91DJD~yc)))*V9^Zs=<%k={fCc&9R?tu) zTE`OI0ityd={u~^0~mA%fYuQ};}18<<68qqTY8yj^Odb$+*aEfeH)R!)tcVTo&JR) zy%!_>Gl2eT>_=}MdXG%{HW0mhdU*Q#Kwc& zpwIIE*4P*s-*)W%cepuVy=UjX@9=Louj9+FO!U9eEyGN7U-RZ<^WH3Ga|QUkSBgHc zW|DJ1SQ*{;fnj3QS>MEMsx@vt5ZHd?zSUK_MLs(2#i50*_NyB=)!Z4zb=DazsZZOd zXiDQ@?BNw2olip+D=e6`UedBGWCM}$mFwJ&n9hg8pyPvVM%I4}JXQ?D7%Dcg-4*=h zOn$4gbPLCL)S>wOCnMVQaFh1kNrvV6m$kJ?%L57gv2oV%c}s>d90T8Vw4MAGIeWi1 z=)@-I^v0bpu+@FFScdaD>n;C|&RKok27!RnF1bBS!3-e#{ z+SlOYo$TXfkImp!^f2bM6SL)_`@8?nm#)&Y0p0HdYo}Ad&t)RxxW}J_taV+6WoAmo zLDJ#h!*4&ezwrEbX*}l=b3^+t#>Q{y0%xkD$Cj2SLSK%fo6aPden?Y(pJ!x@`?3bu zjFo8LfuaQn`PS=tNr*h5vr{Ia4${Fwt$y;M%Pars8Vmm!G`EsxM>Y+8(y+rhPjWUy z#6CdmT%Mv)QnX>l!i%6~rMhR5(9226$Y5)(TYsw|3i0ws@y?CLJ&8TR-omfKSs z*9-U8rk-4UimJ{vpwGF~o3_*U{TuRvsFK$?i!NDvTgRb1NjKrkGqMGiCCdY4umwvW z=RVrgmYDE}O_ky?>Z>c z)WWlrdwi~0LIoK`wWrU9|C4eMKA&5>@FS>t!pU`{WQOa*HS9{9esfjrS zT~*Qkd*oHFdOs}WcS~}~%j~a`1+V=I8>{jx&tycq-f$=Ll|l(aUDX0Z;wtIm$KvXK z1n<85ydQNa-#n2dg%u~4UBSotn$T6@z*c@aTc@dc$aS?E}`!Gcv3U!cZ;cDV4v-PnN{H1Fc*}{ z_nASj=q+I(|d(je1fcR#+r6RPm7~aPZpVS?H6Y1%*c+qtB{Yj$Q%IykMwL4N%lkZY*|8QYSbC|D=Z4Uq3*|hv;|3&!1 zpXHWUOUvcga>l=ZiTNb63gLaKL*q3V!=Oy}?P=eWR{Ry&(|DI3|Egd1Uks+mK76up z)Tf3+YKW4=sQ9SO&T~X#un-H|`WaE82z7z!I=Nu|ho5mSbPr72xlsn#?Q~5yfJqW( zEQjwuv~_QfOKNXj0$sQaq%KI^zBoL?))GO0IcLXLYL-yXp$yIyGNs7#ZP2Bq=*j=K zHZ>P@<>u8h>{tJiE@Li2H|yA?dcnrk#dl?C&ykmY@Sadu&j!Cuem~10b6kvarT^T^ zZh80G?08qC@ROPW7A2Or%m9q&IVUVG2u#j+>n@F#RJka9?mpc_C7U`5Z>0)8pksS1 zX6DrSuk6E}s(s9+{qB1kanW3S(G{3~E!jmtF|YmG73E38bG1K5v+^jmixg;tsi*VT zcy#3BbAt{h-ongT4n4wz=Z?MCENf+E{9%N4R;Tab0`Xs7vOO$ghK@i}N?i)?~%? ze!kXA>tL$bpY-{Sl@^K*%8s%c@=#0O)x57XT4d?8%XDYKB&>?nFF0)7Tts;=*h~KI z_u+B|yxN36T~5)(Xy4ynemaj;eH@H?ZB3K?&ef?-hsj;JWIyui;-{PJ-p?TZ!NZZ$ zb?_GnJ{FIhi~H@jUtiPgL@t94`yjWnMB7G_AlY?2JO+Bqp00nmJr_(NN)zWjh zJ|0+9=`^$_{dd#-N_VTJ)YX^xhttm2hJMd=lk9Joi>+LFF_os8Phz7V>=z`LQd?iD z_!{;CKNFvesq!o>yAK+2GCN5ExK79eYhz|(A`N2zNvQn6)mty<#Up}d->xnn>Nq?! z?*8|+)zSR$!7u=e4}c(0=Mtd-LPSet;@vr#>#>tFZhwEwzN`Pf4{?jqntLkWexZ)U zjV?#gh*mPlV^e4&{^a~*W^AsfaUrg%d2Fy_Zz67eK%RJHI|6H*$j&$>#`|&VvZ5Sx z)GS^Z5g9Ty*QeGOl6kZ3vcPFX|I4G0>_jbZVb1vh6`ek%OiG)#xZ3<6?pEl7$68nT z6gIi+`a*N_&{yPm)dlUPI{DEjbO0Z$R~w6@+i3=!Wr_6HKgJ2a(fY)5qhK_=>c;)! zwomGd1!H$IpXNZccO?H5jH~_&z37LdjraC~FeWwQMbEnE5QkmzQ;L7E!x~Hv8GBev z>vZ%N;DO4^N*zfiDynzdWB58tsPgEvrT!EmOc zx1D`oETqne=xfE@C`8CRlQw_0{s+CQ$;VT^TETpR5Bp!xo|xV(iV@X)@@De=A*RmN zTXy#T&?Mrk*`M0iKQ8wzNmFskdO!X#B^d(Sw@3^~$pXl9_ z>P}bhPOt5L=iGfQts|62A6wMU^ssvZ)zcTLqleZXTgO;pw>{(-T`r z$gJ%Ne%%v1*fY7%bNe$vTC3-VDZ$F6r(3FbRipQgnSmNx{g{8RYm`CPU4x8*-oz&c zJgx?t?|Y+RjlJ=mHQ8M$Cq15`bzZWqm)qLB!!WAeh8JZUuPIC4yx%ub(YNf_XCAN>C(ml`kupm5ea=Mi@jtUqh*hNG`-=u zrT*@{{>(o{?@$9vT*eDB#wH0y2}_0?YW``+}niPhb~g$Uz@kp8*1gT6z9CvOK{ z)|viz`@VMQy^rS5O*6CKE<+uDW|-)qrnI53heHKV%=p@ddZ{bvA``oMlbo}mNA%{R zeCET_=9)`GFFp@NE}EL}npzgTf0$;D*D`lDH!pJ?e(Y~9yEL4IGF#v>yC-EP$v5&u z#^St|h4Q|+(V1R!o1sg(Mec+Cxk3wEy#>YM%-jQQQ5`+fvS?v;X0h0sXcnQ8gryDO zQj2QK2-X_C|904P(A><~av=hSw1%Lt@WfImJwTMnw^Xn*^dGitZyRklv$WZ_oc&2d z+YE>NjAt-@9v=a>+JSrv=&0kh%#^ikh#u=s8@o|7*4G@*qL>nuLNs(^SwMc=F+J6Tt+QIV1f ze)c#65ReAq;yoZ!2HiZcTXSEokce7dwu<9LY`?sA2x}%SF4YeY+v8@j)}|dt1{}CL^+rb9 zVe^SYZJUGPu!GZ*L+k!5CF#$s6v{E2XHM>}KNA`rhC2xOR1dqyI5o_jk6QD|U=xhJ6_#Vv$AqkEaPE z<4aRUGt-7liBnv6CFCocDZ^LFMlQNG@vpo}a~ffDYbwVr-qc%5y>r?8Md6V zS*zHCLnY`ABsvdT^tljb_t<-V-|+8GzhggZWF}lWrYvxBIb zA#?3fC2QBcI#$~~f)m`2uGlmFuwPbLv$FA+_FnsPW9^H!`+XX>M059&Fn3Qwdi}TTHM+mCz&}qB$aGJIdkyoiM-es^Rc93p7tYDADH)D%^v!VIddFpN#d_6I zYUR!Omlr?wPODT+sE)d5b2#X5=;<2T;WE7p1Y8YoIT-cn8<)75e00*Rs%6gw|HaTz zdf7x?S`cp8nFhI8C_5O_BfAXA}@~){@Ez;z*0zaC@-7=5w@JaaRlla5&VHKfV z)xv|;vLMN(P}Q>PpKH-*#4>QN^K$!)^z>x84^$ZZa?A*a?Cg&*2421o5o-2N!1?l=TzgKl>e}?b^_dypiZwW^HIcan9^VWT0EychM4nGX4atMiv@f(JU(y=CBz0W(j^5m> z_u9}5K5z}zH9ua9xDHaVSq1bGOxB^{H2TQK| z4n>M-OZw3#8KxE4(-Rk+P`Tsn$I!1!;Ei(34ViOa9~*u(F+8S~Fer&#n*3;2r)n+F zxrupXsCvg;?Uffn;=QPYCCRLHVX&)qx+r+XKH0%x?5bnGxk;XtX|jpSrE9K6j&85ov14qP9IQPM zW}c6BB))7)u7=57_jAgt)DYypX65U3&FM0et~bK*O0|7OZfNDpfXBC-gZmvr92~B$ zKG3|LqV?#$wpF;hQK-KHUqBN>#2uEPey8iJp_W?P#wJeJ5==bP2*$yW5v z)pUO!SMjahT;M;>ru?{Tbu0gpK=`NSzk@~(9FRHTEV*hfdExif!@+`gWkq#$;=}I0 zGsOQq{tXRSeS*M0nT-UBRvX7~jcT~F5vgobj{}B?8%BX)*Ke0Fg+EfDuWk}7tBwLG zSDCGR9$)wMd*_!FZbElek6twL+0kitMuhg%AEf8+8?=!tVp6|bqMpkiwT1r?nfdkb zM-)v%YNrvhA`h(0S{!QnG2Cw!e;Sd1xZU9p-0Hv|Q_V1{CggL++xO1Ri7$Wdah`yW z&M1|Z(K-%)L+c}w#ZE08{={GVQ`vNuClS-7925ID!s^A}=}WN#0kNquu|5|69y7%j z1V(2z#Adh0R*d|+J|DZq|8GIz-=yxpamru$N3k=cnE0bJB;+s6;a^&(=COJ(P}t$`yu)+Ekb-G`jA6^BS&}OB6Skz9=;o&)*a(CK={G z+YHT4mD6mloo}?6^s1D;7dTN*+u0@ed)m*f*!!!g!H~o5!aMq9KXxr!c_T_&lGTbE zI;`n(X{^X3+I-$$zc)`tSll@L*rM!_c~91+2Ex z?VN3fK7ltno~Ng@okI#mv43y(@4h+>qP&ic{?0&nM4VZ6aF0zpkSM)#CdXMygmcua zkk-X~=HkAqVApZrjD#m?oIRq@1DOFCp{JAIU z-0peXF}{v6R%akW7f~Am2c75cgE_$&x7`Z96z{qft~dP3!}7_lBaoN4daPJNx9-Iw z<_kDK`a~Jdeu})~&RG*4f0EOWglS(OX`)`+5+#t^gSn4KJ)KLcCPE^Mt8c5c^x#g} zaCCZyTb?A9x(js9Plnp5qqNZx9=8UEWmfv<6MZbqOpc&(rwF120AP1TztKSzQvP)D zjOItlzuB#$0ucvqh7M)Eyw_A{|Gp5_^!n9KoWi@mzyDlsqtIz7cJA(lnsuUNhOd+9 zSLvDbs~r{3^>W~Z$)GLRLlkTOJwcYL(KCB?4o-5Agbq#RDt>N=cM8&ZPX!gbZWwHG-R~!!W6$Z2f9LD>t9CLGpw3_1S$jA&k3WN}f=; zO*$91=;6Wj0p6kGMq?p4y$Sikhc-w5E{ltCq}+WFB7Efyl1)k@DK$sCOZI<@hZ z%v)_D0$*$TwNF~IV$Ul0CxHR{n{|eX2;q;!uf2ka%)yX^&E%&(Nz9nC`?+nR;^%7z zEkd9ES8^sQsV`+}ZjWI}F&Eb7Q-5a|$#`Gp{?_KpN>fU5Gx>q9x#&%f*P`}}W2po2 z>D*p}WlpM7F<0;Jg-j-n`H&gaeEEBlq(g)d^VAZQE$KYUP)q7`90wu>u9ih zV9UGpM_B%uIa&8)WwR|->ECMyyPb>zl3F*a?i@dhA z<^exWN*85K6t#sJw03X^OGyG^z4k!^*MlPDcC}uUZ&83oSPZ2;MMM!K<}`-UJ{?Gr zVVj_fTk7)Go#^4+8^610r)R^-y<@UBI1$Hkr6iA4`u_zYZq^R@NZVCVfrtwiYrxw7 z0U|Ee>D+wc{#V+OLV6HPd!sI25ipzNiMwG=QDKDt#ABOqfV8m+gE>)JHPjj+#J3JJ z@Yxe|SDbdXRLRlPuEAzRX6GloXt6k`yDTE(ROx>6X>Pl$x5AV8zRa7#S91K23+@nRdFd$a`S>?qd5LZM>6D2M!?Uqr-^ogly-I&n!}-PDrf^7b zC-V{pFz6{o<_;Nw8o@9+q!$K`)I*zFLvMt2!PrwsEN~2pamgcebnOF_R)|kK-2)+o z>l6~~gm8|pp-KEmPHAF1UB0If1vfott?9s$#k2KR9o6K~_hjH?Fd`Vo43moEq*I~;>h-WUd5xK7FhnCX z<~sCeumqQ)t*s=P4Voc=@2~ahmFLLYnb^*mny-v4AMB&=49Rqo&iG-!)eij$h)H`e z2r1y{;CG2jNOCF(zz^F97)ydclEvv7Ee(nWxa!C6pW=x)w*xc^+=IkLM=+>jQt0=N zK0Y3}Ju2JyO#R8z@q4Ov5lmvn1etOsb9m%qE^aM`2H8e;_i+CO95B&nzo`d{pwvpx<9_Zyzy1v zFUI}yyGoUnSO@vCyHDWCANwo+Eg3kUy7Suoxy?DmTv!S+)URSL;qNSp|jLSG|t6>%^bJK?!J-Kd9el0q(uLP^-N z`m_JE!{Wt*ge7j3OT?B-MCuoDCBWso5Tf%+cEpFrtN1fPd^9eOfl!MiODmJLpL;U) z46=!m0757GgC2fUe%&b?7ZS&;=*13th=4c>g9jvX^_X;tHC2$yZB;|P^gP}}JWg2c z)@8{|FTC*@H7HX>A|Z}QKyx_-vWAN$?=lcX0Y@|+*?gKp=0zu*XMw^+J26uu{8b*j z5etX}7YSuRC=|eBD_-I@A*PqbE{KRw4M@++n)tPg#vZJ5IKcpKLB~=Jjs%&P6>_y* zaIP+y9leJy%J|U)0k9NE=;C~UL!5Q-zbWMdF^KFXNlEGuTCZlU!i+;mU!Y7sHwAiv zg8jZLCQZ-AkqD2Y>tUl7Ze8(}B(SYqj$4lo4HpB552wkdbT~8Te%y+upmK5F7Wr92 zr~PkHJUp&bZtD-p?)ycNUv3q@zCScD?Pb=o)L8@Q6Yw0*aRZVNIxT!Zn6MxT`7eej zH=zgDB5^hYu;?pPZh}=5&!bGD-Ra_gN&z@UJ866vB+SXI)+9Kx#Dy_IhCpTxAX$%! z-JZTeSlK3g+#WsHwp}Ayp#YKmPM(30G2=KvM-O~`7sioWxGi(J2+zBthtc8^1%>3U zn#nBTxrRx5OJy>xc-|f;zO{?DnG~`RN4;iUj!W+qbAm`0ji^$ejl1cEtM4!5TG;L- z$kdadq91Jm5kQN}^tpsf+clq_>L0Rs>5Z$(~+LULYiMc;o469tCjhYKY1MI zd~ABU^;((9LIkap+5%NLxvaL}>8>7F2o&wg_v|{gN)gT;FOY4Yn9WgplZ*ZSt=%HuUHp{5qaaurW6vX=y@xAO)hr2f=si8S zA3nQI-^Z_zC82JwHowF-N)GmrXX=R;LF;*5ars_tqjVDsp*l8Mw3x_-mTBR5(jp-9 zRQ$Jm>L$K3G-ZyjStQz>A&jv6pYH7p=;kbZKGTlONLcPj_3T2?cMY ziry#I_4!@^7s_Jct&tQzQ=hupOhn0V=Z2)7wx=}S`FiTK^<+lbPLBFc0og9``Yx7w z4%zx{>ZgWemg5%6vYE@#$A9EpPy31gD|`5((a)t%eWQBx{~YY$zkRM+d6*e%#o@-x zbI+$j{4R-yK2CV(J)`xI@YoPX@3|ekfQNuyTb%H7!}LgaeiBXQ`~Bn}PJ=I*Iy(Af zym5^CWSUl}-c~$4ni#xMxU^e%wp_n7y$bWYmu?#1w#D&SeE|<=g$4ws^#-^ViT#(< zFODt`oJn5N^NmU95>E-dha{{N_906*3(8#arEy5C{$lQ=54Ic1l}j{+1gtbfqXF#i zgUDb!n@3|Fk^+b2%efGUau!gyY%02FWuuM`76JJj2@!3D?e{hAkIEm+G#;$TAI=0R z$l?xvG=BLfe?;4K)Fsd6(Rn1Ga3bDx!bnt?Z2GFB@NG1R1Bd@+-}GHT0k+fio$;Ahfx6gmMmcY$ie;F~)y(&6?5dSoO4wjKpGAWn6v>FjSx8>to+tYGMk6cc1QBId_#CZ=SS5*_-*-}s$P~O zO8J~ni`;`$q2Mh@0_h86kIfDp(3pqwA2~{Ua z1$1%{T7YrVGzXl|ns@%{Q}OFc65&rJ?kGtnKb6c|;M~FxMs0>V#d6myqnzPOx1cnH8C0^=Z@NN5`pyltfMME{$-) z|6mruUG}XoooCQb9}TcJaeS_NUgiV^tvJ5qNy)8F!R8SHT6l1{S@t}fB?8A{4)F8! zP_w|$gidTX?tj3CDXK4l<3K<(qn?592wQA;x;7k=saFs~gookq&&g0KrIzp?wh~7V z;^D4csm#wjaS((ko~9nJ{foNkA+w_mBxQ+k0PsF03-;j{E0wRf>cK%geI;&47;0gQ z!xlhcQvkC$j@7(JyA@|_1c;uUcS*42@FDteT)r;=fnv#<=5Q`o9Mc-r{p=#Jkr3V? z)|O#<>0Qtzl&~w#jwL~w+|9tYNdTb;MR%T73K2I&=4X=%UtYe{hPzu3kNB1su+*gh z##yk!rJvvAMfaX|b?f?&s>OWIDHzI#k}D1L;MCLD#yCx&)0RF#rBzSHS_OYZw$%0W zTOx9t!L+i;*YXGoOI;$?WNTS{S@WLU<6KMxV3JSrXn3ymH(pK>kUG;ZgdE_S2!eqd*^9X2#0!5Y#J`iE9Y6a$-ZrE-htN_44 zMCh3O1rz9deh_{F99rKX2}jlir)F)Pi)aE3_yf=U3NQM~;(q{&IIR9pubos0B%I?X z`I>ilkX4TYNTxo3OO^x~G=+FR`=^yTJTY<7*FQ1Z--x#o=c(2yq_q+&k&wumfT%oj zMYozR5o0Ol5VY|Bqe%d)0lxR&f45EV0ti>`{JD_C+mn=ROW)Q>;DZ6K&+>$Cn{8q7 zMMVAt)wHOjG*dE3&whieXp zy=R8k{k6))UqaDmX(lt^a7;blaySXB%@sfjfC*Q3zoEg6hU@a-){DRDmO|l<1-%=$ z+@qn8gkYWl;?uF)_^H>pW`GY#PzH#)r@y@HI+;KM-7us~_eB6-WFxXi#+uxC?U{$@ zs{j-Q$5%tn{7*&wuRfm-F7GdlA)geI@w#TRhmg?8knkVccsaN3w{?Cz!x^!H9%xyO zqumN=;3RM*EaQxc1t_B?PSU~(6j+KgViw6ryX8#v9GWu#>rQasw!c->4SF2o&nYR8 zsEG{^;_c&6Ucv?Agwvz$7rs6EhGYL3?9>W_MQP3R61yH#fCkX(j%%;gwq|OrYO}7=oVuzzg0yv-F;pY0xip=2OKN2{i zUNTz9@B#Lomq8k*)JLBXLjqf(ZII-Ce5F20G~?ekD>VUpPYn9Jg?wU=nBv38?ltxL zKZ!AYkjys`ye}vXH2rJW3)P3P$WaX0gGmW{)pzE!0Os?Z6sysaOP#Sdv7)^NEM{zx zA!XJe3n-E;x^=+=c~O#@D*Uxk-rdxE2ZG?x;;MM5YD?{e_oS?gs0G1WxqF*A3#7Bz zy1vG5n+k+uZ^XG9=Z6^>UmVyeKcijIb;%N>zfglz(zm1cO{~=$^zTl7OmYb0G)fhW zWsnhbmPEbewUXl2$)o}irBomy1;$_W*1+^)*SPb}KEum9?+U{oPcK=>B)yTnEU;W0 zOGrH3GamfUs!Uv;PR`e|)VTacJYyp5M0u)ubM06sLMYw33nf)Q-bH_I*t(lReSf^0 z36HkvVK$MS=wY=nx9Mef3Yh5S^h~$u``}r-{1|YA0|Z|G_W!@}AOM_$Qj_EVhw)&XEvTCWGXG06KDXYT z%5`4+OpV!7Cj+CebmrJnG4LP4qUqJ&Z!<-%Ev0=`9DaA7N#4HD>GDQK zv982&QA^0R)NHFKI>x`MwsZ0w=rMA*=K-&h^d}#?O?*2@sJ+t^6!=x;{oE7ZMUIZP z(&L7aUpfvuF0GwwGn%Xt3v93bw&z(5DS}x3y@=UuW_u+@*Q|dtt6b9Fd44$y2P8?X1@PV6Sx?5q4R{#P zG=B3iKwW)_iDx`X&b@GKVu+*OV;J>#lhBDz}`)^uR-d3Tofj$OC8 zVh<9BK0jOYEUS=6yH|FP^c(AiH}D73>rWA2-OYSd+$G+Y1O`MG(2Fr72thTVrQ4~`_M(w z_=;&|NV|TlN(;cv(PO1K4Nt#zer+n=x^-F9_OL{g!_~o_sh{nfhe#H?*Hghy^p&Z& zt9;6JGA91V17ZrwS!!D!O&Qd+1rn?@ZjCMts~qgZ?suy@JipN%n)UjAWD*<@~4?-NgA(;~sNjg(al7ttb*vVxw( zTLyQD>J2y{3vrT=s#`8)w>es2CQMDTB(BGk!oYe$+{uo!8z7-`C3`G-(acb7#q<1+f(%DLCFtLsWQgxh zyq3P79z1nih#LN7@@47brew0E&;*cJ(urLxm=Cyg5Ba!_Uu-m}%bhPhtyO=ll_K!Q zXwOOo{sRzU@lz>Y` z1V}Vd0IjIP5#W%)f;^FWo;uVN0aHc8T=6~oD5IUu_d#Y%!yD?TNB9I#k6Nj$RXS3K z8imC>g>=CHaGc)?Fwz7j2%!!FNWvQSC;&@DU=4lXKpF(li3QvM5L38-I85OJBJ`mW z0>}Xm3?YUL^nxIdAb>UuBL4?BDB=qh_=N!0P=O)%fs;)T04*kP1wpXj2nu=S1*0g- z=zVTCw;Yf@w1KmM*yA1Gs0Qk`x2I`bV;t{jN1d2aE@3>0W;1&Y8fF=YWM1fF31Mm=t5HL9qJyakew>ZTM{xDDvT%?Iy z$bmpwae!DPM50!t=!j;Sms*x2qXWvFN8d4yYfOWsEhPppa4`#5z~UJU%g#&@Vg;K9 zF9bQ|2M5030|9We1c4C9F97h1PFz(WC13;x2_GY_>pTx`mvAO4QQ|jafD$5V1%3s01F2| zgk$*#gENoy?8}IngD`NI5iFVP=F@{un7dLx4q9zs39_73jxT117Si4T5XA6GFh~O{6&fN zWFy=FBWl1A0mTENiH3|+lRVQEfHs0)0S}-66&B{MW<4&49}vL^H~>I`+~W!k z$Up={kO%>cA^!p=V1arE3S%vdRsdC)z?dl!(cH?bqWYCykf-8b4FTB5VncF7N+G|S z7D7x0i3UawbQODQT0XCwAt(bQmTh#eo zn~Qt~-1kV^$kZMR6*Q|AbGYHOj977AD8Xlg*!s7~o}jMV%4^0zTR7hiaJYYxf?{c9 zvaJMyYx6RNC>-S7&HnSK1AS3^_4iQucHzEx((l=zA__n-Lzuh(fG9|T(*lSD2xK4y zKioqKo&QKe74Ff7Ap~I!Q5C=!IMD4@+#mwa2>{A0kYk(z5gq9J&5`g00odRR$`gns3P1~i&;XMWDDQK5VEGXYq~Hga zy8l_ESbD^q9wVq$&FUNH^_x`O1srJ71UT{gf&^axa~CMdY5;;8++YEHw^RZEev|+L z6CecWWeFDs1y3+pYzGJ>V0qjp5a8!-;+G%f$8bRAa6*=PM0RMa1`+LN6BU;O<3te0 z0003uaC7Gj0xch-UeaRxQO5AXm4 zG$;TWV1ojHg94BVA3+NR&eDxd*UU=9$VNdoXw9MAz- za9JW?idujL0^kD_KmrxOS(dN?MDPI;AO>UQ0vk{PNw5=dfCK~a3NWAnLg0i;GkT9$ zerQ2;jo5AfRW=Wki7TNE4gf$M@e4Ty62~A84B-y9a1oZk0RnIgiRx#Gmv|7~coK8q0WRFYq za3g||L*XHs(IGl>mHm;GP~?=k29>)em03rXvhff6fCy<230m=EAOcXJ0mQg0IN$&g za0L{J5bn?ms=1o1*_yo&3$fsuvN@ZyS(~aheBV zk)0uyJb?-dU{;yn0It{*H3kHxiIfUaBD97SDIyv8$Q&ri71(%>ng1DWn@JdM&;mV? z0gA9Z0zjRcVG9y)G&)f^ZW9#r={B2lpVX3{`uQyU*`KF!EdaVN_&1Vtr*QhF za$2W$`lWPwr*+zfoiA9qY8+csH)(Ci2pYc|DXZu*%BS{pkslZ z7SkO<@f+Rw8~T`%aEW?yxf-OP0J`uGp1=T_)(h3gA?}G5mRdKMDjb`78=VTCDj5;T znHkE-6GCtTTi^j%K!GtR0Cd0u8UO-3AYEMXs-Y9Bn!1&3*_9jkl^qzWtC0_U;04Mm z0GyzGo6rZ~+6QE~tUJLM&UzcODjT(0b)SlUESa3;S(O;UtYmSna|x}<_MPlXtyLJ7 z@hYzrL9Z-fugQV0^5&NG)~@|%tpF<$0^2qO`yB>LdI)=U3cHdF+pv03u9Xq7_A#;5 zSh1#evAFuKy85pgyAThnuOhLXk&&*ev94ATo(>6?4F9sLFS)WJ8xt;TEFgQ5JG+l0 z3lX_088{n|IxDR_(X$fsv)&oBp31M2n6W84uN>eOnMuL4JhQgy+O|pYwjN`%aW%GNYY=rioOheH z_iB<)tF&(^wK*xbgS)X`k+nplxLgahwmP(T6Sk3Yw3k@8_ei! zCAg705TJ`DqWiL>s~R%vwVFFRoa-2#i-oTX8iy;ZvwIq~>$YFJxm4S_DtooX5xYKX zxonHM`^s&q>us!yyuB+C%-giiySLCgv&DaFK;rqUX8^6Vdw!mAz!h63zfx1yKp7>V1txLX9VZLM&yu=B+ zL@B*-d$S50xeV+a4vZHtYrpDCytk{r?#sUnk-^Kd!RKedJTbg|o4*yAyM(d3bnCx9 zIlpQvz!B`bH_5(nIl?4-oix0ZHk`O@nXez*!Xf;^`}@N=5yaU!6nOi%&aU8cuwvUM#U-JjP-?tz`VTS$xJoJh^N9v26^; zZyc38460^K#{|K}J%PgQs=}Q^z$@&+>i+@5fFZ+MoW`(v$6A}me0;WUjG5EBjeuOX zkld`2T)9Pju#B6qeeAAF%*2AcAD=wBl-#(MtjCyK!GWvAh?dH<3>1j_#i2~GqinII zys&?~$@tgF^}5Qk+sdT;%9T8k2)uO{Jh-+@$faz^H^IWEtH{U6$a&$&wM@(dYs}5N z%OTs#Bm2u38_b&=&ETxP;taIp9Es*!vZwsR>I}g2+s=!t%&yGLnS7MO+`o2g&o_+E zm;25_8_!@n&m>&WP@KzbOwiA3&`}%5?K{W+9LU}bvFm)k5Y4?3ow*2Yyyy(b4E+;P z%)t;$#fBTkv5dvDe9;&k&OY6{hT+<$W)83oJi>%Q6 z>(gNY)RQdK1AN5SY}DC|)bFd*H*wM_9EJLv%sK7SI}OvWo6(3I5m;TwTD`~n+|p%i z(O_-WHc{5oeAX*{$;H{ss`t!f>(+k3)SwK7!Wp_MUDy4rnLO=6dd;(Z&B{)l!`K_x ziec9uSlH}y*q4#m$Gq5%t;2Nv*n>@;lC3+G4I7pn&VIdcM7_Qg-NS4R)1iGFqs`8x z4UuTg)oLxrFAdhiEYl|a+8iC*T)EZ0oZ5c8+85p0Cjr;O4Jv;v!7MGf2+?(AL)c;)&MccV}{n%z{JZ)j!A%WaoO_Qb#+~u6yz)aj)>!@)- zmaZz+P>m7lUE7q|-m@Lt>uuX#O~mEhDV2)frwtPO?cBZ{t?mua@O{qm-PfDJ8}Vu1 zFoE6*j@>AY%m6;uu*~3VecKP5BvMh~cLAUBnH2^~E%w>s)IvZo?kh4rvECFc)*>$8(2d)YKji11=k#Z~_ca0{l}DO27dMAOc(^=GHFIM4av8yzMw$?D5U!sv!bj;0|lR0nsNA z{4fQhU=Dwf00R`~`99P4%xmE^aPM2u>mxDi(O&Kj ze(n>U?!ztco&Qk>;Uy3v5mSA}? zFc3MQ1yff7QhyMyFaQ9M^#C9RUE1|t|Mg%W_RDY!w;=XrfA(Ns8)(1wY<~>2!1iz- z_i_*SuQ2y^fA@A@_j0fHc;EMEulIf*_=3L-u`sBEfB1KA3rL0deIF)Mumq4F`Gz0> zcTn>J00THb5Yf;ANpM$z_6`RwxC4)ey&@sUvp4zLsXPyw1n5ZC|%LqO@1 z(ep!JC-}1gs z?7$!M>;JwQqu>G&zyh2g5PL8Lweci;fbSi9?H#V&xIXBgjub<#`L^E{mfq92&)vHX z^tCSN03kr&z<&b`9z>W>;X;N2moOk$X))x@kvVxboM{r{PofAv?kt*ADMOS*k^XeK)MU_vKBeBY z3i0Vxnp_W3B{|fq&7)(@7H#@->&>WVHG(~u)oss>Yv;<93Rk4qxh2c?1za*MPrEVO z24<*tAYQ~c>o#8ORxwAukTw3boSA7#wM!3cCTN#2=&Fw`k4`#yV`b6|F}H3#_-0|4 zpZ`g#Mh)AcX~?;q(w4|tw^5M8V{<0#`K4~$#u@rH2z)Gb!qOoMcP{XC_QtYpS}$oE zbaU8q2e>Hynk^NJAcbTsA|BTL${H9$v& zsZ`#IN_DPPVQbYbPv-=6zgcNj$=3dq%Jo(AdhGSAUkMFXzF~XkX=v0J~J!{w2)}7AVz1kF3RC(jH_PcXi z)0Z@Uy=vFgce#sqV2$XF$linSH7jAz7Urtqx*mp4V2N*{SgV6?OIJgV)$_L_a6yZB zg4fKevsQeTc!+PX+@T~)`IJ^IX|37)R|G9SMwQOpo1=U=md*y@c-xt}>J9@hbMQP1XZP@k^tOy|#s~U4A&U*dcr1-ITUjcP-%=aH#W$bW z@fRV#Q*uQq?>Frn6A$@wi91I~cY#9pYV;D1HPUt@|6HAQiFp4Cc0^_0ly-(KzYh1c zeV3Q{=$y|KdRC?HnEHk=hfH&&C_=w?^s)Ebbs*yw(tBRPXW4jItyi7>PuGubeboqd z3inhczkSiqbmF@R{#2B_?iD0`GSMIB-1j5_>WY90GvHEAr<2qzF#m$?3JnB5C;;sd zq=HM^;Pi-hB?P)hfjeSgUi>!`swn1x2(g6(X1GHh_7Ht2@nH~!I7A`_(IrJhViJ`& zLjf$&iBA+_6QMXoD$=luS9Bsqu((Ae9)*ielp+&r_!Rz4YJy=pq5YPnt_&(Ag%#@{ z3`h7e2g0R{W(*+wvegwfuCQBb{MHM(6hjO8Pl{o@qmRxwr!;2lf*WgNQr@VQI1X}- zbPS3W4cVea5~`7+dnD;1DWMiBgnW%L-{wk)o=*lZl*2REjR5&CYV&x{9H!ekSt)SJkdG=GB~c~`luF8qkm*dwH}#0FcjnBGJDa7;1ZmH1_DG+` zlpD(WiL`$zEucLUCO#WiOk5@OW(&PqL$mf!rbSeu8#!o2sm76N!Ji61FtdUn@Go=Abs)n*^lct_et$$=I zUfp`Xv68hRb2ZFX$=21$eYJKdRIq|0?EmZxt3t$vrK(-K>Pi7yo5w~j zveBDt_`-U*%kC|+AKffV>YAFn0yM9#-K%B$x>$vzRwb(~%2V}9&TJxcn{cJ=Nz6)9 ziQx7(pZ#8F>sQ%8&NjFQv8_prtCrR}^tINFZF3d-+}aLTxg(iwb&xy1@6L3z)pIU) zdFtKkYIUSB-Bx+sSV{qvHgl(yXmrEV+1QP@fbx|jeGzg>#H6w)&R9bg8j+AgfZ+;v zV6RE^OOo);rn(z#?@6;u%k6^Z9w)c~7%Cu#gYW|eRp0^&Sa1(Kc4nV*^DhPgOv>|) z&%Wiu?^OuF0eA>t$GCGw0Y1^<Pg>& z6bnFgsu!?eAXH%>4xj`=ToDQp$3h_t@ItP=010>W+Sk7ZcCdvVjc5ql*vCe8vX#AT zcZlN{%!YQfrHyP|OxxPmhIX~Fy=`s-Tie|RH@1Hvj&PTI+RiApxv!lMe)KsbP$&Y5 z2C#~Slwb~7HrSSd+GT$#S*lDHXnGs-i2n+_FlKA%J{bf(~`a#91Z`-k5i9=Ax`QPizXo-)daF-F>-x_sDOC`WvhOhiHed zF2StRwdn(VdO1zj+i+IhX&c|q((iM23#OgzV!L}<-L5#e%SY}VsW5x&e({>+-L8Aj z-Pqe#_P|bjjb8TpVK*Fbu`B-X3!*y;;~RO(PCo2TRy^5Vj8MnNW%Cwqt2q-3`p}aw z!n`H@)+r8o)bAGKs|RlD*UNa$mjB)$Q>QWKMGN+hR(|Z4-$>vAH2Bo7o$xTlz14N^ zdfuxx^Be^}n4^xBn-65nfGKm^kgpNtQ;7MtFZ}cMp7FO&pZcR0sq7!$@7lvw^|Ceo z)yMy#>k~iwHs3y*_`m)^yz6nl{VT5i^E?3_T#$)d_CujKYrr6j1s=(T0o-`IPSW@DDgf1puG-6Kj_0h)(gEC9Fq*Zz4`09 z`ok^_Y_is9JIUr2p!>Eig1gA4EYQ#IO~lDlTjwHrye6BN~0GtBnk8! zHXH~Yf<+)IMlKQnYk0;l^2KSqqH458D#FHWgraCbByM~nV&q18l0dt_L_v{4yo)^( zRKg!*!XR|QA(TFpsUu{}q;n*hbcCCAtipDj!*{GhA*4JgteOYXBxP(8eFPjvge*^# zEKm$SI}|HJ6r7N_NB?|8M>mu%PGqg~Yr-ik!%jTI5S%_uL=}$AtqapIfLzIV97rN; zJ(Ii_lsqnn1TBcvK0>@hitIv#^c=JjNjbbiI&8@#yg``EL7(g$pzKJSOfH-RK%JaO zg492yY#xR@M1LGgmRvH4BrQr@ESbC*nxrm|gh!D4$S{;gG%P}^+#am#FQ+6gsFb?y zLlII0KT}j5u>>8m6fe2_FS>Lmz>9#bW0P0OPK>q852wav`Yc_zP<>*uR+Y;@kL{HhwPZ?!TgoL3XrIsRPN1?<{5dFFsHI?pk(!>~}&sm=uB}deWPaNgPBfHK= z%+3(q&j0qH2rb>xL@Y-!g`+P$qY(vC1Ci2xq*64sQpsD>k8x8wO`kiuAw$}vM2gcU zs?jpq!$iHQF{Mlj8_>nv(U3gQ3XRYUt(P`!QYPY{gZ##d2%=E!pPhKmP!&}~{R$M# zL^7p9Gu_iqOw%j<(@zc5|Ky)s)uclj)KpE?QZ)$7*i~K~)?|cK6_q$6{k;!O((_c$ z^gy3m)z5>pq7b^rV{BAM6@XJs#Z;s^@pRP{RaO~9()&zL8=Tf??Nn7I$6kHTY9-ck zOe8hrR*S4hO;w*`EwVD@vNM&{KJC0(ozs7~)sI0$cy-r!wZvo$2`{oodp%gyxYM`` z*Z*Xl(j#@pW>wQ36x4#1Q)@lcU)5DaouPUKS#}K}aE(-^V^L-`S0(*X`ykkL1yVcm zRfxsbi_{DMG1&{L71Q&`2=f7Do7v zl>OV7zy@ppji8(=g4cNVHTo6JwUz_dTYmHb<#b1SmSN?5Ygm{AyKsOR_gM^3#7eIidQ^d!~ zQO!%+9$nj-++Xx6&-vxugtcE{eNV|v*vnN=m2iPI5C}J50i!5^Pbgso=3LBM;KXg< zb6rvhc9=E1*;Tz)QdQo62;V|oUSQo}ldu3r5D0=ph$!F!0VraHh=5Z-T0eP8Q!+j1UTNr{JphzI(J>6#XRZO{jUuxZ78 z!#m+pv$UbL0FEu43DmGx2LjEc7S(*#)@7+7^b~5{#8-+gQ5rqb{fKFV!0C912b>mw znAV4FNQjfQ7JzeTqghPs+fHmkUCKw@3ICkU>w?IN!Hy6GNsrN( z;=$e?53vvDoZ%&kY{~W^%B~`qPVKn{?Xk{k*dB;s2yKI?>)76Hzm-&`#_P8A zhFNUzDV;&|N*Ja}^=jikeB+dkV-*xgI?kVLk=Q(*sBLb%Zf;SQXzxfQO!&UdibTkz zMT-Ou@WZ`b299V4Cf&&F%zX=L|KgJ(Ay zZyjg%^Y(8C_iz{YaVPh3H}`W#_jFhHb!Yc>clURP_jng~PLP8&O9)!HgFsm0frtb- z=!BaR>gGP`bJT@A_ycc52zWq*IiNQbK?FJ&WdGL6@K>k3j-~cE<2v3NB zAbx;fF!7ZHegs9pIn`#jZ>h29;g8iz%tO0ffG1_2=HQOU;r2(0uAT^en?4@ zrHD+3fFW>!6wrnT!iE!Yfgy;1O$doMD1asij9cgc8{mNoXn2Dd0uV@o3DAS%wE+(( z0vXr?nTOmOC%+ir`v_RDgE)h)=YS~?i2q9{`y_yX*2g3$A9%S}0uLztdpigmNB{;% z=ik};zOQ`~VT1@cf)kK|HlYYTK!6DNaf+~n2DkwsfPf~4ePYpu2!I3uXaxmmg@XVB zvCjt^3LPQ&|30T8IfIC$LZ7HCH@FK>H z8aE2~_phTzj2{2tz#`yYi8><*$~kfGUzHpm1-KH?qY1~HI(KU1VuN52oEJMe(DhFc zhkXCGun>1~a zKv4yF7*)Z`@daVltq#``<~fqZn*V>=I3Rj!>)0OBnDj<8|hdE&#;hQE;+FCL1aP z{DPl{ExO3j9VZ~_@!-@X9M4*!3o_ zS5>eGL7p6t&qYb>=TQfQz*9gG1VQmrw1u)&ZHwL_guo^jz0s8bJZK@nlWf>A0vUv% zTcnaBLvh4RBk)n`l>Y)qOr^N_GWX9W2!NE}thI{aftnD@{PSjt2uM&2Yha{6#R8~7 zgVHh}q`{m-5(+J$xjCm1Yy{Dv)&62qH)dbWSGZK@cMuV5CJ49r4pZCIVDYhm%83?K9QO9r3jQ#M*KZAs!&)0%<3Z zCIBT0+@tAioi+&9OsUO80VFIVG&w=Uj?Fj8{jK=V$vI241_!J}PCM`${i1-j%P`QS zIL8oF!?!p5)d>UieX@Y^4tpx~^|j{IgRlYsF$F=ljGo5`clIFyL6A(KoXof(so6g+ z7%cz{X$X+dE&q3tF`)oy!0?YJ`XIm<)F5iXy9gA9KoBVifgrtbhX5Wy0dxE#5)%-| zKY(zBj+_BwSCb0KtVNhRlurPBK%W4X!4O*{;1rcp0NYY9zeg|tV48{+>KvxMOE`cb zns7ig1YiyNK&oXVyweE}SSS$i;UD}MK_32bk6U!68J*6DXBo{P`MJ}B^r>0CrH3|<^aGY1RxF&^k57W_}eWO zU;?usK@$1O6$nRy2nc-P2pU+?DvI?FU0eVOUvPjTG=r}$5(E_yfC3gAkhBQ|f*>xa zff+au2LF$6VggzCf&>mhNB7n7P#zj&ArDCq8q}x>Bk14{*cAaUoPh&RC=4Wf$xCV0 z00w6GKo$tngu)5n4oKJl3Xl*9K@!rCe&0vY~6 z2?EG~k*r7(DM`r>KS&`C5EQ^D{D6>5U;zxqB8WNQFoi$dNsiM3C>^WCB8+$f3tm_S zLGtkiHvYm4RZxyI+@MmGj-q`GdY?xsQH3zj!XwdmgEc<#iZEQ^5)FF9I0ITrE@Yue z1hGS=u(5_I7y>G!(1I7N6it9a(nTdbX+jbw0Dka63Ukm4K`6lmEHq{_zLX|R&pHxu zxG-S~tt5yf7(tLntkexHt(-~O*Ts=Mq6%iXoh{zb9kK{OrG)qgNDHe{HEpy-0RaFZ z`2+1unYt5rYt#ZY9RP5M|WhlJH?B>Z_wPcuPz@`VSa&hT!YRQjbv)58Wr~3@4i1}HF=EJ<9XAf$vU5er zJxwdNOd9Xa%}Q1C{VbbnCKeKEs51DcND4MwN4Hi8x+H3zwfV9ho-p}B*r}bnr9B*; zhBL>Yv@kekjEgJ5bxQxgTRi0Po8#RsXMQmKLFmZcW2N5OkcO4f5`;Pk1Uy#Z?D-_0 zLFd^tAXe)IIMi!S5q98H^pPgU4Fin;2!H-v1)zchl?PIRH9Z(rf*c}M6MQK>^pl5_ zMVQh)^|XVII{Q#`$Bj7NL5cuV05K2?Z(x|vD+D-TqytkdqvVoIHtA%O$I$ZRlvGw} z<&{`wsU?-KZ0Ti_0(>dvm{)cg6q#tI>13E{K1s_jZN@3*oXhkg<(J1OqYO0EBvXtp zxd7@5purf^Ofj<dkP5Mg0Ab)z;U7XK6hSYX_A-)5C757Bi3W{&Qwe*K z8m2|6E@%^qDXRY{>#Vej7!q9m*drr2*HF`pF~kTX3^Bw6Lo6}HG&9XL<0xZKJo-c% ztv%NW1B@}*=wnhK9SEe&0-R*p>bQT|niPo~+6pU7wQkj}if2tjY%ste%gi&?bVJTN z^Wei!v;x_K4mI;KGY&ierzFkU~Ct? zThP1k3dPK@zzBnHH|V_6PCfS2Y_qPrUNg=-P6_V zW$j>T?IQn#GK+^%l^ETG7v5E?cr&LrXB>I$_umw`X!zumS7bL&i4V7UY_W3vxZ?&% zUis*xw}&{Zlyn*4T#C%)I z*B}4--rpbD^s2reqW-rM9N@NRzX9U!fM{u7>c+>o@(EBx+C!iO*`>hSF_3c(jLQT! zsJIGJ?^PqiActVb!4et0E3?(Foqe;qeQjeZw2q;Bq$y7$9l#V$i zU|gw?RkHGuhKwX4$u~kb-tw0x%O%z%i9<@#5}0#4rb1x37+Ka$nFp~YGT#VIgfLSv z&g^0}3nI;FnsJ*18s+zP*}z`j(VMIUXF;xcLSi;iodW45I;9BDfv~e&?gXSF=Xw9j zdJ5#8e930x>M747MsO&VP>ALf7ymU^^AAf1aq(LzvPUJs{4 z0gWvrP(b_DrKwPjs#K@?w`EZEs#wix{j93hu6k9gP5G)=$J$i$k=3h%%c)hCI@YJ2 z^{sGK5m)0%*R#&Gu6XroSo6x)teUm2eG4p7+Y>*YhRmmgVQ2?u3elPx)sH5PEJDMh z(|{s2EQ-~fNKr}BlBR4$v(k`wQg_+Oz|^0va%dtWT3M~Rt7M^#iea%<+J*m~)_t3u zWoNlK+q~5lIhnO#ZlAf^E%sJ%zn$Vo#kpA3^3t*Al;Uwqin*V1D5x`ZZaJYVQ6o;* zhRHQhaKp%0EV350eEIHCtDD%{F0i~~+@~4U3t9GJ*1Z;lFB|2{+tJ=Gym7?u2enJn z0NE6O^qr`EO}pHfs!_jn9#6T5Uv6fY(MaM4o7n%n+_kau(u~bD z*KN$rEVJc&++8$Rxu;hKZky-0+(C<8R4@GU+Kr0uh8Wt|9_1We5{`s)37Vn@B`R4f6y1$;j zO0ZYe-Ymbj*ZckTgonLa=@lE+4kk3RBdly1lQ!1@Hggnf+XtxOBwY9xzNejBamx`PQ_>_JyJSZ65Dg)jSM0iv^Bv zf@}HQsg}2&>AhWhH<~?Re zXC=OBfcuu=E_QcA_x(^fqxi@3UN_E(tn=pbyxBkRbIn)o^OoN?-z7eJz1ah5^(nk# z?6#b#@hNlN(mdfdNAA#_Ty)KLow#3@;njDXbWcj74nMZkD^B%~ z2R-CAxp&T??&iH0xbHxpxX|y;;Jk0!@GNIe)xEcNMYp}vZx89&Wt{dHR^Fgv7jxNV zee!sx`|tk^J(~$HZOAuW@_tu5;GK&JAuXK^m)XfS7Fn}=kbcNce%0s{d9z;O_* zkN~3~S^}tj1Xz17cYEfReblynb72U8FoGnwA88N+1Caw-a1i3)0!@GrL~NSK65h=fMCgiiQ`PnH33M9jQDVi%w^X2FQW$#*AL)j9@2>{kDsO#(KCXe{YC^ zh^KVf2#qWuctq!o9SDv{H;&pUHO44xci0knm|efPjqdnuauJVFF>L5acIsG-_eg&r z2y&_Ce%%OvQOAx`2YZS4jI+m$uhxrt$B=yIkmN{r?}%~|scQkba~64c7`c%f!;kHF zj=x7r2MA@UXlAR(K_=Od`%{1zw~}Pmk_Z3yk{cA07dev}IE|=ijcA9B8flI`DUCHr zjUdSq^T(0-_-`cHjHSqnr|63z8F|$adk}e$zDJY5XOnq`lae-fp2vRmg^&|jl@-a9 z;kbxTsd7eX68|WAA8B+~`FdITkac!YGr^Za!IL6+lvD|nR>_tpnU@(kY7|94i}@6Q ziIsAhlC2SZJ|vc%CW%LdQlKG#kBOI&>6I#}ly+&DGT9oFS5CacnP#bAXz7s(S$KCj zfNyD8zw=szwG?b6R&E7YyxCNJ*_*&wKff8A#Q83JRh-C4D}Pm-!wE08c`|<46P+oW zC<&UA36`5?nH-0ikfoU}(U`dyk3_2~D->o#0s%(jB?MfstE$)fY=qD%p!Dr%xLilm<@pCU@1O-iJsahlJQq6FEI z+4h>PN1`zbrEn>wHApV%s+WxA)?x~mxar$c(D zp`oR7#;kSbtXemzEQzc+sjNH6u9xPnZU?V7DX(LxlM{5U3c9I-2d3ZXs}S0zxJoJj zJCwTmrMw!Z23w*CTdiZUu(>L*=}55a7_nnIu~90nE2^z&YNg%kq+QCYJz8P-ih24P zmi&5|wmPZ_YpD&}r{(|Zspq<(p*pi1VzG=`vz&Ufy_&OZy0a8ZS+1Hy#CjRB3af%) zvT^FM;i|H&>99fzu|ylF>6)j6Dy*-%w3N}bU|SL18n7s9kW|~1XnLIk8m(gbq*5EK zASiGr#ic}gL~OmxOBO=OBuQc+qzR5 zVk?V>Et{P$yPYwsxqZt=f9n`xd%7D2wX6ELq&v4$8lWS~tszmi3`?!9i@Q~8vv!NK zcw4lXySV{!xXJ(8xr+O_jLWfbYrBwZy=v>cY^$cUE3xRiysta1R-3&;yS-X_8R{B5 z;LEwNyLz%an(y1O@td;hE55NyzO#$Jm#e>A%eSTLw`02)#ml~GfxO=etnz!n|7(5F zs=DUuxEgH0OqRR!xVwrft!AsdBy45Z8?^R|wG1q}1&p>FOuyJmr*~VjSlYcun~1?n z7Q;)yfvb7FOStsChQt0e5@)wy=RMh^Bb~ttHavM!|3Y3dn>a+{74hL8bz#! zgG+qBTd&>=voAckS6jI=T)RG8y(PTHp4-Nt`^NAa$G1Dj>l>oaTc=u_w_KdLX#B;Q zG{j<@y379<#TPrpvd6q-$dt;+KTExP?81Glq}vL}(Tl+=Ji<22#|R9-3M{~Q zOu%}azNFm2$@syGyt>IN%9J4qFaQEfU=0Rw1SkLkIgklJ9KpgH#)eVBehd=Q+sG_T z8NUDlZ(s^EumlCc4{MMKqkshw;0&WE%tB1ee__m={K-8$$Z0$fYp@*xzzGbX%Lj1} z1<(oG49UZ4yi7aB_9)94Ji3>m1TQEM2!J#NF$$D01u5W#;VI8wOV5By$?M%)R8SOsKE` zo$wD&U?~D%2ZUhOqwo-jpa1~vm`mJhbUeOxT)qQ*zN_p*3 z&;T5e2ho$&YP{7~+{ruq)q)(>U5s_^a14BD4dU_Hhb?YRoILfoW3)CCsoYY;M%X!_JxjnA46iol6 zo3E|i#0lNv-J9fH-hgG@=nYueecg${pQ>5TNLB1b(5vQP&EsMXyxa`N3QfHBY};kbhq?c4xUs!( zLH^)F9^rF7;bYFqT(0B-j^hNb;~(zlsa?o{e#qXe9EA>PhaQQEjzB*?-z|QsaURP> zp3gOmBg<-2#)BD4(E?9=U7hXv2N!{PU~Ji;9#!lDL&~NeC&A6 z)mHA+xK7-<-s_=}>Sp}wtRC#H9_dD2>{~hIkzD1IeC1)D$IjluZocZz+UhX=>iI41 z9*WSWE6MfD(EIAp;fu+X-tJvq$6tQO>8{G_zTyCH>B)}i%UZA3yto~F6L}b<|Cf+wZ8IAe!**g?IC{9JfF}$Pv|z!yEw1a_-X939_^!T z>zUs2%|7)1Ui5F??Iup-;1265F6#-8>;kXs1RwP34))KU_2r)D)4u0Q-{&vi=}L_4 zB+u>d?(Ok@_Vb?hSikmKf96P^=6Rp%d%x?bKJjc<@y&7ZBA@XnfA!;j=XEdb=T7a7 zZ|#ro_mpw+rVjY;`r-{8rN zIwTY%q(eX@MMVLn8>B%>T0liW1m&a5mlHpnwa%Zg*Sq(-_S*OTTvzdjUupNhmXnT3 zKtH2DAJa(Y@u?i8D}Q?^cK%K5?6BnG=>5eB)lS6aMfm5RyCpwxKYpowJPk1V3u;_^ z|9K-g=%|O3c{Ja66!7sVNc>-j@jngD;M&s0XCHpNxIe7eSYv$u$4Ao7vilwSsuzYq zi&y;h{f{mGYlr|xg#F(k0?;V*(w)h4QzMo7no(=yk4-HQ2^$J!4#g_@Q>&(G6qxPw zN6jlW#Ooe=j>S^>awy#~_clzs5lu6Ol-~LnE1fdH>w9t~iiFy;1fXdB44!DjY0>-s z6t>E-H>Xlo%>6o0#on2rNq(~bsa5Kem*d6j?`rj7?FZ1CmJN<^p8Y4Vj^Kdx2lp+l z{=LnU_?VFqvhx64{r-9hL*EzeN6JxsCr6+)E{%%&IWCTAN4y``=2#(U*Sp>G@Ch8bbG%==I3H zNBf8G7dWN{-DKxId$Kne+PLQMBkW{n%FMZ;gy&x2;oF{%#_xyst__R)x7$Ol@K1JA zoS)PLHo=2>c}(gcGkU>oFmXSVXD8gV!97bH9?#yBSB{|DD6bs^^U*v3n`&ZS-a8hg zHTDqhU$LsH)y(yC5FTLn_NN{y4eUD>WOv;P;pQ}#dMLNBgo?iEH{Icp=1NFTYYMmpk7n3-xyihu69eNa9l}24ftCGI)lc2Yna+Y=GgDQrC z78zOzb(7lE|FY+EtUT%YtQq6zxopXwv^GPGcSL7g?pf|x_dLGtvpASKH-~p9e__Sz zRABkF!~H?d>k5DGYp>dGwzDu+1&M^hbYMVCvZr6PAZAuBEb7@Z%z37|JU!mX^q@ky^!hh{@~J6JyenE;^Yk6b z?|I{Z;?2tO>3269Kaf4~Yv|=~_kUS8vFHD4LFEbW>(691Gj&BA3SSN*-?w>}d&BO| zck*#73Rk5pD{8kt@4X?Jp837K=>rd{qps%*gE&X*X0t<6?@xWU*8cnN8RtL>WS>5^ zT^H5s2zbrxl^-U-hz*O=*&W>u_Pkh`9pJoIR6bz?BrNp1M>Jp-*Uj=|HsxQ0y&5iltClA+eVtlbev*iL9~>9A z?t(_>xUR~|;|o`e;uKmL4Uc}k=Malb!!Apx09J;22BbVTx!Zr$akwM>r#N>Okk~BQH=?jM3C*86$<2`u! z6m<2hrXOZS_48eSt7{Y)`l#U4Lr_ye&v1H^sY=6B*m6JJdC@JmGJf!i>#c7$fWy+e z#N#+jV~Iyt%FaC)n1hQdUSpkZP$_{HMw6y(6A~_S%dMlFJk-T=@>f2=% z87kov zi*T%)xL6kGW`a2#Z@S?IL}`!-lQ|Vu*wtO5BB}W(=8{(4A1x@)=uX9<;{v{ceG2eq z=@Tsow5BPwT6H?KX-i=W%*BG5H)p5PUXxWpRt?0%oAdK`!@20|zeooa8dq{e)LecO zx)~#E7Fh2ArA>|%{rmoJ zsdKL!JB+Ov0QyHb8bNH*lMO70;x{-vWOMDy^ow9}TMcMNFp=e`68r85M|sx-1lWmp zkVFq1E?pncToEW~y2S7+*%RO>+8$YoAB#*(n{hJbkdxJ~IEQY48C?$6MIVkCoo_V9 zcY}2&0S01d94lKnlp7)Tfa|$TX1*Gz8QsM#Oloo>)PXq^h8km#awgoPhRQ-NaX?cu zsEcZw{5pE*3hdC1_=t|+eY(hMmX&$mpd5}H)>daVS(DOV{4i55Wr-xBU~OtZW*I>N z;r759;Xw~&g8f*`Yi0iYR&>3P3T0K#FSXUt4LAYDseg-w5Yr0Di;XJTR1tJib`F)Re~8 zV&h}eU8t}8nB7a+OesB-1vfWE;Rh5fwD#<_?t`{DXiVQwz2(Z&h8w zbM_w;#>I`jzBjA^CIgeP(QSiy>AD0^UG_B$jx%?RsF8=080%g;bJ{#tJO6vf?)KU! zHpXP+>%c4}n=ZPHYYLyXCUU*0q41w#$wKI37|Ngc?$Nlm095t2(ceu@ckHI<4%3ga zkM7=3A~)I1Hn->EhM zc*Qyps-b_>VNHf7UYVrMWm8Z*LZt$Hnf)K9?$F;KN$JP>@@2eF{!jex-SlxbGmmS) zSPT;rg)98S1mY|UBag*_zMKE%{_#pxJ~d65!sQaqtnx3@JsILMkf_w2KmJ=YNR{h} z3$XtaN*0VbpiNdUBj_UvFCmSd%O6^kVNe$ss4W2sU;~01W`|=1o7&E33Rnmr>E8hR ze@Xo7pyW0P?;=2lBkDAz)pND{!brt6#i5w4L`figB@_^pw@d~EyNG0aVv}ijjC(6% zYXaj>Fnoyb*3FvxwP0Qxz=k8*=i`S%#HVJ|ezk!ZB_QZp;>k}rOB}#}BTAp%&>VgL zkDUI9Wc9_BT90C-xd5jx8Sm{5}kaiig~e6GA{==0hLfh02*|$mz6R zb?HU7U!`A5)+z%_58>=}BrVp7BERFAzILJSbtK(}Nwg7pFOpPsTJJB$X@*0*gGIGZ zl`kJ^5G9iEf8z=&%EmHK&rXjMP z+l;jC>2?(tAZvL42(&yRD9gv8*!5aHRLma=_n+i9B61530SXapcfyl=s#rvp1)Xan zr9edldy1wD8~OtoUx*K~cu>>e+;kgBi(Zb0^r(nB)VuvN$~iwD%qU2PCimI~B%glO@G?aOO%j53|3 zV*T(HSj$t;1 z)osO;7vGA=Iu=-!qG=EgL~0+xl)BxHN%_?jiEAQDCSWj`=c_mErNYZV z=lR4gCVbNglEMX0f<4VDaEu~qSym3nJ_0n?L1GddM|Y|XgVMV!3R=;I_vAq~umHCp zViqvYgWi~gCJI))xCNuwhA3qRi)O*9&?Jvu0IHd_fRo$j&BaMH33vG?NyzAdHUG|d z$AE8Jp-tWtn7+Yr=M-fL`%*(=UBRMUI1U~1Sw5ae$ZY}_fbtkeLn$=6XpShV5`vW2 zN&@f^tJh8Vxv%`R^WfhWCNTO8*DN%cKC7FX6*cM2f0w$C_(ja$(+xMxckT*W!1IMeJP{+!QjQV?JQ8LLdi5^t}2g1IP!W!7VZo6A7& zlJjvfA#uG(EXdU+of+zq$Y+Bln@1xO5j146ZI#F;v|RuZ%M-s+0YD@ks5y0)#S(Cd zVACni69IJC={I8@>=2a1J)K>S=?jncgZ(M&N-_2*2M~*SxH4Jv)wLC@X#(XdlK|jN z2h^jO&vDL@4nD=g-XRLH4$kf(VyH}E6U=x<6ty`)7y!R zFc8idtM58W#w0=_mY3_892{V}hVnv&@hAudW z3LhZ~OG%c@1Y3dvuvNZEM-4@tBQiATn~P2-4|2G^zjqx0wTA1~>#ExsOY1YTO#tr41cUOD2YoQ}^>BZXgbfPj|zV z(}BS})1WHUHl3gigxBCWnFlC?6wnY-p%P#PogS*A-{nBK>nm;#H#%1w4#d%m;X!TF zpwNWSmC*Qpi5jx7@`_n#SA2i|cX9Bf7L06NH7TEx##7&q9L5a+krqR+i9pv7RfWhP z1yqu)FztrbHG%k*zVIh>xS(HZOe62ifOc~Pa}0NuGd{yxh2y1re zQLIt{75EJ{IW=Dqy=N*-4bH;1U2Oqq)y-Rod``6ip)3}W3~UMj_}niP2Qv?1Bh-nG z&kH+Z!!u#Bv|S9)uC>ASQS9C|{D;Lb;#+8l?C3L5-&uY_B@Hj0TrvqtHz^dm%>#ki zj7S1y;8a2SXK~+sd7s*`gZ}nIG?uTV<0j83g-GM zU=4(%ZL3e5c!TompF>jm0a>7!k{8p}-d%~jC2NSd zA0SB}$JIa(KIMeuuyx|>_i5B8EE^jIhG~0)>vcN zZU>ghbz1QxE(0`9PXk3zcn1N|AFZh62ovCTTm6*V#|{I%iNx^CWLCDG6S}M#e%g2h zc##tyv(*uo<5@$8i3jc$s(+)=XznImoZV5JpfddhxOW0m&8-(13oTt=YqiXxBMNkzi;(S(gRFP zJtkOE%yR%Kn5cgy6C=Q@x2ci=+$6n`OD=WQ6P~s8WH?Qcj%^ec z&-M*BmgEqZ6P!W5A5TK#%D&JQa0&`EdaEFC1nhm4udE8D?_Ok}#&Ltv3sZOK`I?@5 z*n3yQehZxlXv#^z(&RYmdC^|d77!5KK?pk33ms;T#&iMgu8MtCVOP7 zc5j9Wn$7;7yEcyu8i@tW<^c@A{`L(TFN49*fMR#3T$^P0)-4eDU<@}z1qVFpi2^q< zUy%3!K8;Y;Q%mMKw*>+8YpYvi*+FoSGq@F>0J}2w zsz4elXoh|x;UQP!Yu-x#-@^SBUNl}V94-ll;F8~S0YYsAC`Qh99!<+6&v09Vz>lV# zho+gbVG(}rUu1my(ayx`gCLzplugp4Qy!DQL04*bB~q*RZ*7`}&B@lgzw08n3zdF+XHkd6YElOuzH?L=?$ zt+aQ$s$xe{=MumtLA4`zZn`7c1IF7K1&NQWkc_SZ0Cy8BA1{#tZve$J ztxC(wbvtd@pzX@@$hyHtj1tUPG3DPGMRe}aY-G1A<14;UWOID_U?z+774q*MJR5va zi~axr-T18bDRNLNtJ6>bHFGvRn|iM@bT3W|(N(@Y8wF0alvVeY!Tz^fCBgY0zh(PMC|4BsjG zqdc1ac3$5$!``5HR>6bBZid%xH*b7VomfEM{9;dYPTXG1|HKc7qg_XiQ*v$5M77Yl zh`2D2Gygglq?~dMR!H9M3`XB`B3LMtrI9xSbS@EcHd!J>fEMjhU?N9ZX9WReE74IZ zFx|^ZP~kZWjI08OVc2pWQI}xK!N5Z!et>BKea;1k0F`%L3&BTp$&qLYTT#KD4w;n@}J=i6%IZsQWBv&K?2LuD`i3A4@9KftDb@!|UR&FyE0%5TT z_L)c9+Fk*Un00Z;0yNAnS>0{;KKLRHEJ;9`z#dK_VXLDGtiOE~ssY zdGRD7$OO_1kBHDMpOQy238JF_fIb)=qzPd?ijA%VVE}k#7h-iw3WC?8Gp%r{1B{PY zjm!ik_wr$}l-&;@nUhG@Nt4l?3|Kdc(-Kx3jMTjvq{12gagpUdBFk|>Mo&V~T`Vd~ z@fApZRxp$>iOdAx*R!nf*5EX6IO4S4`zU7`!d@N@$ws4sCKb)?o+xR+IRLVhU^DZw z#~N`em%kC^S!83RZHEUY018b;V_(J5#OI@jeoX+b5Q`sT1K^VKD%a6PCLl8jL`fIY zw+zsJjF#|4rw>uT>IYx`BxB_+RzjA5C*6)rK+rO%C%>j}59shAk^sQyfENRG9AZsm zNiGPlE-+B0A6O0^X@MKo)R`!t2g_7&XylVJ7$O+>b{A7=hb}>DK)OK#i_bjXroZM- zVmU`WyrC&~{G1Gr5(C08gxejjUVu%@r*#beHbDtIXpSQ!tgAe13EFr~3W*A=)~KkH zMMq`5ovm)z5RN0?KvmvA)0MSK+M%;uKy>dA%{;&^8dh{GP7EzX-kvGoi;@7s&|RGK zBmf$QutLzGgiLOHd{s3Wi_+(@5ejL6x>mn!vqy{6?*)!D(Xm;|;B~N=92&2W zz6*4)B%y^P9-wJ! zn^4ii7Ef{TAQ$9hGo5u&5jp}r-$WBkqjp{^`KlIOB*B_eRtXLnfRkb=ZGZCjTMxjF z$rHQC!pacm@@ytA&={_Kuq*1QAN~+q!@I>7xkL3Rw5|piyefs!-h^Mv<`UGWAsdGgF?kaGbM>p0g>Qv+JC5Se^B{*13 zKL#r=y2ma`l`kT@smBebkIE`D{xNKp_46H5=hma=C&l@`QxpcwC5&Uz*_Rl{7sJ_U zvg)TFDWjjP(&s7DJ{6@YuAeUZwTm90EoPr1O$zWjiFh0JtW zAbPnXV3EaiX+)X!LjcW;DDXUbx?dDnctATuGF(^{y-{K~J>fX_j(xR*eU0CAwV-~f zmvVZ!eof?fwX1$@EMWR7g(~d)yuZ3UfLvwfT4fnui~hd$!tm4JgHO=`pSP5!|I|VTr3dRghM(uz zH^-GX`IMJs1Gm80n~cqy42J7G%^N@Jr#LvaP#oJb8J`u`Foh4Oe>ZJ2U^eJ7w!~j< zCy4IYl0vNN_$?)@I^ZnOh;-N9pb$VnRz_*9|Wy{YsJ+P#<1?(q#i$8D_WRzdN0 zDf?2i*v=S0afbcepv=f`gibWVFigt(8OrlX?5oF2J#LuFf4|Nf@|mapQRNdx9J)pXn1{-q)10h$6Uw(+!c zhpc-G)SjfFCY#maM#5TgMiEy?KaUkf2&In%XQuZ@)k2eff=j>RaExZ!H|( zxg@_cn|`M;2~w(;YL@`zFStIpaXx7Y!=jA|~Ja(n$~ zQ0$mC^H99uP>X7l&3TK1L^V@JHA}*sP-Bi6B`KE6sI8(8$1V>T*uOH1A7NvU7+sHk z7@ab6QGaxy9=j4wbY1mGx?$xgi%IC8Tj=u)v@8kTvJPd!qPZqvik!2D5(~)gpZ^Yj z(o>!?)E`eb>~B9fWs;;G@1pMOqKQL;Zn`Au7Y)$`H(+r215Q78CeUR^zhKSaUKfn% zB*ebQVoxbQyAd5tfCvyEfi9C|8({rmw2$+#pYfEx^HiYfQSkjE4rA)^D=grB8j(q| zf1Ys=3>j&NOoHu@`UBejBYGJPMwCM?OcuH&oov2ET*-8qyY7;MVDu930ttiyP7&4p zhwk{#4YmtftmAM4|?j^F1-0NKz~eh`>LA9$s>KA6;+h zQys1alv+K0eAEld1<<)b2TfL@dg*nHFw&&bHKmMI=~6cps|7rBXKP|p<3aJ$@pyiyjcxsg4b7?g9p70KlDG~e8Vu#5V|{FteP}&zF5CESMMyo_LVX6 z8@NsN&8u(!-M)g+qh1`4LOJLGD@L4Gu2 zo2t})4$A7bgZtH5f z8}kosKp9KiV1%x|kd1gY!QUDJA&>it$%5Q$>! zq&nOgq?c?%&=NN3pR18o0VO%LbwILp#ky)K0fxY~vek+v5JyZhy29;=*y}kD7lp?o zK~C!Pw>_Nn89JpIOlm4#^uz;{-jPeZr`Nk`I85G!KxTe2yaA?3ZUYX}UG`3y*ksn% zVMF09zptg!{-6)eeCwQglukKFA96Hmw_@XdRIpq8Gw$m0vb)d6WCS^T)NdFc+)7bCHwPktoayy^B;$2G>&vDNZe=)MPi0 zE_x3V0S5ZdRRr5$e$}zp;!#l7+8iXybE42_CTw3KFnHd0y5ewE<0rs_dXBk4El-T;2E058t%Fr3uGc zh6nMF_Xa$g6ETyvokO~(Q0IFtbI5gDk18-pH-<&w=tN-J$r zv*O|bgIIu#jhli7JB)a5g2Yj%0q)6Nv>e9}mZ2s5p2a90+ahYLmG5ERiN!4l2= zFgEqumupkP z3KHIu08uNIXS(O-07mF!9JU3?H5}_n-eOy5GnZf!P;E6TztoZwDO3Y<_j}VqeXo_F zUOmTWQ;;Rrj6nlkKYTNdCWQFplt2NKRHyVn#XjMc3wyMPr?`|%tYCi`9*4TgaFqrf~1=-s_|gG&-nA&D*HNvy?%3O9*i5~Sgb3|*A7>xI#3)xBwS z;!K(y^fUtfeO4MFsRb>YtFIS>LXhdw&`~bXwmO2v$6pH!B2ofGjCdQ8PZ$eEfY=a)#X^zLGDoF5)+y_-pGg=+ulk%j zg5EK1g>x_HWbZ*=vs7w;C9Jce_P~Ae8-t>25ITRhEq-@Ga-+AKe|30)kaLWC{+pqL z7j1TeO+c&_;zu*Vu_Cg0@Jnf}>hqYa- zf+u7Zy+Rxf=Xa;ZdCs5oKO%-m_!XtFC8ZAD2Zyq!vh6sCC~z3Z{7fY;D)o!}gK?dp zE3i-4K)h1;2tyyITr0K~cIN9|2snzNiWbsbK#qIohnGl4e=!ngm{kz@m2TddYh{g^ z537h^3jMc>`9Xkmm9&wq%Voc$x|@tK!Y4TYw+D*2F~W0bUBnd1->I|CN-5s<(zWU( zPOhEjJh1ou;D0~26y!hvl1y!Xp`L~@GMDez5#tiG~H=Fz3`FG1jIR)xT zF2`S^{}%Ax|HXOp@^{IHdo$-T&p#wp{jyb!(u;8(UpY@cpQDaB9Ot|+&QYPL6Q?_8 zg#O1g`#vDeDL%XSo__8cK zhT z>X9}`m077!5ouI4c!g7H$Me>!z34rC*K0MRo;jr96w-%@>mxqW82+!zO|tJNzK^h^ zu_WDfLEc}-s`>d^zw6sR+OK^tmrz=*6~??Ttwq{xls?$<7T9ULw2!KF=<89QRkQBP z{m;EZJiJVTfQybIB=dlP{gF3{a2SAHA2TWGI$gJI7%VU z|9Za0yQf9vHM8Bd9XF_;g4A@(FQ7{G@mviSYK(AdNuv)7NbAh zMkhl@n`QdjR^Gk+TlUVsuU+X?N5_zx?#QF6em^AxhgnpBM@4$NLavP7GdjiRFJxQ# zl)Cz`-7A_sZ1TMh*T`v?l+)ts5JD95q@muX)6*YbY{YMi}FHXi!mU zfK?p%scS$|{-!@rbi=OQux!W>yEOj%t0DV^;StivNM`)(=9qhwL4W*6wEqP2U8BPk zBP$03;){u!8d@84df)vAVz!4CUW_c}@P6>WF&mDZOE;K5mHOqNd)8raUd8u2T=`EF z=f$kye^Ii3Ul{zGy>TfcxG7>3cw?ee$B5l-qIKDb>0qMo&qO$z(Xqb?T-12~h3?Ap zN&0st-NTbn6vj{4K88h^lqOFy7n;nmPEiY+eo&aIP9LW49Awy0`u0ullvfY(%W%}d z{?5x>G#2rtT1?jF8y?mf zo?n<8jZKhp42-AfMz1fK&>NcFo0&e`n(jWGeg)O#J#Qi`i5*3$V!SoYHKM!R!>}mHAZ}YdOq)0QKBY%Ft{*)UKQr$V-Nxt> zN0cXjL9>880QG%MAa!@^)*FWhj0XgGA4@&hLA)oXhREoT0*(E@$S=KJ*U`lm;lpB~bG%JKY^qul-2@RNHoEWi3w z;VavW?=ZW)#k|f>CBHspyh^bD{i&SK&h9s?LUXCa@lzF_9rxdOe!^0101=-G`tFwi z3hpQ5qtq7(9&`&He=Lxcb7`!Wha#5$Zdg|6 zTN)@W+YdwGWl(z;kXTlVKyuyvqj-HEf_z&%Ywz38@Afi9%el|($vc-B$CjTj+uNtF zV4lP+*n-3MS|cz7c8S=T>#_a!RvKWYj@9!`Fmn|?O;vVnT=A>yf{MDb+_r?N;Ro+X zPTyyo|Cv(-@U32VD(G^wn{xc9u(lhqw(FSqC3kJVdhOuV+Wv#JuXAhPcbxWjQVwCC zkLK1Y(4SAPf8LEq{b}j^vorNqg!7T*`*X+7OyN$x_1G;>r@x-5j0xpT^o4#8%5MJ4 z_ZM9r|F)8+;dCQ1rKzYbM#B5OchI&zVARDnn=Xr2ko z;iM4VMmaHfvGYjh6%I~ji4ZeEKGs|+)?TiEGqSaM`D?Yga>J!{Be`z_SDeCrxz0hA zTER9=xIP!F+(^vriZf*6xx}I~@R%4*nh7S_1{XShH>wO2b%Pr(8H$hJl7GOSBp@a! z_!KY1z$QF^y~dy>qQWT}!yxwFmHcv(J92|I-t}#+tLeXuU<$VqwoPTHcPb29^88z+ z67KDq?qinj((YU8;qD(|w-68Ag{s_-n%&*I-MQx7HN=t)BFhXJdX08VjJ3wb4BN*= z2Ox(AnwMK^lpgQcw{MGhv?*;X%kG@xcU(+&`dmF-ke=!so@SRjKapP5Y+l_$yG{yT zPDWlDPF~A5JxXtTj6U$dhI`J%?S$s+%vO0e{+n`4Fcau-2rAi5__`zh-s{lUOC-wc zL&|RVpWTC-)-U-yRT5Xw^aXci3+@f%`aT}l)9TlkEx2t|bmvSd_L7PCo}LsJ^YIqH zTcX!{fBw!9zNv`Bo~Ydq!3~2UB_BfrR~spP7GaAL#V#$%8v)E~$K_52A$sVsBSu14}aQ;HaQ>Y;HOmBrJiAMBs5 zIK&J&s`xxFF@G`7RCDMRz~Fb2@4!dKkBe?Ug?Aq)-gnUS{bKGLA@;Q*(E9`AD=+=m zbgr9^=Vun9zm}C9!0Nr6Gj96U`!;p@b`MxIHth8#e(AH?W1K(u+`s>L_ePbo?gZ1tfX;ts$pMExNX8&ksRFrik#xiu znXI>f<`;3%!@-gOkA?uxz+n0}z6f|9L|~h-W|!&BF7uCRdVv7Q6++)Qc*!Z4nKAg6 z7Vaz~m~Fw6opkW|y&vbGIab?Z&}m^@Y<+_4NW&-;&Kby>sUh&gPcYM;#G!q~+YR~Q z6~d(&RD=sO%>6+&7i_$JlzwznPIml{A*Axj&&?NM4w&yx(gUCiCwY<90QIRob9n6p zQ=OB=rPavE<)|DfUsF6y%lm}&s#_!;%A|V2Vf~Y{@mMw}Na{;~^m%|x={M8H6Eo@) z^B<>Dq*He4Uozf~g-$==a=-XXe_1sC67-H(kBm@%6{_EV(yV-1Y!qHSaN0O|3eJnr zH?CA+e6L#C?wvU=@gu^h<}5uqjMyL9G;`+Q{nO_BR}iD1Zlh;N-bvHbQ1_%?*Mg2k zYLrOtr^Uo?(W#z=8=e(8MZ$v4=ENfPzMtQZ2xFu^lm76_O72$wS_COj`&N+kZ-U%O ztoIS|$3k4@x|%>}8ayIh`y|Qx(1$V1R3l>XTR<n!I!fIJ@cM4Lhj^Y%V672adKzX-QO=B;+n0CH3b7eatmJ z?Dyv8JF>C^2>6i{LmV*Z=vVXkcJ2ACI{58p-jUBg%d-6@rUy%riictqdQ+|og2d4= z5;m|~5|>-rm)qJgjwYA8w=TaVUGC+@?0H}Azq$N6c)2f^G*z( zcQV(>fE{ghB1N z>N{6oG7ZmCq0jOEM*exd7&_(|%3^C?rSUzf()I2%Y4J}vUX;v}@;*qF{mHMNDIc_Z zWA9~In~7Rd;xzv{B8T_^n7nwa8DC#Y_8pq-_v@gglyvF%{ovQN#Rl8nhyO-ieY1|4 znrsOeW#EvF^In~iwLBT$j@lif?B83z{CetLGi3#c+Dxc>sQET-9EQNElPLGk z_EX>&Vu7!{SIknA&zC2L*Yd<{u7BHU0NJaGwEwr~?)ywbDqrvsU>-Q%DB#l}99sXf z`;lSEzu@qT=sNQJ#!`{U=e`1qH%a@yier%s;SP>xl(kr^`9Ip$G3fX7))5TgD{d3* zl4V(<4;K^nZHnogvLxOm0c=cWwhqI6q4$C~Lap*5W3qJ2^@@zKf<1;*<;&KJ2coDy zmg(AhmOQ?42f39GRgal=d{kf4^X6*E`ts&hyDmECk#2@tofw`kaDDdH%O#-V*VBg~cVBzkL{!}I&cDNv>SG%n`A4AaF4B&n zT$|+`bCvH~gkYtk;)rjJtF9hjb?$tGZ}dsT+d8l6$ZDVbax(?L7cDUnemQl|4j7)h zdJ6NtNZR+KuXkKx;cFP+Sf+2(ySTV!-%Y&kpV`lH_RVI+c~FO{<~`nb`-!g_tiMnE4s`j$Ak+Bp7wS$>HyLMZW7fZm z|LD8i-WFEJJ6Jsn&ZIcs*-qL83m^C8bT6#;2YXSh){r7&_9enNzQRHs(dRm$!&a7T z<;F5eI!A*naTh0rQp-Cp3%DCo!X|!PUyvTF1u4Ir6jNQ;%a_#>C5$Udt!`PljtacC zxM9zClxEK9_^U!=t03Z${VnCK1?faX*_*dMdcU^tdEVCIg5Vr(&d^#&2)7UWU~`_9 zutE82O`tSCw49JMAG&OvhI&&{B4ot9#p@+ow&tl%#k*5zx0biAMx#=>5zaMHGwqW| zRkC*LT#j)+lT*X;u$x@`?5LmhzS7C?*9N7Z<2Op%?LO+O{yPpfy{~-cx|OSZK0}&Q z{yjd*5Od~4`QgURQe{NPVc=7vZwGf@t!;f3A2^)hy?7N10My4_9wJMcdu@W=X5h zpi%n!ySHW)dKXvw);{FWwB%kzYlVEXP^ecjq`ksEL#Kk*&L_naQ)zKlQ+}yyN;r&L zdOo?xa6K{k0XlTcX`4(drd!g{Lq>=G`Yiraw23X($_fJZ=bB>1R7RYX`_kzUgNol! zCJO9fgW9K6uuFb;spx^H@h#WfY|Q?AmzR;}Pd`aF^~AcCjv&m{H$wLAp;MEG6{GHT zeanLBtjB$H{3M26C;o4F8z`@a#5)ak&ki2HwU`tO85-+Wm~om6e=MV|HLhnXU0~(F zKN_<$42`7`+1g&h@|;av&!x?j2+yE+xi=&VHh=tti!VM^xBjl5MCKkvk&5&1NAC-B zX}~fI7jS3H>XW%Ayt7EL{cTfF#OK7;b9;+acSRjxF3p|X1g z{!&v_r|P~N7E2P3wM?Fh7uPn8)#(^kBs^lUtBGCmWzeO$lHL=AE)Iu_qP)V(*ZlWf zISR{?t!Qf(Xbyx^^lIWSrk}C)A4K}>&(z!{^rp{=&LeB*x__#dW3E53FQK=1dw%?F;Pvyq z!;!=GZbU|#%I>3-k)$(Ks$?yd9P|xu_HZ3@b?h?nnJo+3?^6FcSqUn?OVGNiM&TzTP&4)6C*M&gKqux zYEM2Bu7XMJ#eZ{>G@lwG;ahBTqGn}YhK(EeOLM{5xm8PPCr{|Zr$qi~8H}3Guxy^1 zeCZfgym>ysGZD6l9#_?@$)ED%eR*G*(#7Q5rjwNOi_KTr)1GH~>LRxF53ixMo`B_S ztiz9#KP%pDHPefy_%ol}dhFzM&E!EGDKe+JUd(T6dTG7;b@{7eY+&5rvYEnZNk1in zMUv&5re{R5~AVy6fA%@dMxP^k0E-g?-m!<%vccEuYxRj=#o zD8t~4ZR=F3k}!|z`v6Ca z)z!Eu?Bd&UrXDWZ1A3lmb_%m~>;#te{U+CmBlm?P?ffRX!iXi3g)63z%a7Ym#8L9V zRszMtNX9L;yCivNCzZ$|bdbeX$R*(PM8GM5mz$k0@(G_W-Sh7k(1;y)4u>(hOzjg6YES|wb zu4Gw`n_Nk+Na?k`!seWUn*+XNLs59^O6J7jRg`c-o>Zu?+@{ZW!GqAxLc_ zMG%lK>8=qXN^NvX3o5CU3W$n`N{mKnq|2dzzz>j840I3o{k(oYpXU!aZ_asf>iS+6 ze%&;#+U^3}-aW-W0q!s`V$SVgL9<}7Gw3*F;6zh{BUjsK*O(i4ef(bKx3?~~vwnSN zmZ`~szkG)O^PJT`N0*)f7qG~$S8lqUYq|qeK|A~xuO?q58)?YurL`5I?mi5xb|5OxjQaE{|qXsyv}Ez;hCB;Km|Y5nEHJrSV+ zQ$z310Zp0OLp=&8-8>bK4z0}&{o25l&8*~F1@MUKP=ZXLZh&$r-;Z_iggQd{*PM;o zHc*zfQKIrtf^xlhN%L3Xx8iF5YAtDe92ma7+wgi=<9*X=L}$59xv)odtJg-RH%!9Y z98|C0Qy2T*r&zEy)V`jyJEGIqt5A)X+GR-2r%!v!meN^GWDp}Q*0|lJi>1B%hqpfd zz*O_BSAp_Xr+SMzREwVylb7F6|>~bE8?fg)FQWeKo&Azj5^5lrZR$#zZ;q9;d0$uhK z^ie%k6@f>okI0r*KB-Kgdr_Mo*dsntZ-vE6pV12OCg$B)bQmbC`^WHV0S`@*3is?m z6z;eo@bqUNxOqY0KhjtOK@I<)=#lPcZGiByKjyJ{K)c_we^NK4(wdo{x^YUskP2ur zNM|)!x!bDWay8)9?<=*zPh{UFKLb;xgJPt$)w9~37{8EvdZ+Zim%sboKB0Z(Al>9$ z;ye=YS}d*ODqAQ2)6RV9r~K(%wbG8zz#7zUKpgJ-OfnsYY}SWGnO~+=AVv^(-ExW0 zvk!1jXIx2ONgx29NE!AwfGMXu!4i>4GFLkj1{d`I{7Mp9cPbPC^V+3O(547ZbU%aQ z`8oS0Bas4Upde_Y&ob!olMG(oo{ybkbCHd6akBF%jq`V87w$GLl*=yGHZC^FF10o; zb;>ReG%kglj*x^-paJAw;R%vZjLWK>k=Ri8liz)cnmtbq<`S1B>`?n6cKy=x zI82&uPDBDP7GE>ge?bo~zD1QvcLJ{&!&F7Ue1(HX3kQjHO0|u{0!?;z4%0IB55A%5zj2&NLxaurCl-O5`)@ zr;E0Qc?Ae3!i0Q@xJu#_jTqSEIS_?oXdeCMVaN;x2-*>lE$dNO8yFFI$X6#TVnW0jfxh1v)4_tF%NHb- z26bi29Do ztY^C7sq}1!ZmEC05>|kKNT5p}S>Gi>;w6cWsKntKjw+VEcr%$NCLDJFyk*yu0m!m4 zL&)|azCt1n)y>)#e%=fc*8oCUy;P(237L@TyCV92ytF+dAG0Sx(a+875(Ifch(d2W zJptQ@9*}YiZn|5{FhVh2Rw@GQ_*zApcmitcwc*9FHhh-!#qv%B*k$1zU*E8V_MD$b zx*^h)Xhjp9BioV}xEAarx1KgDRsz#U-;NM&4#Z_CEVRG0_(&ZTm~Q~8v7!Qc;vOni zr&sGVLCma4>a4)JeKJDiLV6*QpU^Mli}lU|7*KF91uH~ROj_2Z5lJ}LCyPj;#unJN z0Sr$HOTHv1D?$YCB!JtRR1s@JJdqXt{`cm=5dqJ^*mAWtI4Y|dRnncQ_xyZ0Pgw!` zHKTV=D%Cr2OBzFN2zxDsz~10U5-}nRmNuaVBkWONIFKS3h&5A#2nZypdy+BjLoBS_ zHhLuV`Api7iqHutMIPYDN(j*%;`Ri%C;;tAl8^-1CKpSCf-|2qP!r%Rxn!<-Af_H< zPNiYaBEm5^Oq3!l_PNy+{qr~@S2KWSrS@?*9EYfpInJYvCp}r_AVdj?jzYE>A;Ag# z!kF%J=D|D?d9*XgTuA1s2AEirxGIUaHOPqiC}FE_!f-SDWnCl%;Bq35ACXxQWMK-K zodBY(1~&2$QrL6FK!Om!wnjuu%yYe)YDpqJto1l9I->N?Bb{YXbQ@^XTTbIBk>9AB z7uXlyZ377STAdr|ueOVYhxv(b>mdm^yB@YA(BBS(&RI8WJ4rndCYf~t_P#CB_AP#0 zm){7-M=(4;P|fo#PxVD%xMZn^F}Hd5q+HJz1Bieti2a15v4xNd#IYxVUFLC6+a2D% zghz9YZ=Y$rd;RWR*Stpi;Jfy5jgGl@9iKEhzrO4IrqOl!u8XQchPRU$HM=?5y9G3R z#M^u1HG40%_v&c&8MgPCY4%ecl|8Z698gg#Hqo|yFg_+hgan2Dw#d>Ps?hv!1uhN{ zpUFcYMz{}y?IQ&=bY#G`p&MvE9Qmd>?r1!A4#$SDZ%;KRd*7*<5LwN^0B6MH#g30R zVXQ_(v^n;*PREQ(EUp9$LXgcpI_7jbP-rZByw<|$8DfGwQQWckKo$cK3D2~a6WayT zupskW%b#NVUn&YkNv!f1VS)co?0y^C@c+W@-q5~Feurq15cM3p8(qd$-b3EQa!Fn$ z3YKEevAe?&|6`-O!M8NUD8nN~5JnTCMe3(sZmz8hdC@O!Xh8Dg)pQZIq)$#Qk zQz}CoAu2k5P?V$46)bYT4ba3&urr#ncs(hOLSSKb5Ov*T=1<9kQ&HU;6D!!y=(`3& ztPGwRz-L6?xF}KmWh&=Q39nq0l$7;9&<#Z?c1X!vTF`Z9pq_UGc=gu8lL8g_2Z z^AlqvCoX`k6v(1rkaw>1lpob@QL8vch^%-!3zUvMHNTe184~E8+jvSo{>YQT7IFTw zsWdcIysGSbj!Jx%MQRr8`&4S64s*+A`{4r|jc`R2M?bcnyYRBuS>sR>_Or|p4OfK8 z3m-g`mP~`YDr+|(8j#hUDhGRBH!U`5z*r*@~ zhd2`eJawM#3SS?Tr=FDdz;ConpE2&&s0Ik;@44Gt4 z8HKF5KEVb!QAg3Du-$2IdvLDnL~yIy;eD(Gy4_qt7_Homfu4`}U~GKY3oyT~9vH=e z|K{s1gZZ%iLjsFyr2wzEDF-e$0&5P-A_Sok@D&5|(k=jt$Iv5`ZO%8bt#t2z^_!6U zHQzMQ0^KZ0RkL98Yu#A-pBA}1Ovdz2u=|Ku#7!_O(=A*kucyjWsD95qY>}tA`6dDx zNe7ioqQS$8@#5w(au@_;5sQ{VU>F#Aj2I+@0bWih1Gw9OiCr83%YgWi>iqyMnLjzV zCmyVbdjb7S)~&>1*6kOt%4_#Xc9>Yj=qrR0rMng~M8N7mPrOorNaJLJ(PlB4pbAll zq6+TJmjNQo7zzi}Tv25|`!GouK9C6he-SuqCAbl9o9W`X1rmj~> zGN2E}6b_BqLGjJ62pDicbDy9whPW%S&d!b|GhGk_6fl**K1enzto?UOWJ){@gE=*)Rf7H62Hh|l_#zFGLgJ>u4qL}RSr0@e}%NIq6wA7cSLU?qN`J)!|ARAIOu zB?3p?Bybc+q0laI;6Rk<>p5rx&V>TCWPWOTV&TPHsN^cS>=mMq2&NGEE=;DDmfp45i}`kaPD9S&$tReIoH3D6F2+Uz9+g+U53j&%Ut6C-?P zu|KZ?P3mX5hpc9TmzW6{zBEbwE+dW4;<17;lbctbfZ!A^-6JM!B`w)sluW^1RRHRc z)faV*jEZO}9Hf)A$6H|lST7pANHw{u3US?doUthda;*uW^`pBDCA=pM(d0qwuYeF& zxS>XXsS*pB0UvJ7M(Gb@&#eW+a`OibWYskhrt%_Wpf+X*)ToP4froM7&>})FS;=wi zp9K<5t^&%IX&S}~fG#a2>>{@8rl&BlZ7wM2m&6v+vA%>vOtmS7V?Yi= zimYf-4lS04!4>;R&Kr_}5aTZ3e1grz5Y1R`U}ROgJASx>Xt>ef#%L(8HCLI?{sZ=l zGfh>E0K8^fC+oGPL1dT6^*tsg+&vRlVb_Xh{5(bBu8K@{uC3hby?m^uA<_skF&f5n z9=^f8h4z@Mm)cN)*qAg0arwxz2YN}Q&xZUd_~#WtL|fEs>b%AeN*&7gbV?3-K;@BpMmI(JcjFUgN<=t|jU z*$XMp4zL0Y7&FX8=(&0xTN}l~r!>GAdBGri&!aQd+~(jHktzoST&wpYqi!Wo@1BJ) z7YFuUJ?;T-VN!(Opob+L0S_6lIB0@YbYZ;@JpV}xTiV3|QJjFKmwM5kulXJ5g4oGd za*$K{oD4~HV8StO;OJWBh}YP8A(A!nVUN|ueGJb)q#NBeB2yaag2SN$uBo^|3BCvJ zruzAHMSg}QYYM?-c@cek4aip!Z!!9Gg}5gXYxlsEap?9VZ zTT6sso2tnyEi=b4jfP+^LmBgAVHyts1A@MZu6wL1woR+YBVaVcw4Zw&6gWC`yKKr{ zKvE*pb{=&0{s14TYYRfBzGn!;GA`zB{r=uk-X0T1sd8)*H${GiT*w7(EiGZpC?8Au>!)L6DVd(91?EVA;I2fUWu4#P2@&9GA zrU})`Q%hPGSB8<|z@c)8o9HuF5Msh1aF!Kf5f62k_*`leoXs`r2^qMKSijB@r zK+DkJupe!0hyGx7gQLXh6m;348ymgh>T*#B?3ylQgl_Fglw?yHUsX3qqNDn7Py z+Z0DTaXOtZHqk%IgeuYopt08mEf=jJA#mHZAH0w?m0bz+V|^0XH5Jwkx+Q^zTtv?u zYcW`a(_&H)OzQ8Z61(R-v(;jA>gjAtLcmmvKc|~r)r<4QThvnpfFUm~ z@SK+@E5x`a4^0)^q1KXoZE}saQFA}?VQvg?bI`f7e};=Uzl`37;$Eb=v>=G! zs-jqt*aBAD^PZA$W)K8T3t7AVWFBoL&SzpP{-GXii^-`9<<0dghD;jLKN9L=Qi(kV zk4T`$6fO{N1tdJSZNG^IO{XKP=phtP_oPO)WE7u*M;7{G!M0z~<3cb6b%rx(dZ8jm zyku+buC$?&1YxX>uz~uaMc<%pj%k4A5~ie*ng}01gnavp2mh2fs#MSyt3VG$OS#nZ z)gM2CRB4Hj%LIN@!MYJpBJk>$=2vDz+6jqsuZutzWZ9wFzVdyML^J&+79)J?CeHgL zV8!OhD-=BzDz1EkBLl2(_of1XYK9dyBjYC^&%T$?vm&b~G$s-iC4)#57Pw5go<*jS z&&9&sivHDAfGdms^nj*F2pKZS`>g%%zl{jive+&PCnG{RV#cZx_809Z26BB&xO z&@^xRoQM;;eiURTmRF37U9-#u6KSCnz^~+6GAif`D(LK7kew@{q7vDZbe)-+j&6Z7 zit9nP3uq1;9=J=Ph0;03$N*vj8vBUttkMiap(!9B<0ha?l`o*rX=w3~^U1?RG|jfB z@o!d$n=bt5QQgP)b+cS_`UTL!T;#Qbxbhob7Yfluu5lP_nZ93no-sO_pappj^m@^5 z7DN9CJ)!AFQpC|LL??~Z3R~n;hg*zz?4{&K$TtoGZsyQ@I_MO811s(Z_<$xx8b~Y1 z8h(qeBj6!CVCv}66yH?%FZ#jU??!*S7I0-Y-64b#Mn<{POV+}sJSDL=LuEGaP%3qa1*7txKV*FdA1 zq2`CQiaQV{!Ln(j*Yr>#Z)G{pbMbn>w;hZO0pNMqn%!>f8G-gs+9O1kP}af!kn&6L zYuNxivXZmj-FFuhIX%x4Z;rHbKxcmrj-0B8Fo{k5K;Fdk{K{plqo}qB@>D3m3Fz}X z1;5ODbR}~y8#7Mh$u$^AD$qZp7y}O`BP=+@%xnZRTSP>kK7@qQ73#t>34z8{wQvxw zzpZy=vzJEkg4GrDrUH{OlcyDrdCb|k^nNnE`@96|9GM$m= zRkK1}JlJaz#zw%;UmX_x<4+dMjr9cl-F+@;Du6{NFM^W63p8 zBl?%q1fpz$wv4~wS|c4FdpsKM`*Q;JTz=bRlCx}*yJM1fWs?8zB!+KF=>KB(*eQv! zDXESrnUyKIzf%hTi`|u}&L34{KdO~|ywvegbLFG<-;dZJ?rgFra`FQ_bdu^e4JJ*m zEf1MAjv2>}Q_Nb13Y=*Eh<`XORhj$)!I7cN-r~I9W=s>5e%*Eu*d38+R ziJebx97}RuSTUK0k`@|B^Wl3lSsmyCKK9&>@tEw{QogZbt@)6>v2yyU%tmy!?5tbR zVt)3b@91npEc)>%$9Vwuc^UfU-dIiJc-`K(U)j>uizS-LrQpLQe!gXd;_{x;@@dTS z-_qrw#--m43&T|U`5W}hm9k3@O_yjC7i&o?XALV0qbmWUOHF*MySp&%N>EK&s2u?! zhUtSTul6{v_Bk&N#4Zi(EvN3S9`3Fr(644?GwxL~Y!MlDCK!G+Gcs0DL=NHH3beIk zP^c83_nHPUPlOAu90bj6I-|G#&O^&rXjb{3uByXxVp0J@yH5XG6x`)F?L#jNHIGwshv#f{{@ zQ3z^ffsQQAaT=4$>WbTSUXOB$(%2YBBV#}-;~s^6+#H3!gPO)N{7^Wr*kKq2P~GPA zKZ$EX&jHN>q>|c}#dWlrxj6#`U^+k!H~-h(iF(%jUu!N9J2n+hfON#|4wdh|`}g06 z)!ngwyA%9-lViJ6*Y{@Q_CDU(TkPChy1KXgZ;#TnyIQ{60nkrlP@TE^ofD`T3hgjJ z-_JthrU7Qv=eqxK`aO)c1c3C#1$$8sG z_7l8{kzIiCH}UW=mwsge)rUcKV^A+AP%V>;!I|SIk&cFcAbM!k#fjgltC&uwU%@uC8-f)xi`O&s<=JF8cH%kNSf>kJjJ- zfRNx^K@80e=+ti;vYo4$U2NGEr#YX#=RIR8)?wEAw(^qEmq=Z?Z^m?o@(Wf4`RdA~ zXAZ3|fMN-AXA|%r!RXTi8Wkc~qZzKFd55hXUGr_Lj&but2gNgP%bU7-lrO-NoU=Z6 z{?R|~4_)~m20^;^5cJiFxdb=+LNq9G9DND^_X9IDDWDkQV>zJff2!%pByMFUy%KYB z1ure1wv*Vwr>;~s+3S5Jp_HyPZml?II^i??8X*R;JafUcX$EfpU)A^|L%QypzeN)FgR)=$ViX zGp=oqdW;{*{o}p*-cn?I6ddTpWDpB?@FD zOOdRwOqB>SFR0bZo>Lewv`Ww?O2ixun$wGb&7u^-2fyLexlh{C54Hq*r}tJ~yZpWW zFXs36y``LZ7i!$UpMR)uH2DlH(o8<3Q8w?oXJwp)8#Wn!*!k1pqmcjv6;+>^!#kvx zcIo7xisj*5buud{As4U43%!;E1?__*W9NsV^3TA(~Zm@mZ~bf$)T-)rp5W@WKd zVlrHE4hI^{mCx%c9w7-kw)NRgt5J0vERXZmNqHn27n8p(RQJOw(v= zF~d&+yMxZTXkS*>YtyeZ%eZ6!5#0>?iZVSh5)=SM7Ah`>-ZJ_u5bjRKuUuW|KYe~P z(Z=NZLzh>lzBa>w$XUC;$%~&9Ngu4KL?y-hroBlDMlcZu;;_up)w8Mu!71xcNe4#Z7(UO?`R8_hza%QGAKn_`vcAhURD_kE>Obt^ z{=G0eVa9#?XR(Qj_9Lr;XZ6Rn$v*s5lYE!vPm;z$^(w7S{Iq^YsweaMemnji6Z2@W zOVaN|+JjrvVUEN1_GqKQPtkNrD#uxY&>*$;s6)qv8hJtIO#PW(1*zi9=GrAtlUcmj znhQk#sA~(>Od9^L0rdL8Q;&Gey z=0r{z*FR~4-Rrk?k(sR63_xX|QuKFo@r+x|#5!J2jQLp_tCwB7g^*c-T2ci~ z*L0WsTd6E#;YYv_0jvv6fMlqpFneME9a<4)fHMh*TcbhpuAv_p_3>bEsmLfHbtVj0 zs2l*trFnousFi*E(=VY&;+m-iX%O)+49eVG1Lcp>#i%lY)DRRlD5%Cz@74z??r#~e z5qGH@cJhkGO+|m)DcJiY)I_DQpl3TAVj@D+Xc$T}vU-SJrjVEz4$BNFJxXpj8DZ@` z>~x$k++9NAG9QIAX^S|r{~V-?sDyfQ8nHMd+7ECc8O)Er9_-)y5YuE<^qrZaLo!mn z@Gt=oL#H7eCI*CsMAAFMdo!R%X$&nGxR4z_%t-`&FSr{dLdNUeZ59WaxUxiXBN(PA z*LslHTC?iye|~a_ma}j-zGfkIeO_p_8ykjY5HUuVQ?BrEtqk7N9maIOK9S zRRB7b)FAZ`s(9m}2K!+`oeb&HdFhGt7A1kyOlFX?hI;$Fm3uIyQdhO~*zDN9Gj`QV z7*8KK;clNO)(qppw{KFhJ1X8Uw18Mc+h0|X>d0O?96d5;gi9;{q=Oir+ zT8tS*fce8OfQ`G0Ud75%0xohmc8swTU%iqwApH68DD*Sn8x1> zKX3Ht*Hzk{(*d@7-)0UrAn^98Fhd(ufzs!79{iiIYc!am0N)L17Ma26Vc8A_3#0e? zV0Tp}C4-?-oYEDBQ8ufWYzxbqNuF=wlC&Ml@1?9-{jm3oZ*r^LQ}@+l?3?)8aN^18 ztYYwIdeShlg-x{4(%9$s)IFQUTF}xWNBn)?s@AXdZjL*~72Gp=mapz;G}_w2>1Qt$ zeZTFO?d$l7+vQD)(o@5QfSAABt=)Hynvq&AH!%QsfPov*#M18kAZOtu?8oh@SZ}}A zw>tk?8|D7tC{3z=aNTuHwYKqRP*k$Uhc7?E-#m*6P91XeD>=Nl`J;4|%Cq!mjhJhvV&#TE$`5Rw!3O>6`-GS2Db5uHcjM#_rOavFQD<+u*WQ>f4`BGqw94 zg?Mi8Qq?|I?4EEKuFP2$yUlznj%bi~UNFsh*8O+)yLX~=}5H!}|cgZV$H#;12^Ir7o`jfBkzTk2qUYb!mQ;Omjhh*>k zKK;D9`Bpr7EBf1SC5XUIkIvsu>A^99!a6^^>fY`CGKtP#D&M?xJ@)JpwRc>+;&ega z@9q`G*cj%n57QT0ze5;*b}M}vAG=w+y(Is4`djSxqf~+U2VEyio!>Lx>2zijyPm(( z-q6+g^x)z?kM=+5PS`qmc1i0gixyW)9jzYQ-!GDoQF4 zUDCAK!LsbW=8Nd&EXA5bdZL){3qp9D65jG@PxL~Mr3D`C*^@5aO_h_mFVWI2*(V@k zrMvsIDQ~PX+TP1Ny$;g7N73EzLab(W_tvp?2c+xZQSaepT|=kd+<@Mu|8%eY z(RHWm+wAUX`-s;q)oZ_^SCQWf{m}PdzE3Hs_^oui?sAuTsWxvz=e2hH@t5w6V?FWZ zUdg9@_V4=q3i=t7^fYApT84E8qk6m(d+oUTzx(NZyQSxo)mQPSk0pY9n%MvIkG@-j zE@!*0yJx>(3ogK^k2-7+?1T^E#R^P6cAw62GI{CD+In62b(lzBP{Uw^Uca};;Kc?5 zZPcJp`+#G>z}78;ge-%14-BBYhKi^m;p#yLUTk=~_Kl>**p_sv2lTb)S+SR11@K>Lg&*mS|8fkwBoq0#NJ2p>@#Z`>dBg{4r2CGfdHYf2aucWhU_( zAsi?GPaBCos_yY5&S9h{I0B!kcRx91u~3G(${b({d|`09;0=8M^|h znDeoMN5WXJ?L^8>%hjOfo;pp1l<&$EW2S#cRo^7Vn- zH=)W=S*o`Rd868h({JGnm4(q;X(B^XAm4;K@^H%Zl?lr5+Trjg-7C)3##dTCtXV+l z%@g?~K&`G&m;x94ClXGmW$_w*p=p@jH|SU`O`EMuCwdXp$g3L#zJMsSIk-SVBumwU z#hI`5Kn;BL2H~a_^o0}j`5$PrEv}bZn0T5~nUt?7=wCBFA(Le+mHDn=3+_+27Tnt% zmeVpsWWP{csZwWC5gWZIZmKyUS){=>+^*Swmj|cXr;p24!JDe-_G>nN5!CXs&~DV# z3F_o1Gk(QtDEHk^zo_G*!i-vwW#ZYCHvPw5$n=PXHG$Qd*kFl@VBESqW0H;jjVO@= z&61F_Zpm!!Dzh?*vy#7NJXi9)yk@0CXWjmmo=(ib*Je~?ufcE3T!i)8ZSZDCaNKFZ zDqK$2j2)^Su@Nd8vVEl)vLP+XH?5RCsLXb;E)=b|rxEzd@P^j45a@^vtBFO6)kx-j zJyUB_`Z6}t`3Dh`@ijBV*nUS*-B|hos`Z{#WH#H)?^*UU?;SQSUmL|4co|<+9=3s4 zD}A4TQfP;*wv&G~?|L%*M`J;>XpXLC?pC0^O{~3qwmog>LX@dJm$SVJoBa#Dxf>g^ ziy!ARv7)4og;)*SeABr{dvkSX3zr)g#9|kdGaa&SppsWg*~@ULdvA3s`Z&UAWI zjw7Rs_!Woj|CVVsY%kKUh!j~Z$U0LWXgQb4IxN>Xth{n~;kCS4vqDK;oL-rp@tP^$ z=oyY}9r^oqH1^$+mt|1U(n_+Ww9NYfKI{KBoW45SZ8oHciYH22CD#~T-4>Rq2o{*<%viCW`Adg(IT@1i&TY0}7*p4Ijn zZvMBvOOLgSOC}{Qb7iM&#kkSA5JHKST@Cua8vJ(^Vq^cSY<_KJbyx3y z1BbUgCj;ettMP-g;SSqt{x4U11r~jD;WybBH z{^Yw?{eCGF|IVs_{VM$RC10Bjz1kW5;KejPpXp>z>AP$DHEyf)KA$=~KX&-6$@;v% zG3`O~+L>M8HjS-!`G(5arj^Vl^{f8YZA;$=?pt04Y>}$vKKx%$s+&&brJgApCN!JZ z#MaV+i-R`T%@{tL8!QmneX=9HZ;ClZ4S3z!pU+a=ZjJWU82hTa>LauN_1nhwrx}OB z+4V}*^{Tip4{hA8{PU_{*gW#uxv9M#W#FT4;{&tuckA4FFt$^=x^ruPhqc--kRf2E ze>-<}yG7Ig-qjsa@an6$)z(_yyw0J_fuY+0TiO5o@HX4lZhlt#-brWP$!A|TYW|aN z{qMN{zvD(B-n?w?S|E-N24Gw$6VP!Ts&Y zfBsM9e8;W#*fn9^qRvB+ zKxz8w(W$}0&;5g+qoG*@7}W@StegWSxdO)MG!x2X68R`~2n3%eYMc_y>{7J89(zS4 zYr{{pJ{4odPw*E{bPZ4RPQ&p65&GxNIjIr4)MKN%6XVw>S`{Z(=1xqDBd(sFm<>jl zbKEc;Ke5n>V7r#4Lm*lE+~A~0u`mNmZRb&eG%4Q%OY)6N$98gaO7a{b*L~Q;1i~Sm zhic2AA6!XN*@>(r-(}>Lh3kSvs5cbq7Th>C#O9VIT#8iGK%ok$tYl8mPw-20ntJ>p zUCtWI=2!ZQ{?NKF;x25V^CV;mk(bB^N+ar{)4%{RPJkHRW$k)VoAm8y>EG~jr&|Dr zXH-bBqXbt0nn3Nn8yZ|2+OZKLArpQII>=m}v0~HtC|1XjH`mjs`8w;k|cEFvLU zVn%H_;URwGAqnwFH;(WCn_F6}oJa;v*-w}6!|f}-Dp!eDWDbU=nB59`t*PkO22cN) zSMd|{EUHiCch*SM=Y^lh4X^U}NaQUWSN+*%KFrTQmR{YcQE$7wie7{la zvSu3w{LC*xbn9HsyTNGce6;xFpU&6OWV75Zj+j%-8I%-Fd@~oOVw)?#mM89=FYm$7 z_3OsiEssLB%EO;IslPxuw|mQPTRp#Z^XBqXYJS4#jL*%pj+5{A>LM!}W1iK1(``(* z552{%cgnBrOMU3GI9co;sI$G`va_7yxoXxradYL#X~0L9`@?gAzCIy!cfIRpKYy}~ zGBNNU6pM?sx%trhw4Ubce;mG>jQ8tu&c+39tuwNHVvH}fyz(Ph)|=zcv{JR%-Z4pbzwnN|=KP-x+3LRar^pdwj;H$1Zc3-DXyiAz z-0@YSxm$lRXpQJX|)>4b`-N?nL*SNkivC+oQjC(eDDC*!hI z%X$)T=a5h&6`K;}T4Z0AO1G7EuJz84@_8q>__Vky;r(huFZ<#~ z*_(%tcgsiqZOfES7;}GV2{Mkl{*b5XgU{2>U)(z{QM6YCo`-Nfka|({_(Qn6Vjc*Uk8L6|KzswY`klXS(0v#>`NX0 z^>gSQ$MbtT!y_I2)Kw*9TyObT6YZiATlL@0AL4MmF7HoL)wbPIZhy>VZ*RWX^sQ*v z`rem9a8dD#(>1xcf_%!6M3g$+b@T8N4_7bVc`PClm6X2Z0-LeMpME!sseoXDp$OI! zHoB;Ocb5oXBQ@#@D&l6iU{lM*3(zTG(Q=4z(XGfJ*^E*lo*s?bl!ZkO1F5!?-7%0!ZA*gDr)iD0a;N3S7kEB&f z`s{)kOY#*{QRi!NjO{&`I3gBlY)&$g@VlqyB&bvuW#nMbbT>ZG6XT);XHL@vaJ~t+ zOOvK;C6%R*P52nL-L)d`Oyz$otWn|fNK`<1GO?KtVU#Im`!Fk+Ygs~UH)qGLUkgu1 znvNiTDxfXVWIn{2A$@r+S^|M%lCw@yKN9?SZ}SVMa);#A@FyS3j#}!pJ06?HOHEfX zzp7VJk-AoJf4WlY)#Ixxl9m-x){hNtJh5@!u})shHCnHHdVLgh{>wg%)B*+uu|urJ z=a~(&op2hu@zW$ANzMHwVIpx)VZY)pj`e`Gd z--(rR;h|f2f7RwiVMoJt*n#b^``u@KPDavT!Np0M9$v67j+f>|It=4UC)AvLfx6wF z@z$$yN@@$r=wNEtxrx-{OyhPXpp^)gQkx@>1jjF{2`^sB(_E`+kCBkaWc0Jr8};&w zVbe&3*y`Jy01Fwjn(k20>iEXj|H6}&?EJ}M?=xR_nNTPOm4I;@N&?sglm8mK(XMX< zU4kU8dN&=nPPU5}-uTY~2(f6baN0PGxNHo4{rZu;=fQKD@I3lxuiW?g!M!C*mwxa+ z&7!(IsA*I~aWUNd+17S;kf|GZ{g(Qvgon)YXfxEO4z_s}euKI&q~zz7ypro;kvtjE zY7*?!i{+pn!$gkS)dn_oPj!Q%J2L~H%LofnCRdHvTid<9rM(&P)>gXzvB6vH*_+Ye zxbO$>QD4c)v&G_xjmlY5#A1vMCh&9v8c&A712FbT3*=a-t69b0? zi=TZ^&Nf>$gp)sL^9Df4bgR7b3-f>EyptqzjQ zO4n@PonM4s&o7B)Up0nLOzHHV>?${|FY?mNbH-jErI+b?XwWZoTSorT*80yegB;QU2RqhsQ37)jXoKaQho1z%Ghw06-K zNzg@os9HKz4&4i}){$RXUj3mI5KFmPAhIg=;FPdq>gx8?ai%C(mBe56Fb%}3fFbRAQ^_bp`;)^$1;`j7W%m(#YeZPfc4&W81H$DM-O-?Kw; z?0GJ4m*4+8-3B)qw=phL4E5RsMw>k9F6Qlxx4!Alz&pWxJSh zo-b6%gd4?vu>nqX*>hF9BM)C|gx=F>c@>|whq)HldRP9hvRO{~*wek^XUGnUfsX&( z;@dsG)HjP3mnS>A%1`%ybWom~L@9HxuBPSu*m%TT^@T_I*XDI?@dsU@uNgIdKP%`k zRO=`&Y$(#^nm%T!fYjSoi6Qymz2E zg8pHu{A2wIE?0V1#%pS%E0tTh|7zu}>B`^kDH?AB#P#JJS;I$Li89p*;`dw+aUbPg zxsLy(UjNwPIx*R&W7Ml)q)X4g3R_)1A5LYUP5ybqlyP90af*lIudZfbqVfcVjh1q} z_Tcj*=c`+Szf5g8y`8xK_Ntl)az{R3Tcs>*U<`xSB6llJzJKzK_@G~!2vp-uJl%|; zuKV<^Y;3Lxe6H)~fkrI@P1KqKf$LBO!+ez!b0HPe$sib)(mKDUumv$t5V}q*16l>! zIs}(u)@Dc7MrQK4jCG&h5aLvK-NjMZSBKBa%(?d6|9<~0-pZ>WcjuRvBP?!(JB3f0 zUti*=l39+Ag`u29dj(wkiOJZB*#M(@&Hb0X`>NI>?pncJ;mhfzELdYIcpOOE{_SjqWE?! zsMJ%OcO8#O;8jQxLcxW|-MF^GNRb{M6x4GuRmh~)OKubEx*29wiz86Qf}*_f#Ldfh zYyHZ_{A+9do5TWIYXdsP0tadX$HanWYtP?tgEwn~_r*ef)Q0@?M(QW<62SPD1k4af zcs;TB*P=5afj8F@~6UEL6e5JnpI!Qnc;t++8-ock4uE?B|$zO+7U%=}<3Vr{9IT-m z*NkO2x1Y`A=qAqaxBcAb!Z?Cx-0cHv2AHA%RLR}aY$I-h1l$PZX#@hR5z($bx+px9 z7ld3VJ0R0Xk!9N#Sp&(8 z(^#lg&o|F{AOa6Xbkh|QRXF>&o3Tt3EJP&1uN4n&P5|`qP$%CA8?vBszf_NqVOk>e zToAV;fLp-#kVHu*J!LB__O{=1R|wRkN2ehHyj!5(0#>!cWrYnOrb*t}1vsm21}Eq_ zNqX{%28|^F>kztTP%&SktS7i2G8>D6o$F5QGQiQ!EtOjbD0kDJ-KjqypCeoCYNCe} zlK%fN_UG?V|L-3^{G8R;XU4vdvF}Uv#0+EKhHS|)Bs=iorfI9)W{WkS?yI?iGmgVeSF1>6)6ltd37hWlM(NHb~1#b$7yFw)j zE`QdB0Eh-)3&iMJ*O^^$ch?Xc1itJ;Bdr<0c~_qDH3A1uLxFZT;q!AET z5F9eo69mGT05N-VmrEkEG=8fu30 zI4teE$pWtAvN3lac%Oeq?j#ZGM@tz5lGyqrENPF+|o zG2KQbpiW7s7>?{8-wnPyB`r-;LXg!X`=HOre7ynX)pDnz0x3Uk2)Ry6FcBAI09zKb zOOiKRqk=g%RHSLrCp|2~gMW1T&-u}5NArd>CP4S74v@#AT?rh5UG@JAS(PXC=V&|# zKz|MlW#3I;+t7zn>X}Ycvt34WV3pfFtXnkSj6j3r?wI(3B2b!1WYirZLVzwpQ)~nN)}+o=c0y+%&7NONE4Xq3y}oFJJ(= zr-Z??aRO)}sBynkQVrn7;h{6%^#PhV0^r2pP=2RHK{8E+P%$ksk2nQ3cgpymy0@r+ zIG!U7&w--@{zbWGdnueplvYRZo$eltH=b*RqQ2}e^-P(EPT{0c%sxLAv1}Gli!}VB zRLPodU``Q4e$Y<>BskPs-NC8V z!9(5Ax7G2Ax>IzkQ-Zp4YO8aO`i0`w3l-`vb*(N<>KC84UhGtN9cXoZukQA-)$NPA z`)aHEj=IOMRu8&5Nh;;^kBN^HDkTy^l4|o(8ej_rpkK+Cl-f=YRsmyD;JP0mq|)Up z5gNV>DTrMfE(in$uKE_Y`QPc|%Z$d1bkF~fbbByg`n*r(kqxZ~J8rMzEkj}lq*WvIY6cPM z*fN+zw;|O?+{(z5ALKUF^5A@)JiUvVYki_ATg`*ZEMK)j3Lt?nmBg>?hNV)#+I4f~ zh6nJo`%lz|CK#Me)#P5Nz-+zv0q?u!oD2Z;bCEaDsQsTESx^V@?4_rglZ2Id?A51{ zJZ*Wj`aoJXVD=+lz)JXDHhKahPvHpP_LpZ}Fm@{P;OI>QB|>H-nf)cho-~Hrhe=pF zKeQ~BB!hun^G5K3^_QXqh^CP1Q8QUz1*$^leoHd&PQL{Jp4oXToWM0TlVx3imiJ!X zc2eZ;ty%%VgVZ-6!UWK|&?N6J2n6s`xkIR!jJjyy;ZH;B2a&Hb#-26nH5YjvDor8` zI4>A5j*k<{uBu&@a<)j~>n|dJ3!>dE)*ne>?a^;|Jgo14a%qgHG!BO(1%T!efd0#~ zU~Fqkr2(FEhUb;6?Dt3(sM+aq0++iKF3+Vo=^e(WW;`uOEjc{B5ZoRyC`~^JPvwmj zJVUe}MueyEC&_b6ohz6`^$V0O@Z6FrUcQtq>bupIr7f3=mWr|P_0m8KVXv01^pfzDeH$e$n{GxF5Tl~30b>T< zOPsy=B2vl+JCVY7RV{#+%a}B6VowCf$_YH?rwDe!n%M{0V!Ee=z_bm~KvC9nw^QEQHp$Ad;x#<%$`#~Jx(v_tXeWEdj2L0a-nJBZ$1U*$+)ZHbV+$n zn`PL4XhK3bt{g9BJBXoSrNICU>y-*il7Qq(TiSc!6K9e|Wet!xjO$njRn%C;7Egeu zt+pkUe2el7qrm95pof$`3HpKs%Nh{_kQPNwZ|sP!?nFPreK2AzX(y>Bwf;38bOws! zqC0n!5%O5DXF6@U8lA#T?SsD|nf2Jy7~lvf6SuOcvxX-g6h{K$s?sq4Eip~GTesqe z-J5@1x1nobkOqlS_f)lEEiEJ4U~1uv$xW@F8(`Nu5=0%LP~3hffPz7>Z$OH`rg+7` z6B7x5MlOXVOB7Y&kZubyMJ+fW2MGe8&7grPN!i>n+N!jP=y19WT(Mvogj`4_24NY2 z5}ee}+M)?iC730xTMPqA>PD(!NpHXL>n*11?~+ld!5-FaV!Ey15)9bI+v7+t1P<`% zbbA6wP&viY&wv?`i|fJi@w2*;*=|=t(C;eAvIHv1%&yx9hoh&M;RhH#O4B%pgBQR4%Vhh!R1K9+7n zssb1hpY^>-FSzIM=yOQ~5br{YgEy6dn@A#5cUfVSy*Lwgvz}wI(BVQ7TV8$7GfoL| zZzDw_lh>D5u_|2wg8@G}Vo*3`?6YONLsx$H@&N$kSv5Af(;ml(+)Fb(`O2z2({uM! z(F%w!roi5k+0nM?vYaGPORgzMI+ww&atY<61wldDl59>tC~7mMa+n(X4tA%g%H z(*1?s%3<*^nGzN*|09|RC z9M%8&lbhML=W62tv}tvNY#vMnH>tA-Jo*V;+aPhk+Wt zz`25wL_IZsn_#__Q_XS>P?`Xar8-ZXm4;!@TT7I=Ld*OAF!7tKhUzYLoG1OYaPJKhQS4+_5@LW6ZU7B7gzyh!(6@=NU0zG9O?-i3XEOK{q~+6 zr5&8uyL>Odtr`$`yC)z6u!AgBsa>~o!eAr>pt~!gO;n7$kY~xa9K+V1nHH_Iz>VXQ(iC=4V+ZL zN&{(ln@P!QdQnSDKtGER*BQq1M2eL^Dck}B2vJlBmMWPGkm-KZEb!aF70Jdd02BJfT4aM*Z6_gDlE;*0|M4xmcmr1Ur6~>6 zIF2q=RL8dQ;$YbMJiWEsFIgcffb@7??L_pjW3U<6vr;-jkOs+mGG3(go!i_caJW4( z(n6Q#O8O+F4YikeJ>#Bj#QTg%c3y#QHz z?DpDWc@CJ3<{qE3=8BicF-~Ld98}_LPfP&-+GjDrNb40xexL`vkpQY&7su#Yy{uZ5 zf17zbCFWj-6aIyRDW;46>_`Ceqfn`;SugizJV*6qCV2{z83x?U!L3e;=*3F%g^MV2 z2MSe!K2M_!qU0?i3W zQn1tGavbs0$c?y`A7yZO_AoVpH55265nX5;jlSh?f#xC;A?1hKWX$Qh8i<%ir!P2( ztLpMsLgPZYPD?U|@f^Y!ppN8$E8>anRR+dD_EUiuix>bRRE%5a1cyfMmzJiSr~9D~bng|LeqJZ8Dm zz&RX@1i)Ea?7=jvStM6eTLKsanm~Xoq$I0Q@T^l7oCI!y0?;G&dq@y;3{2dGkrq-_ zY2*-$7xMV^|DK-=~4MECVX2`Obw6EmITyVRTaVz z8x#?6D2qWW(|bJf!&?)bx1N5fc=`hDjOncp&bI0X{y&qG6mIzk70bH*PZth#2+ibd zQIAapys8n-yr@Sw=rj7EAbu=P-OH$53UKu%f=;cA6X?1^aIoLCwK`Td8t|E0R2s=O ziiGt*PVrU9y->fnk_-zX*a!>M53oZ*0sBJj@G2QcMA&WC0`{|Os#QXO2?1IPtlcAj9Qq?3;<)n?MF9&=9}p8n+huO zK}fTuF@SY9OM&7(^fps%?~=_JQY|d&Q+w8DQ!;qWK0QSYJ3tmJDJ}hxz3q&wFpU3Q zPoeA)YdAPkl<%hGIzIsbNmCAqpQ;E(fa!&2kc8v|-bDSxyHlnPR>`*ti=s|F-#u5& z@{2UZ=`z4=Zpedh77NLQZw!F444|c!A73cDtIX)SAfSvvv7kA;q=9-2&>LM^d@H5y zKG^J7EJg~L9#=mbEp)QL=%35YkK_pKO{M38VNan7DrqcFxz$jl1aeV(YtgsyA}=by zKvvsnN4!Xq?d@adAp=TcsEYuGA|vTGfi52aJ=DUcubYcSvYgVgT)e1K063l9UO30Mkk@FJjbKI=ZVwHI!Y6AFD9yWUf+WK-DGfsgN$jp0elZNQE9lsf_xf(}cYO zCAd`vrFn#?=R^Hk5V-R~>V|C)z#Ff&SFBzdXJ>o4j3B1lP~tX;BjGrX;gJd|I%Wa4 z6)3mqNM^=LAl*w9*abZ^KTE>jpYBHg%GK9Jpdg^@&oi=Ihe|y*vJ^yJWOz}d&3K>R z>~II*&SjTjr%UR$;1>oXcwz#Kp4D}J3N5UKt~*>?iK_RaQ?0^i%@C6^I?Y!b!=q+L zY2p(qEcH8WB+5iQ0gJX^aX_D~|D(zpHBiG<23>j4m@S!P)$|4)Uq3GdP}YlC>?a!{ zQLngsW^iul1rP0~;9plBqV_=0g|^F+yyLs_YEK{l8PRK0HCl-nE2wJy#hy;NBoAU3 zEiJ<8fSw|NaDFbnC2+IX^ISE9FKs~nhqPlPgFDR_K?FI(FhX(n6mFgF{xW_^0)0tM zS(K9f0L4-=03*XnF^q=07P=3b3I?0N3r+N09ux*%oXZ$XhGZa7EE3RyN=LRzdm*R$ z5B3p~v(S_=#*9k1>~5KT>wSgs`;YigXXs4eBxR;VBDiDk3H&}taF?M*88Nr4E9O%f z%Iwpm6M-hef)?Q1i`X0d-j8v07N_=g00wOaN%?O2H3baFd-7hX*7`fFawbUbdf)0+<0< z-~#*#jJ^8u|MBniW(Kn{AezU_MHzsQA)&blDhPN0*mw2=Qp@i`U*$QND$p)Xzc zeHtbJ{bu7?^Z9OfsLn387Xj~I?01{-_XvQUa{T+)Xj@Un zdwbekyS37*K@ZpOqd~P-_(=EcZ?982zzgu_eY)mEm*a+lA2;#fm2bwE z(TJYopih^cJ=kYp^uwGPc&2;?I)>tABtA2ISoZTKf;__9jH+SLJh^nz=6JQ!s9WjgNDPtrJPR?cgC?h!#%Jf7U zhz=fNiC|Lvs2ZuvP(Wkf4rP)IB=*-ahGQ6HEI1l*Oz2maAB8gI2y)&2uFO98(aY|? zLILk%<^SWni9r`YvtkF#H^$&i-RyOhsmxGB5Q!lxcR~Tr+*YRf>nD6>fH9x$_9<6Q z`Z4*Vlmy#pA&FDi>}G-NI4~1Cru;ILiBSq@7^@JEW_tIFeMOn^+8CUYdzx1!M93rl zeeZ8Shxj05j1K!)%VBo=29x~DkcZ^il|1%4y9~iJh9V)`(a#l|wbNto(07y>f-4cG z&t&S5DOnVz)iT*>0jzU&T7g>WJjanU|MDdCQ{?5 zp)DfF+xY{-zKzh|Vrr5*v!l$`x%F>U7^lQ>j$J|j%C5otJ;KhO@%!CB4WW~Q}H9rAKW#=M&5rJMgDyJVWxU-+S z&%4OXe@T2cv4)+v$oJ@3>y!U+$T(FSxbP{5yl9ZZDx{ah zYrCYM!9{mi^s@chpS3g+2IaF`HqDc;DnF3|zL^&(xMkZP+pSoZiuS#@l%B(9!4g6Me2B^d3z(maR7PcJl(U!Qqj6Uk0bBaRU(+Gs5qbrtuXz} z|6@n%_4D_8GLAA)`A%V_Kpgj?Y;x(r15#2FOzlR1{Uh>&1R;Gki;_)Z6G_y=ID`3VKjfzu%2>Ke;lBh>+#I%Pm$97M|+1$bH>qPLGo@lTw3#`(3;QVgAS_R zcMgmAb;{m2K|WBjTy0I99E6qqs}y@Lv%+GLqu5$=YlXHm%aN^mB%Tza@HhTzP7A9- zZ>Uc6iaA2Wvvkq7@j@|3(^y3@A5ayLmhb(jELVg4UHw@k#ZD zX?mGfW}_vUZ_UIz`NN)sgjcOrhQ$nq3`t*d4SfPXeR&rlBME27Nbm7F(f^>`DGbtZ zRfaUl6nVK)T>l4CfiqsFi>Zco@|KT4A$;NVhfH72*qJJ=PaySWloC}3O~iiNRNhFd zTEWDoecGH5?^4TYOYARrhrQv5#8|00`El6XD*|Dt=b^vF!0g^ah(b8<;jJK#HIk5j z)|h1UFp#q!iroW&{hMy5&zBtl&!_r67!+lLZAa~EVvf^der>>-- zvrd-$gN>#lV(^8F9@(;UsU-b&HAnc;gF31M$uXa;k(b|yp_0EuQLEDPDM@AT)Nv)vtg5~x_5f8bS6jq93Iv|Rgu2)cwaO8s~b!?J1#$q|&5-KI~ zw60+KpIw~`M_(#>tv_@nzoH%WYfqw#GQSAZj-O;k)OVp}+6@ds79dt?o=};L9>&S( zRQI>m#>R>KMv=K^or0C=i7nNAf@#WBYt9{!6kd>hB`v9^@zjt)q8#uOQEc{Ph$a-L z#Fj@@2p)!#i%{F+EaQm6SyP{jUrOJgkVj zI6yL!0Ixhn@(*drVDh5A{hl19fQHPF8Rl>$7GyMvUI#b#ve0coHiCP+0B{Ew$xW1E zTDXy0y7aZ7Bv=05<)Y9Bmp$8#xMFv)7T~oao!9nBGKgLw2(b?j1yLz87}m&TfGr!z z*ry_qL!ozJMC4R68F(xG*>}fds=?g}x>SzT5f?StW+_JkximY@lcm@eaI5iVRtilq z*XtTgXa<8XINwum-px>6UJyA(Ql-sqqq`V!u`+W z_`{Mk-7W(ryVe)LAkSdSw>qquIIyQFqb?mam|!UiLE@6NOK=npzXb+?Pe}mh7zi%d z#oq!@5V`;?xhM}C!ikeM2B=Kpo>^0k-CQX;&fTX2kwI&p0@Ew!evRoTImwN5Pci0C zPL|V8i_bCps0(}=3W=&u{TbwEbaBQNcZp|=maIxXtspEKmDQ(FaYwe~UPfm-)sG_U)^O-Ap7bi_>Yg#iM=89j| zBTb_A=7xG)^WWD~NA5to84n#I(1pkml@*d;*K!Z5mWooT8{GSyxAQq8_wa~iSD!F! zl3$-tL_Rbh!Q6soazJLvU}$Sk+abVkNi(OMWgo^u>Vs3)fuiQS^*XlY4+)YHl{p3| zyN5|4S1|_YiI3?V^*E;R=C>T^N@X{3FJ#C9MN&r;CM@q+0dDUV1TQ8^p0<(ZX@S|x zb1ij7_86{UCgo~&6P5iEu@`3u97UmUKo`$cAL_^{pczQNF#S^dd7Js;=k0;+U&cSg zKbE{i{mc8GebOZ7i+o_4NU`qqV!#mzlJeCIaA^b7OnW!9HWcA_P{o!@>VdlN(w^aO{~Qw^gyPQn??Oc^DxyE*DXcEBhJCsjJiaH&IQ8e;Qfcsj^`U0OGRg(tRm z*!}E6(DG6aj?C!20}??1J2P`~;1Yk$8AH?0hyd2_)kX2F{&=~cFEYvT zN*U66{C6G2mXzUDpc=NZOe&$2MCDX_ey*fYhKCXDC0g)6-cvFFvOe_qG=niFXEc7+$avGh z;RMGPhjPl)!ky`1h7*0Y_n{ks;%Y!{5j$69|dckN$q|H<4seNWLa z6y|7%An?LMUK==1=$vnC+3UfwpBO~wnoK2XP5&{;ZZNs|(!_gYfK||>F|>aM=t)U5 zrU;q}%e@`aHl>GJnkrfvg}e5p^ya3CcctIW$>^=P*=_Rp{M#(=x8dGK2N1JEj=@zX zEj!Dm&;!<-OvH!Hfg;N{#jXP-f`eYY-B(6%cY^YgM{=_{&2r}u8m2%c;q>M<^dN~0 zRfd$dDBlx5HTt0ATkfVVtNU%0XE2fnCBFVn;rF`_ETc5R(H~y#1}z7EO;{`)Sbdm#`F4EZaDQk3 zWMTcE6{DH;yAcE1PX>$jR@w5S6c(EBUXo#?>8)o``(s6A}!BEya)ZYENAIqG$OLK z65j<8M;qTyZH-NHsv^HxZQ73=^}aoBdB>1t2`(f;z9}Z=r3oT4Ous`aU7Z z2Bcv2$(494Z+oC?`?JLsd)am`avb&jy##DRGI>mt^_}$RF|lMDdXOdXW>B%PRqC^y z;LkBk>i}Kp`?$%m?eEFvZI;pT-#VzOcTTM0I5JldN z-4^{oIrHI!aGvYkpv<>%!>b<%Z&*z4OKA7;>GX}@`|ONw*edrCRn85ag-!jj{Lp+b zsrC2#LeP1oYajUj+KUF;<8Ro{6xci6w|8!x#9f?hd^lC^I%P5Juo5>VlRl+aHsvM3 zV_o>pQ{kM?xxq_DdEP?j&%>rU3$33fw*M_~Jg%7*c`|J$Vb8=o&Hlz=`DB`x^`q~W zL&l#e^{Hua*{C3^Z3OF76zi?9&qFac-d}q&e%;E!@w2U)ge_L=&B~Y=Ie8-T=d`2x zw42d%w7MZZLBT%d+<8jhWa@%V;v>7H&(_qdc9~c0v-%v;KI`20Ynst2ar38LUaLdC zgHu77WBMbpwq1V6)V$nZ$QY8iuxB ztu{EJ8J(-nLVZrMFl)Kw^9^M#4?jD{6nsj(I$I#*5-l+m-{*MEXzEEas%NeI$&c2M zsae%`A6q_utaf8=cWY|+Jc)ZW{Yk4~TzVq>^993Xmp0RxZ_YE%-{J7>6afUZ^@zca z_Cg_)Q?s5TSXtZSHl6UzW#z!-0@o+`b02RcLm7@BI5JsV2NB#(mWzRMmvHFJ0!A^3 za3XB%+-LgvvdO-_)_(Qu0j`S*%OKegU`~OwODKd@DBvMTIg3PK)_Su1GD^qX^N_Uf zKj(MU8FPRydlDYmYxDa?U-r&@Ik^0#v_1V0#<;cy5ReF?1t2MgYVd~vwg!#HkfqN< zYJ29-k-wBWe*qhl3Xor*KBNMz1$YW6H)a7*OUj7xK%}t27dkD8r$4e(FS~SRBGd^W zFQdr17*G#}!YWPSj-q&krtlUm^3^W#w=D|vFA5edI*ly~A1;c(moVH*yd5w%-X$^P zC2>bDVaFxOs3ob#o{}j`GPPc!9m($XUKnoUp?b10G2NsRIKQ5ikVZDEEObJq(KTmk z`e>8|^kX}nPtP7*ShUhw`pf#2b?)K0T+TE|MkT~hhe?SB${2%zV@wz-B~N1r3`vg3 zZXeG%Twq-MI6!b+cz3BY3vq@7iY7DgU?7Fgi4I8MJc)e%C{?+{2xJNtMUpQqknaX~ z58PN*=5ipoT{LHN(=Oun?PCwjrRZjYJUGcPB9wAOMM$4^`#>o%$#1I3SmhFD#rX@u zQ!bAuFHVoOaee+O!DFAMDkftA8cY6n4iV3r91VS2Q8-a~+3Ahjg&;@!;11`v4zn*E ze2e?Mg)Js{72GcWb#qC+;Q4Mgw(r03chUbQaQ{hg_Az4V3lwRmvtVAijA+b{RuS~{!0 zN8xJm{neB<-&!|cw-8^QZCWnuzgyq^^P~LEMR`Z1ct;m`cTBC8Sn2?;nH{qW84qF&aOs3IBQJ(f0Nn{5@!ZWv~3}hsR$h=eOUpZH^VK z|D0b3oNV45ZkTd~Wv^_zO@}u21x)mZR(;#}?YFnPy@hrP^E3=Q?zr+v&u`)J+KT--mK&Zeuz_*Bo7?cQ$zH)_Hljc8Vm}>I%SLuF$!Eg{SAv zPGtvaT-m)IA1e22^S?tswc_x}j)*Dao#)#ZJ{E1#g?GLv?ub={YyJvj*f|5|2}ekU z!|#8W;|l42yf0FxrP|4T#$*?g;QOy_*OcMF%;ezdnTuuvVTvF3)J#H@rMCHY?B#z& z_7sI$apsbpDigI$)Q&qAPWv@g?H-_7APPNOq;49_)L%B4LIMKV5mQ z7DNSpa6FV|k2+@)u2&qQUl(GRuph7!?volOTO6h>65(XB@BiyNR^(vTI@)rFU1dPp zqKPl2;_8Kg5Eo6Ci@uSrzx*%JBcu{G1f6~eNrgHja9(pdb3K~Hn;wN{h@wX;9e7p* z`91%y(eanD(}W3qHvN5+*Ow^r&Y_J>RGPZ#4~ zBah>0?qgf2q{*W1?#fdwVD5zvst1gMW7) z1M*tX(-Y#t_j+1`|Ap{?AB!=8_E|%k)8E5MDB}R%RFBuD( z{qX6#trb1n`yfJUtYm4=x-Azw0tTna+WBWe%#)$d!;Se0RXYVt?MMqPA_15|oewJx1% z!l7A&+*=CI@)$i`vTYroSsSZ1iHJA)t+p}Q;Ph-h&cbPP=Be)o4XZyI+jAAco7>;- z{Cwoz>Cgk=8-naF3#&4&-AcxELM||`$k-|m6ld6mSU!%qmr=c2xU$5`S1f+K?>^ih za>xDK@gelf!yFOEc(>|_({@@AGVV5_0u@=&*(CCsesY2C0gq<4=O9n6BpGoxPPiLCrJND50Q z;Eys!d0n_wAZV*ych^EDebp>F#9qoR{yNO>Vq8b${VJhHdFfg(?L;g5fU}nc{-nfi zQ0_-C*J^GGde))Z*oQZu3V$P`sM4ft!?wW$Yu;dcMPp#yE$*?4T;rO=?M;(M=*Wl8 z9bj0H%j@`qh9{bXvf_^;=4H2TZAo0*Y9<)m zs=njfYNL2N_{FB;{fZ}x9sWuWm!IBTeYRiwu&(pnJoHNA4*2T#q|Yg{W$j;9UZI{L z9$pWjwPwpUHABU&)%1h!Jq)d8dG#&SWOzdMi3=x#yh1-+=GE|C7Z)?|H03Z){%P4# zK)??pjXx)6#_-JNS{w}pZm3O|$tgrySe*T zQRD1R1#NW+&smfg6hG=dw^5bSTU~Pb-gxHApWkkx|8aM|`MyxxWBGjLKr%4u;_tS1 zP0Q4WXRp0#;1Q1KyHh+GlPmSm?d;t1|3Vt(9{SF|+U)!#`)Z)X<~VktPs~OuJ>|LZ zn;%~d+H|5dpQbw-_B>BwHe$Q)%ii6i{3f@x^PFXW8|&o zqscOx>*1f~|1@*H{FD_!xX-b$IigtwEhoet-&@GzuJ7FHyF%`N=Dy8TuX|ZEG$A`S zm+r?v%fL6gqnFv?@9ya(JlUaa3(PY)9paCZL#c3YJ4UOLXFESxEdm9;u$_xJ_c;ui zuo+m6JQLottBp+man_yP^T@EI7pb5w_=S`1)CWkaP%StY{}%n~W!14sbhGqelZ!S& zPP51IKV9Je;`~gxAv9B7{vPxDwH}o4F4b0E0A=Lc%T_ubtixHu&B#bF6t>Gq_g=t$ zO?!3I^GUYl>#r=|e)a+TPbeQ^F_>#cG<@x?q=H8A-39wzx~$Nx%!uVGsqq3km-7dT*E0RE^e$4Z-;tbuCzxbq4*j zF4A{4`6ZYwZku^>=jTTXu1XE_4Ml{U$@t9qRWq1x)Vlk8ab@I^Y7?X3)rq`Yl)2Tj z3_hK1FI97z58UZKFZ!Bol?q?DTo%80!8BE`AVIpIUfcp^9li9lqS1TJ7&2>{181+{ zpW>3O`}Eee{Gj6Xi#Nb(CVHCZkVbgv?nWA&PC0xA*F2Ust zl5%`?*w7e0CF}M`+p*nTy{=}?UzzdM;D@rQ2YX4fxUiw~f!jatW2aU<9FDtRx*R^P z8j|amwU``MRDZ_vxsh}{G#X5C46Sz9bhs2S{X%EDVn0*<9P1tH-s@-D#4gJR`%kFM z864KWDBDVPkNt1zA7?xHQLt6v=_+;Z|-7cO|vCfs(?iRk`Z(r0^44IAzq(e8WeAPSiEjlD6Sjk zR1NX`Yl#-cQ84ELut~`H3bhhogAP)-w@xnU4r>g@PAeD7Strm2{@o)qNOQ~)}-6R zbEoU1b=E883g7+DepR3BIDB?5>wEB5o- zRIA)e0OmZKC#5k2m%J;zggQRbq(KySDIBjC;QBGN9LjF;nb(VK30l4MEY@Jc>m}|^ zt$wcTy{w4WUm+jc2MiU%(=HhbibWq;SrQp8UGx>phAy9lW+;xE>K)bYYQEC^jAf&4IweS53OXSmSJfk@a6qkhtWUZ@? z&XW-6J89nuZ;F#QZ#$b9$kNURq+yMp!;;({%@nx7QPQV=N|re zRGV`tEBbZHi`b}DrA^kU?vKApR-@tPO7t6@-d~(r6>mGSQ1d1w2SED!LZ;6qqNB`gE- z6b90;`)Py$AC`gbN^QeDeqZ2AqKNEwjbHj)HhuN;$)_>KY!X~&oI!T<=bPj&VP&aP zn2U4nR6K_5r7+pH65&#LSV)45(lO{Ik)M1R1i$E^`XX4?6Ub&6WU>A0iDr8Ih2t^F zT)HBo%Y*5$6N@o(hbd~>Z_z~C^Vr|wK7J8tUd5J;`S!_q!?yR0A9O7U;}S`l9~50( zUSOZCN?!B?41@`y6WmM{2aJmt^dj`o9rmyM7*sC1=h<^0`hKhHW84x!9wMEMmHB7* zp#Uozk|kY>m2-I~+lH0b$@pV8M3^gY;r(rAZfoP!u}j*sm-K&=3_p{^Cp<+D z#dJFEF=}89u3z|JRcYY$Rb#r!P#CTBMad4YUR6pJ8Ory=d=4bSUp*1Ao)Bu89r$<`j9~hzV<~TH_ER?)dMXtNSDAWE}9%pODN8my1QGpeci{`_|4W_Xt-}3f4L>;TQcpw+rKY- z!qa{k&i*SN21Y)SR<)!61OOJlRJv?fD(Rgke)iuo^I;`XxGq%E=UbW2{{7mBmzRju zUqa&Duf$hfeOl?=uwwbN_Pn{&wd-Oric$d@zQ{a@$nd&A>T-03c&vL}tczG2{6fgK zV>EZg_1U_Apw&#PI{Ns$l`!vhA79g#-Z3enQ5~xh`@YnU(aRIH7wl?-jO%0IzSr66 zk~vqqUF+RTzq)mJr-rU=e6Qnk^m~(Af02LrI-7LF@0z3l-wVd82@M`Mbk=S}`BCEi ze3sJFQdlzieO!gAn9`eN-=cutH z78*Y|3i69L@GI3>Pim{bEeuQUOH{L$3D>C&pYV&Ft&eY$DcD$x3s1Uho~SqJpI7@e zr{O{QW9f>emBLzK4mLwwHJ>Uy$?_%N>ZdZ<{dFe)){WN^)p{XiOfr7_0r$Z&>wIfw zsvCFu%`Yc6)c?MhCoG%)_`$C|O!DK66#MBq^hU6`gu9na-uC6<+4bW63^~g#)B(sO zw_Avemp(-f$&?l!_4UkuK3UmPiAAeXD@+b8 zBM06|CMg11piOEJstcp2&snK;p^&|DEVw7y+r}eZjKBwe$KJchnQ&EgvMcbeNK^VweXcApP(oE=8}R2 z+x*b`2%4PyyvzwqgFqDx>ZTku4PC!7EV(-j#~xFA^{8wAgzA5&2VnoLY8f;FiOQg! z#>Sz>;|clSSn0>YmNE|-E8_!MZibH3u8k}$S1&bJsM6)}Ou&&>LnnBTg*l9sBW!BgTu*{dll z*FroMT+%cU-R6yZKRA0OEt|~YFbuNqIFe6;1uQUZDVb>?{K4a#o@zoU6>;!{1)anh z)U^wPF_g@Tilj@l+j_pfvm`N*z_icqM{aIBKV3K40A<-Ew|7u!3b{~56lj@&d zWs{^c3C}E#Mi?`3_+A_fulcDW-n=qmz5NV6h)(`*kXaX!3~nZ;Og>Ag!9li?^oDQ3 zV`%zk@4wTfVmSygyyjRf7jtp7|Fl|w-7XO*%Pg$#cCM*WJ_6edB6_!UZgml256rXF z%!*sgD%8yDTFjf&ES|SmbgEenv{=4Zv-;R#^+nBkwZ(cz&E{8R%(ta80x*fUpopL( zITos*yuspk%h8jjZL9usm~O%P?sg(U9_SXz1+QwU|0*Z^ubDy6-KgDAQq7<_^eSWVE@K+NCfIeF zEm51Po}ddqy5k8uG~GTOQ%BSa7ZnHkN2`ug_U{e|FtfZkk#!8V&Y_|7P(;b z>*`pakR=XH#-W0svi1P`44Glgpd+%C^mULk6o(?nbrSha?4Q z@`GS7WG3}&5RGs)b11;8;JPL@2&icW{XdM|S5Q-7!>-|#NbWlM+MNp8<_x=Aq+%x+$M>)vMnm6lx?n^W6 zmNYHOQwYz0!%yy^BfZ zJ}?6X=ApZ1VEJ)Me4s$WwL=3jtVI%`!?r82_qBl81>>O84rneHeKJnZ4-jaQ)Xb;N z)`_hggi!k-?!Nz!s&(jbv&ySXk7NGqZ3~twNSCtH5MigLRIHuy1 zkvc68mj&?8X4}!Bx}?rWijGWIK&e|7aJsv&mA1ZSrKp5!7c*jTt7dSTE=Zo*g{ri? zk?Nz%eFqlhWK?AH!{_tt_=`9)(7aSNe{=scQye;vQ<1jve%Cy3$X$JQDeDxQHM6XBjIFpAU&DOla5*{aNqqD3 z=(DrU^N(D!_;#vIPEMcr`=?!!yYbD%MHO64XSs?7nzz|2YDU&gR|KDl80aGWUIX*( zrI%vUZvDN}f}=^eMFnDM&gS-E&yuiN`v0*6mtyryamYfGM)AUF(B1@!A7}vt9w2o#S;T1DAvt z4-*A|V%k{`FHU_+_yj|6MB>kVB-4O!j5UDs(uTP~Sabm!&-j}^H1ZAsnv!;uV!N&z z?lGMPQw)H{5CrTK;(2bYOd!-p2`rn0_JEFu3rYNbIM%LqCttd0!Bg8C1F{7;)}~Kd zm=59NB=IK5zm@lKd@YUBnpo5sa72C}>F$E=I_N3Hdxv0}XLU#(dbik4y^lrBtAH#X z*;JO;+oLSXGw{dF=Xb5xWFG4$aufz-I{d=nS0&JexHTX<6-}@VA_uRETl~pY-$l-?k#p*Es zt;%>Yrdn?b3jP1;A#@UB;V=JRF1r_eM%9086fY>{=~5!(Mlwl0&C@-1&WK!5{68-H zq8OoB{T~ykzurZl66tE{{O(Q*d6+H`Buqf6KNY--Qq&E-i@%K6LXn{du234mCDg9= z-Y{2cD;xujpOA7aKV?H%d+lbE>G)02@`dZQgoAQuL&G~7W_AQbupbmn%iyD2v0XD)sAvwR+Pg-u(bUu+~GNZI4`pj zSdOd9^c>HATXpC% zUK#*ssHK$5C5zE`4#Qzw?`=`2i^VKXB@3*G918sGV2YAMq(E!C^Tb0oUwP>KR&T7v zOtIwJC>|d^>cKY8$m{cs&HIjuh2brFtzZpj-1@2cSrkB=^W~j5SbJyRon)2&xa=k* ziUZZF@iah+`&5i<=XX-s%b|e|We|=+?dppnW5bO!cR-IGuE!idY4{r!_VTg!k2$jV zpfmiQxaM8?9!^`PmmXJp{r>ien)Dg@;%rXRLkjsM!r6Ip=kJoj!WWcA*lbM)eNL3iX8inru3nvn7z-pazw_*SjagONK z0TUw3V%6CnUKT3{?9MRuQaOOi+ytW*SPlqK@FH^BOmZKv8K>q*$oZIMW+F-((<1q0N$U5ITy(G+Y7l_M3a0yBom5yN8+(Hc%HlgbM28 zG9)nNkldSGQF({ywby+xb`W#zE(nxfR|mMk)hFb}BuZFaGi0()5~jsLAu6)`uWJF| zPI-oT0t7-;o`K!0QF}Fm1B$R%=y*A`8Hls_&P??w6w84#52l5^B>~vbe09GMn8#e{ z!c6seX=@_0r#S#)xyypCGtNcGr#L+p!!tik_BX}QjQtEvQv3N84Bm&}(t9D?+#O6# zDgZQOh8m7_qpvbY2)!(?-(W0<>Qa&=hDm2#NW2?;q-3SFh|~3_b&#cbzUrhywxulcXvO(ALE)*^0)p(_*p1hh4aW$4#+5p+8BNe|&feZ;Efre2rcxE>Z?g$-%%)X5G>rnfSb`+kiGQQyg> zWlm3I8!!G03VGVur(e{^;>FO(0V;l_K%69?If&$Ex97v@dO4rHkQRj!4A5{4JLLFI zCG2QKJG%mp&h6u*^~08DGr6SUt*-`3cNkizg3HyIdZ@hzl1YV(68aqg-7Nz+;f#MOy%TQ#-904W3W z$GPt^P8#pRkHdKFW62!Q@f!&g=uqYr zAyxzc7R>DUCwWw(=)=?Lh4Gkh4%A-4Ajg~sEQM92gC{`>|I@>KQ>%Z1&-7)~UurBA z`Qepz;_^kpOL03fHY_ZGlIkT6uZB`O(mx91`@C@m_SyOdzo?P_(04(VviG;)l^^u! zS1&kX4gI|4tu2|no_=A&e{lN7BcGD62t|$5BRV*0riyKNQzdUd(g$~B$9+&Q2rs8Yjf*&=Y zq3Vc=Yv|km*@jCJFuWMm89ahU0TW{jrl(!Z?%MdR9u!4s%!B%3RO<(Yc1!(p}y zZ2eLhCIeLE!XHJVb(MBRemZsIC?T$g@YY>9!X1b3|(42)6lxd2`) zS;W#FJQ4#(l_LiDQ7r8YuabPI-05KyRoId(`t3bLgUu-x0?1|7UsFcnE_jOpa_%0S zTlvtiwESg&%8i7mphLJpgtgI6E$(o1G5lDIlrXyPI(7%Td&mDl9ACJ)qBsB}hqVF_ z7*KraC5dJ!eC<>z1LpwR@#i4qMQcQX4)?pY_F(DVkmFI2?}7sIWlzQou$m0O0Yo7doxujly;IEXkQjMpsgn`+%F&5r*eFuc zUl?6MMhd5wAa0{+%mHIJ=38W>4Cw5+T9Ofi#fSlE9gwLA)ZK{tP;*FX80v?xC*f3= zaoL|5PC2_s&t>5ux{i*euAte{gWoAf+nEC>a+rw&Sc<*vx{J=Gz*yx<&Ls7{Bxs}? zI=7t4fTZ!K5F8K&irpR&h3i%*s~8E(BcX6x^^r&h9yV5xQ~~*q zp-w`(h5{ft`fp1)*25=sXIQ zDFB&I0{yW7U=I5qOZ`sGr6plljvRFap3k(oNLGY%_w@CDF!l4jJdOU~T_6p{8F{t) zeAG-l&m(mfEJ*9dI~jQ$Ru6B0JPeB~X9f!3Vd)j)4`+Tq+{HLS&7oT1_kG+l01Uh~ zFP``jT#i++Q&uT0h~GSC>hlQlVkN><{GPC(-@W>abh+?+5fEkW^X4Y__VE+zJPGV0 z8kJE0xY;}*P`Sdr965&mBm%-g1hvl7j-Tb%NE*;~=sr>-e^-+caD~ZJF^Gc~LfyX` zgF&I*6d&+dIELthzSnb(><^}2s3$%0hcxLNe5nT|8yJ0x%r@vP>qB8@emZy^)qtXE zHh(ikZAk@Bm48tu>YeqK(UtMdgFV#MQ-JCY;J%%QwZUC|L{Ob0qpnq;`26Uz0IF+P z`A3Y`nQ?7@m(i{JRC)OKh%xUCd)Cy8pa;`Usc@<=5PgJ^ja77!QlJV0N|~2hXyrN0 z#6ajHVQ1y|!QWNLc80wFqUpYp03rb#0D?{T8EPpwosGgMGAiQ*6MGOSR+aI0AN}wr z)ji7lBRNipBe+h%8MTwC{%0^R$9Rb#;S@#fKI`#DSu&TxjSuw;esgXP%XS0X4#f#Z zjXOZa09X(R^^bTu9>zD1zEn+h&%9DMo!UGTbY1EQF{BC#MOkF97&w4W@TD_Yc{3@n zcbEChhX2DD^uI~p1*xur?@snU=sp}Pp4N_MO^pp(t zw+vRz%Pw>bR*zAI%O#JRfPwhClO;oQEkpD3LyN~l6z<_=_2E^g;q`>!&659h*>{eI zcezLQ)kl6hjT|J59G3jA%l_|p1mGF{UWame(SPd37}_#;8ahgUdvtVgl)9b4eRc>8 z2I+@}XoAPqr4Vs5{jA$ylGD&Ry79&1F)Ds~;mk2K<2Xfq9Ns>@G&uG=Xq@&GGC^%R zfpVW<7y`w3hE=2i)vPfQo{tMs6VHw(BwL4MoF{~bCd8k9G}0KpbX|gLVXQ9md=_)a-Q$GKHq0LKR}uvT$mr$n6IUqi$58-;{3_^I!c7JFy{=NTUb~;Jz1deEG}y- zt~xKSYb?%RUtBz)dbH60K8tyT=kxyd{D8*igW%6&|ApJnUQj{9keZ=rs3ryOLO~`{ zP^A>=HVW+`h5p~!Cvd0HPbYheNJfTjjs6J@mUC?&&+z154Z{=Z@l)r)wd1Accb}H` z7;MU8E>xhS>g|w>G}qivwXe^rvyDjiB{(C)Z=I!th9zyn^6t~m=|i7yUPp>#e-f=( zmKR6#JHjFKs*D5_hKXblbe&_lI|ULbvGn>BdQe+Zr2} zL&j~&5o?-bRE#iT^Ic?)Lf|eGMu1h$QUjE(aJg`37=wB!?4Km4845M1-@63T%~_Jv&cMQ-ei$mpR>+d%iD!s`W$B^~d=ew7qUWRNwzll0_brg5z!o z4mSXThuD(7x0TGT*MEGM80WCN&+ZDA)uXLle|hXvtyDn=#f9KpF%cRc|FXdgYh|m#Xho z3pq&pJ@;YgfcEJTLcTBDY@Uw)Yol56xW*@e($!n8;GcRZ!SxtY5B-B>90mYJ^7$Je z1UmrM%JI;-)60ZHiRI{Pa?t2g^~rZxN0-~cwqYhCH|VNZoj*o96@Yl);pa%4zIbj! zJiPhiANmG54w=6_Pd}M0o&tN9DOwOHQij!M)q#HVqcp)!F40UygQR*f2 zIw9AmuP6apjv)!G<>4)?vR9W1)}hL2JA(_wRjVkTM8w;e#~r!=;R^IOCWGmw7pu&9 z@AW4zVfq&0{eLPYifaQ;i1+5zqnUfFSmZ=kwm!v#FRu?4U34u$F;;YsNV0~{AImR& z8Rb>$OfU_vcAa~5>Rue=f8}?`UB=)x#SW_&Kv2s9`Jjv6Rf;B=L`~uM1aoP6;fE9e z38pJTm&GTznRM~dm1s=+TO#9BtN6N>XBs~Tr*;RtSAL0cefoWX{8?suJ}>v!s}Th+Q-DSz^1L$qh#S?J{Y6Ob z0n>yo%jp9aK1X>A1J>(%!aP3nMpRs;9bwu0`jjpM2rXkfzu4-2d;etz`^FDMm0CQ^ z4l=q{!LmNkSH!J?Cm^VrK6+uAZN(|PLar(=o*SrrlQQ>ak3yNiOld_#XGdzs>?UOnkd0- zY^+(!;X2xJ9f<5H^L@TcoS0hZWv0rn96&M)Ig|UQH2dtm!#Y0;U(-1sC#8q?rW~gX zpM-i(`gufn=kHm^Ub)-e`nFtWT4{P!KX!fg0*3`B5@yUtS|7g?%0gi@+trgOqJ}b- zpWZ_W9K9*W|B}MkLSDzT7ZNo;q_d(LF|=G#PH4}Sgk-;cz6`<2O91P5gb)0Jil*(S zoD=$sdi|S`6X(%ZK2}OzzkU{+|A_j1RyW-iYT56Hy-|-Cy0B3)oTo~q5jm#y!YJZ8 zx4fGQjJsVbf}4Hc0;8|Ufg{SnC2Y#inpOfZl(~Ewn%ZoXk~VY}UnS6UsB~~TV!?Kp z7$z^?g8+`Mm6_`U6;L6Hc-HeFJ^1!_kohu5i#qQi=i5#5S^D+;%Px`oXbtB41Ra9Q z^hV^-ch`63l?>P21mNmuh)8Y?mmRn+ylaneP!FfIMLoeB`ROS-PB30EB%NN(-nSow zD|Mu0N(ue(;|mgc^Xv!`YQ7Uc|IaB#Dssr&Svv_0LEzEq6bLiazMReq*~uUh;K1T& zI|R2oH;{ZOeKl^G=2zMsHhuX-rI!Mgp#|OlE;0)HefhM?X{Y(OH6uefBMqqR?j~99 zWw^Y&OFP@gbvkrg@5)O-)RG^QTjTI;C{}?Q2OF}gK|`)5Dx;S zXolezx?2l3$d;#K-rggIgi;y&;rQ^=Xdoq(1fWW=cvTPdIVjlYWEL|GIy_4SZ(czmi}CYg1S*)Zg8 z@oOh`8Jdn9RgfR;`2|jGjX_*gUzKne(-VL%A$k2OnJp>pOzIY-ON0EN<{7L9$7BfZ zQqYeAI>&l2NM(zEpnIS}xRm&IS z0T!#Fw-kk0ThHAM8UCpZJ){G=#qlD2SjKC$SW&&qut4HgH38Y)h7rB_*9ybJ{fUc|m42ziypSHxY=r z02Jz$)B&f^BGu{Y5R4-7e*>(@#to!9Y91bf)1Y8M9JY2G)7@hb`=EMBKuggtw~yb6oeXu%nm126X#(-FXewn>Q!|$MO4`#Y$ybA{!X*>%gjC+*ZxX4H?lYniUvR~v2<}a5(M<4$UTc8Aa9Zw zrGxOWr@K%R4HFeAy&Qp)O9J+RWT=kYxw}nxDs>W(vJ9a4C|I>QWY)uxYq8q5peH3D8)_*VG zWIZS7aKJO5IF-3%T}4awQZikX`ZF5dRMay%W_jw07mn3^LPlR-Kl(|$bg*Qe(`+z) z>&N3N9$)9)Z~fgNCXLs|zFmI!$9rKh`puPTWu2T=^1ax|^2w7_1<~(|zp|s-erq%~ zLs|swG$RZ++kDf1M=f66IqXqe+&Z6;z>9dU-|=H`pQkfHFi78&udeU7w*34cahmw!dQKk~2tbzEKOgoQB<|mPpRj)6^U+9J;?Jxye5hUCL33}S ze`wjs+~*TYrfbXkk1?A4{4&-xgByP)-zOft`F!#{?Z)xKjl`pepNWaiv7ElO{SyWX zdz4d+&tKF3y%0azQ$O!W(!Gg>4pyB`sB6Txepkc7)XAQe!v8$q4FO z8g%nG`UJAhA1w7T`FNs2TcCqmv4fjdi`BY=+N*=Qq=hK~&9Pd^qTay@*W`t3@*THh z>Tt|0xWX^k(?_?kOb*)TgS5{HJyQJEq4cpv+4|k17usS)*oz;vRlNjhrL?)Zm3gYQ zRl2mX>g3}UZJn3$awfX+EM&=JolCS`G?^VbB^^3-9dcb=ytH~FpS1aDi%gG|jDG40 zee3kS*=Z5kBK=aw&|22Ur2BG-uDzGKzK|Yn6=kKarzEATY|^2Tpu^y#>m2#6GG5nX zRoAiWysnd;SBtLJV3+T0q#G^9Jy+W=Q`f0P-@8kP`EUFCeZ7N=X;#{LnlJRC;k{R^ zy8)Mv{yU}rI?Wp0U?NsS-u z3{me3HR(H*cQUki*`r_AON`MLlj=+O+2fdCaBZ+pA;_>KLO0`Et9wbG?P~ffSa+7L zQBh`hwiGJ3r6MX*|GJ`4qLls(FT>(*YKlUAYLOrEX!{FRI}2Hivl9AUOwjkgoh!}M zEz9h=GuVH3Ud^TDLvDIs6}Qp*fZnHYY{{7SOm1I`||59vHBY)XZAlc`EV|ria~{_x(g^! z(nVAVYJHHk{UnLv_bo+a(jbD1@_Py+zt5$vfvNF^7CKOakbA!`_-jR<<_pBvI z84e-BE^!hEN)v|q@AO=+Gr8?_De6O-Cu!tJ9qGOWsU%4zM5L>6KoSW=VgVcl;5q#I zc|Za;)|}T55$HCG3^w--9Yx(6ML!s&el<#S-`tTrO1Cyj|7(=~@6J4Mmg)MJ381I8~rI z=1>eJN%RC3(U&IvU|eD-Euwy0YI0n9ZCvJ;rHn?ZEbD~4@PvYrl`P%Fd7Ft-CGUyz z-N<0S36*;j7axo(KA2GJwo-UCq5jHpt^g{{jCbV#>|#*Hp#V)dL@X9{W(Dsh3->4* z_U4+@sP`OXUb?haW=z7{J0!7)p^VA(@qPF*9Rva;lfw*1?S5QQ&xkM_&Ti;;%)NA{ zdcdfA;N8c&h7xC?Y65z6geQhb+=QX~AT;1*NE3mniNH7tTne?eBwGK@{kU0eol;_2 z`*Psy9~+&So5WDWmC$rsIXK|oXd;(voNiJD|FD+%aXn#hqweExlm08M`hHn9oW(Yr zw@e*dr;2jTURq7_t6!cD8Y+v_3GB8ep4g>X5BikYrbO9YNwG`5XLq_@ZO1a->d0L9 zI&vmmZ-l5ckks9m_+aqn!h5>7vMW~vOu6kHOfNUi+g)GlcQ%=6ta{P=h0Rt^P|0H` zEy{s(&-C_F-Mjauf_S=0hH9>kIT+lWx`c2{WSvV?bi8qYPAcFyb{nWT!G9v%!B^^(r&8OE7m|u6diO12U=s2Et08+SQc`w&vz>}^$6s4I#1^>)HKr0-Qu1*ot2&=OB+vm zedtbcQuz5PgJ-s=+iuz+ImR{g2xv=VFwNu1tI89sPA zH;PzvFK($Hbp9euo|49nY|j_oH``E>ooAidiE=EXb2xD}UTUSxtevOJcA?K(=u)x= zqs>n5InidT0f}x5Q&;}}s`=%#gfMew)cpJ>g;Ln@`AgOuxb8Y^jx8`!#s{0>PkFBRme2L5aA?~koJx{alb-xO zOJDU?F4`L5d_1)i-4)EdzVduFK3FNbvJ#xIs@}7*xaN7&)YFQ7ErV9u9s9g0V^w}0xSy^nK%e!E-9@|Axp;R$R0>#KiXt%o0Y9U{E-{}~&w`ASlI_>`_* zPF%M++aoBCc;&4{wXI*%cMD#0kL6ud6QKmVY_4W`+N}Ge>ieAvy|xQ=@gPKR_)Km5 z)APMy>wF8j9Np#`&g&n+OUc-AkL%f#bn#EIUHqK2nKZmM`@>Jra+&mOLsrN?zjP}g z)&1)ef9d8eE;j%C#Lcx7A6tEYxo3WO`i(r>Eo=RNM0&r++3r=!Ten=+sYNz}T)srm z_tk2yJ?0HG$_pq^_Pem-uWY<=H9Fv_OkjfM*AwT!_|ngpdIH33zqtRSycJn)&aRYt z>DdtCcVRuy`q|W@Z2wm~n=SvgOc%c>4Ex3`Zggk+^qPJ7Hss&Zz25dZ=m9cFGT`ft z#h^LqZStaj$G9@r=w{sE$OH#koO!@V%`xzL+7(v4M&Gb`4KLWiN@y-j@gBV*! zq<^L6_66hMx#6Hjv%u1G$<%#t(1A)odEom4#QKWJ_f?m{HRX`j9&dwjKu;`v_5sq~ zX|aRin44$@G^aU0Mc$)ULHJVkcz^HlQSD>c_xVNl1!VW_0n1s&yPTO#nNfql8G_!orH8@4o<52 zWV2EHWt9|3H$vnrK9vz``h?PKXAc-t(nQM@)5_0M4&P_= zcV>A*Eq(`By_W$Ea^tZ?WGG%Rw48o)M6Cco8A6id(l3I_7E=xZUCr%K`M0TDUB`*yrs ze+R|i2ng)eqPfa=Ic>Fx{?`ZIUm-cK-YKu2USmHD%>V5~br{!st%v?=q}`$O?`v0f zzTig=lgkc?`G>c)t_3kr@)x6{4US~u8W`SQiBOMCdmkG4Ju3AyDnxem*X^T)s@NaM zsGRSIH>P86zlnVp81gax9DN}uI{ur6@2d9mLo@c>Skch>ok-Tsxq#)LVe8lO{v8t9 z4(ViLE4AWl-Z7K5;wF>~-b7t#O8NU%3)TGQ?+EtOyXklW>2Isur?xj5VPV{T+VW{? zHH8M-_4%&%%G~L%9(`K;Q*-stTW5!gkv|04IFfAqi`3uom*YxeUp#cB`(S__U_Yqx zK9=A*{x;wiv5%St53gnKAO-0|g3<#*p(rYOuNI!uG2V!+l4}nWA`E#D8v% zCQIB_usOU-8LzQqm@0`2_q2YZUZy(u_?4(dlKy*RI>}MV*(#@zniI!Y!Q(gmmWrI7 zgvu=3^Fe11(bzt6t&ZM9<{iD3(>bk6cbG%8G_5TXuJh?co5ZeD2Gkh>volHcJ`YPP zQe`g2g>OA6v(gcvE>hAP&Nt{x)@axZ_{4fS=i^Y=_rTA5&NQ;(#R}WR_NbLad-agM z#gU5X(w)0azp{GyL`Cl}xc&I@xm`_HqcmaX2V29FYfaa~eiH_Q)9e=8FyH@XOnjvp zY16V%zQ@LQ<@e-<^Nk~j3K&ZBN3=8v)|$pafDTf9BJ4}omM78a_fc-}QOmizv%2&- zrXob_OCz})58QnOjK$piM84!#rpU;6EoRB;b5vytj?WZ&AfvAdT$k$D^i1PVH1u#& z=Df&wheP5>@Gh6?IsV*4qgmeUQ=7^d?=%M}syfqo{nvvy_b(g^caBe*9wY^fcc0B% zN{!ZwLFFyce4Sxip#p=03@`^-R7kn;S6y5zJo&Z%W~th1`$rK9P_&tJPEG1YOx!a+ z|B}L+s8z+bm&}_F@2neb)rNYAZQ&31RCLSEO@( zT5`Xm$Wuq#-B7Ic?H6eRhCxvuYtIiW zZR{8A0qz5+jIz1?2rnOE(yRLxxqmF|8PxUWO@ueSJ)Fx2mObr^BdE1^(A@d?-5?Zth#9y0VhAt?3 z(v-cP3L6M}r+LPGcm8D&#A^(4WXb4xM8A$G)lfT*eEOY9aCC-^&(wWxOs!eRk!?^GW8KPjs!uhWyv+6sIfV7WPNXZ<#7<#eRSgs5qTGNTS@46g($X8hYj+ z9pWZtg=$+GIsW6N)z7*j_lNsJU$qmlV;DJV+%wSa7WP6iAs#&=RBHa&>*Q%PWsrXO*+6Eg%%~=!Q&^7? z7KTUR?&!*mGGC&&;9;lK@I4ys%W`38Kux~(ZmWcMwWQ(u8RWD2duBjH@h6M=v1GJm zJ-QGiGkp^U8GjNm8TDlBV*n1BS!RXC=+VqwBXL>d;WAPL@jU*{bK~`?$}Rl#5w)G? z9R1Ri6H*wG#Jc#I8q(F^m5g_5yM(9e(^Ow}OBaZBi*t@;XjKcay{Od{>X+kaCRND3 z+|1^ARFUap4g1-+n?$guFv7>WpvcB#Q5HBOh8CQnO;@;1m*f6Gf{)BwljGH=1N;F~ ztLB(c^r&i9RQV#dqye~$>Vij#8S<)=->UC7;O~3Q_5ZV1K_=F5Zi4A86et6|n>(`# zNW`|tAx;TW5M&Wb2T^|(sXc6GiftmZE5|;sLnsJ1a`}j*Ao>zoZ@EA%sFXIfsrkyw z(VT^yoNywYcr}J9mj%xk5=!J6<>%{A=a4U)WzE@3@m}Tf-dp@dUx>yAoNO)HwNW+i z1_vgTCvOaNS-m1)%{2}`-qgI&d-=hU6=A?+X5?^>9KSz&sg0R_w@b9;8k1~!N^!B= zpNg_1N8t(%=h`_=iDpF43j#g2;TL_!F(v1Z7tU>O=%3D7{J0*85x6TZn&mJU)l5g& z`S|FPQK2AlFv|_Aw=SwwW03vFq7Ycynn-VG&0kEbwvvBjYC)}f51I3T_d4eg>W_7# z+3BQRaFkeOHudy<`d^+0J3JPt|$wspDI{KPQz-j*2%%|$TfriS2Bz$72|MTmqr0Mz_-e!Y( zVLR!H6Ld^5m&=(i@zFwzZ>wAO<0lqd^G&K^=GSW;*U=*w>RIs|M%

    AWEK8#^v0%Oxq;JBomQd zY`MZ@+dCwekM&sh+|-Y08CFVLkni`UxWK-)y2dr`bIp+~wHRl#^_{c^rR7CU>Ws6?v;nzVMLW^M061_@0tMPZ?Pw#pLWqy9( z_Z!JEaH7=HUHtGOct3cAs~lmo6G1s)ht?GJl$QQzSE3JmdB`;;l_UT7!Q(G3FN%gm z`Bb%ci>9yL;;LBH&whJFrqK30&(eE+)IQ3iuIgRvs=Jb!TdZ?fX8hTSTsZv#8Fv6_ zySO5g|6}UD*$=IJ2I7xV)=8Y%-u24X#sFEBPx1c(P`0YOj(jbB`E3V}UFN@jEgcv- z-QX23m0Z{`)VolyXDSL|Sy-4DJFb6x_c^-;<~+l{-dkGxrF<{HeqTs1a-G|p68~qK%@@DlJAb^tq3L|DXp5EVpL^;r z3)I2b{lOFNZ)=>GwL&bW^Zf$fuj`YLJVR)R%LjSPAEP2Gr4rS;&)ZurQG1_vf+-ss z&K=@#_#>VDlC$st+s2m35*_>ZU#`nhrPGf}{*c|yGF<4kvM1f22csx~lZ(I~eMtXl z^1qAa=o%jCjxy@R``U&JJ!?+1X443LBc#s&T`30qQa&2St)W-U(CEq$UJOR_Fosi( zTl2KA=8pH5P}++|lWupe^Rv|OQ`D`yQDmjeBy0OlzIlkyxh}!J_6u~$LS60r-%N|e zDa|DFmIduJLiEhsI9ve{+6CRQCUX=L(Dt3$Qtl>-6(Vy2^fI51 zS}WGZiq7#OXua+N>QDrWE@vMeyQ%{>Ap#`;PXbhsyVLWeym?_sXztXFg}y>&j>oS$ z=Y%JP3QoipbO0|6S!zi@I++iJg*V}8<^hB~RGS+@UkA~9-LB9C)Ay;?4-qnmt~N*% zGEDU{{6aL$t2QbXGOk%Qd@OY7b@ipj>hrptmxhH*r@Zvn6FmLIt62)lk+ljqiPMb@~{uRHV$yYq^8 z%sp^#dmvjbeEua&d1h@vtV=$U=Y{ZszKLl?E(Vr&c-TfZm$ zY(+J@-!BsXfa-eT{kZ1!mLk*EeU3*P81Wzp@sc|MTStERjpAj^;;E(LX#Id%vw&zO ziKk(Yf}JuS=WRY?3wTbHkfHx_!^4@wS}>3}y0EFYYDQF{7L!E~Z@I?vM?<=|O?;F-kykH?+r zHrqzYbyGgU?{|7$J>%#n=JjWb4{+8EFnz(Mf2AUJUuv02(#Y>zeCYS_X@GT5flJ++ zou@$|Qc#I4#biw9xYWI@ZD1mqaJ?L!fEz^4K7FP*ATa};Su=Ga(R>J-m|~G72Ty2)A>b4|2O=q^Za&j zip*cupw)xmd%HR^in1Q+vJc01%8ch5mt>-|AAe@jy%2iUeXw?y_`Qnld6cqb-j|($ zn-r-I*}a>xi}GUAPit2_%In6LPQF~-nXTCCm%Tsy^=MA^rEM}_kWH#UvJyzV&#Eh$ z06k$!#+a1@rx=p?^>=aR&~N2VIP>;++j?v!Hf8vUq&1d=(nUR=LFLOm zFAb&coTK){olW3qeK%;Q>q*~E`SeJ;1AFx}3~*MU!4e%tJ8_k9dYA6~w!YY2Ge4aA zLIYMk41B-Ka@UfT%81_2((f!O5Cn(Dc*oZ^oDG{`QYdaoIF;O;q>pyHOXT%`Jrzkk#c2%1)9~&?e&q`qG7&lLfdML~kgFr8SD> zD2V^(hpr&;uu00qTOupcpPxsml@1u8hU2J|jX4K%7)9pwbDCjEs{1 zq6a5ZWhS2^<8dWWtx&**{Z$cTGTS^>2gEU#!$noFvM92^xi!smzb>I5JbOtrb?sK% zFzKKU)0LN~&vk9eU6KG^2BpiSxPe(BP! zSPvXtNtgW@P!8}YCi6!E#xaD@gKDT$<=<8~-0dY$f;+p>;QBYp8K3N&Ybzo~#`?8i zW$O~`0#K`XUqShh<4*3M4cKpFHcS_fAO3vu>mg2Ex&i`r9tI(K=%+;u*}TEplLZu$ zMZ^GODI7CxGSVx2#RaYm;3ZJWe3|&*-%24@o_e}(Gf8<{&RrJnvXFYJj2k5iy!=0u z-T6P1fBZlCYc^)A*VuPsU$XDA%?L@9eaXJd77{9IW~?E5*+U4CkZhqDWJzQT$)25r z60LLQ{rQ~lxt(9m59eRFZgaclb-kX?$Ky^$xQWpea7MWrFdm#Bi^zI?1UiN|W^5=9 z+XEl`vC|%WE|3_T4tyUZaTj?)+(II0h3u&N9x4VB7yvGUyG0N8Ydz7^fC2Mq002c! zoy2_J@pFGB?e@gGU;PX~0YudZH2iSBtxLpL_3dfIj7WW%KfOZBjX)comkTatiWT+b zPoxLb3~ox8R)XdP>=+c_`sRDP6`K-)+QXfbB+`_|@f3@|{D^P5;V|tqpaH^g5S1Po z7tHv}Llv&~ryN*=Aw@;C*&=XwGJTS2nO2<~^;T6N7K%;R;Cdl$O~Ry>Tw;#nE5fc$ zL9zv7<=UAG)eD@4UsB-)v>f)zXs~;n~0%iQ^AUZyxHj z6j4h5EB)oIt0Oo>2AL_9#C3tH-x@Gs30!;-80oUQ?|!5XIras~mJZ9CioI+^x*!5! z3BPH{;rQ3Pxpghd6*h`~j_*1A~+h5NO@LiEoWkgC3&qjyrLO(mO9 z3`A8(910MG=}&n8D~Tj2VsK1s0L#0Hrb*eh>vAIIWNt2HS;-@@Bm!Fz`St7H!7-eA z-wAAk5N)J^r0AMX8|3{rZHc0(sG5AaR2;iso6vH*<4GrP$o2XzE@|yZNjC%jWev4D zGFx4TK5j=ODb2DjJcK2`LRT2uBvP9xz4B7u1~LZ<_Egw-|H;QbS*6D zEN*r!e$`nz=~|-bEYo%`GwZH!cCQHPu1a*T%Ikhs@BXZ(yC&F2J(BQ%2IrNpule5Z z-cUy{MUiY5@SE4Vx6*Ylc{TB(uxHo+?hM`C*6s^@zo@7vhj!NPO!pV7J}&JE9Y5^e zQukL%H|{$TnnA8A(LE54uYb$`6Gs9f8kFC;M%1K+&`&r*37{s7_y7p?=$Zln zkQ4xcW}3zwWVmr(eK9^# zLQUw)qU3W(t^%$oW06T#9GuPn&(D*CIKcTFy1>6d#C1AT7p^aCe*s@ZG#!d&rv>_q zUj|6NE$cOx8hNfHm5JN7;ax;Ca+lg$xo(^F)oOd)yjJB=Eu2Zsr+~ zlse&W9%#5TstjW9AX5454N27Z@syAEuI-v2gea+$M^eZFFi#vVp)(TY@etr4mw`}* zg0VWZJL*q47NA{sh*AJc4V!?sipBmEuEF&COBczqO)Md2Vg@`poN~;~8jb^qS7%xn zyI-ALI}u~Fo4*_*M(uK01;1bLAB}+*hx1twNr1b7nz_7L^OJF}2lvmL)6X-;jbMC` zV@dHaZtpTJXsR$t{`r^Ccer6>SOQO6wAz?X&J?jH7vnLi z&-z9fD-lpf9>OZn0fX6y;-dlXtD-&Y*!l(ulBlWBLo^y0?E#H}-mr`VoEWUH+$m`g z0!033tfdK?@;o-fRUk{vbW}*rLl%3ngKIT#iqoq5d_t!fSXdu(Ozn1mK3#D!V?S z{{t;fLDde_%R;*K3(hb#zioz^XBqK41XWA|-trq}NQL2X1GnfMROfMDP&t>yBT~l` z#7di_@tP;IZ0N)?p(bl#%ssm?G*m%oOo$zX_q>8S#6JMMn-q|qP_xoq>{Sh{ITSL( zhQq00R5KhOc!}d}pj=@P9G}-?b0;^x%sIg7&*y=NksC53otKOixJl@jzJxj$BY73; zjtmLcPhp^777A-o83de*vMLR04GK7SmEL(3g5y3_$zXuWD3t(gNUs4X%v)jT4(yG7 z?}U4fOdLRHQ!pQblMO-PSkLJOpq0I%16RzRGvS~(W>E}iAs(yXwChyN5y)_lm)^I) z@BLrv82hmB6m3~^xB@F1&3EYR*l-=RnnXKiZts@SOcSF(a)7V*$6`|tjKC;b_G)^l z8Uy??LfGkJDe#n3fW;_a2$BQL8W<${mngu&B?>|{X_#pgGN8sQF0@kgFuDZrqE{M5 zt}O?P{fq<{}5;+hk6{ zlQF?mv0_oemWd)QmjL2NE3V!UlvyAIf;Q%mg_q)2P;L>3pMBhH>KUfRV!jq3`PUXR zVs%P=L8f>7;`A91LD9!7Hj*UhlaG&~<{0J*>>H8#28tO$0c&&d6fR8)0T65^n9wpT zzv&^8t6@Ulqzn&z6q0n_UPZ>5D@mD2xLAfwl-5Bx2M)T?^cwdt6p}dsmIG!1Hq8Av z5YP2TJ;OU33+OfUNlrB2A#4+PD1GR^KKVS29+U77<2(bA5BYY=yvuXX0TBX<@IOb^z&R zFUVePkh)|4-HoVA@W|~wH$zJIVMB@0cM0Q^xz-%ApN&Re-G4c zRCrGH5m}mcvH*&WH8urlpI*fzr5@pWSay@gRE0&t&D8Fm0U{-rfpTg$xJg68;Aw&; zd}Y8pykbo$vlKJ&)4P4+LB_dxJS>+R*_l~*g`i-FpRmIF(z0*@^6c&KP|4qLe6nZ~ zsi2YKuUu>*gI`zbGRjlX;CAVRDLI9duky8}(R|*Xj=^%v1;5A$zar7_d`8@-8%%Or6 z;yMt8U`+a%pha=5j3$lqQtGlvjqH|1n#X}A(3Qj;VK7d^+Nn~89e8nuob$=;w$@T% zNgZL%l_;|u3&osZ*~~YI8Y;~+W!x{gkB}K0arK9~>iOGW9#N`=UxSJUMWs*A)LcG1*N-t-y&yZWrGeCa))NdARy=VuAdFt;QdTVyiTxCW+vQ09bP;*?|5`_ zTiODgWTOYbaK!k9t;xG^MGjU!rI+LMCH66J0^Y9bYHqmQp_o4k=fCIg};e}mT}(Y)TL33dM0*FLCE*sChDpiJ5NLE zVv}WQ7PX9k4;p&&X64P7<$M;BI#yi#2m(NhXJl&(V#PR7Gp^JYgDnwIN-?3k3iI7o zvW1f+z!)6B0*o0xNsW*T57Wr!!QNIoXsI=gJ6jvqH9S|$c?sa^78sut11*h#l_mXS zF@D?cEzOw##VM~3fUN2u%YkF3PXPO%}<&5R_c}W zGP@kB?KG#0NvKna7!WZALPTIE4e9>b=}e-UG>UNzTdKyhn1Kg6&=n@fN$EX%(3KOd zsSaA^1~QJ@L-C2!nmyX{AO?})J*adLaz)rH14`1Tp}O@d;MZQ;ur2CFaU%48^m^^s z7^+^+Re`+Im`N=}NY9R7MrXkYNuLIEnQjD+DrltJ1GHkm^N?#v@uFrmph~OcCNcY7 zP8!nvJjaC#ZkjpN38i6!FnB`Z3;JxKiO10#=H!cWos3;5P6UOqKwknl1TBP-wVX5` zz{YQS4iUViQc;H*xlQ~U=1N+)dvglegjhy(1a9oYeT1UCOdBYO1->2mK+%kM)m*Qr z<*iDByl;@D#327hdl-Z^79yQ46%T_b80+^0THv`=N z1L-j-nSMz=`dLu-tPCVnQ5Bi{EonNGH+GrhL7ZJmAE=Ux0x%GpQVG^f!B3QXSu`tj z%I*K<)XlK~{eetH-U9^Hp$F+QLts4ki_;2%av`+&7*r$%u4#1xl>~ke12TcifGez2 zihkHePN9@z#|Qk+p;st}F01~z0RF`5|L4#*=ui_-lN)L^8o)CziQ1p{T?wh;K)^G-Toz$$-XXVu#Dn^c@D3g#7kw=>TX3nt}Czap` zs(TM6?APEMxb7F<)LuswtAw<6`+(^Hw5CzZ#u3Z`Zc&-}UUD6*Kr3JjuYk9o{DypN z3we0Y)K3J|#s+TrgC6EB(6Mw{oLk~k7Ikgi=D8>Y-0nco~mYjmcJ z%F6qygH%@D_$Fv!15#P}d|$d!aqvQ^glvH4_aB@iyeyZ)6zJTU{uh+j=ny!euyA|p zgT~|6r%RDzWF$%noNGW{%b*=1vh}qH)D1EhVmYabd|h6O{81qUrE6S+`d>d@hG?&a zMi*dc!^U!UAwe*XB$`lJl#+-}u8hVl@c*#!0VWom=NsicsAjx*!i)Tfh%w}erkQB~ zcr)AY-T>;f5XBwM?5)&|5@I4Iu+c_?gi^AW(fNzcf3 zH1hXZSqmT9m^QVG{l-v2dc9H^B9pl=gg3hMHJy8paVmJ3*z>>eEtkrfxQt1pm=xxt00KTkSd|zBE2mGE(>1`fc>Y!8_{AO7O|tEhYFm~ zN#Css=g}5_h8}Cbt#Ep~ojLTx>1}-}lHD9QTlAJ4{kB1SxY=pAz|!QUF;8=24^nQ|JLjvkr)|DVv`uA}{c;`tqb zw!g{3&AjB;xR)SU&b)xiI;yS zs3Co>XX8xnlY;0ehq6iGuF2ZoDfN{pVcZ8g+*EVm)O_j`pg+k+_`v7>K_Bwr<@_Yw z;p9WpX^hY`vh2f)cOO3Oeb|Rg^R7(ukf*Wk)6J>VsIqC`@r(drh6XYtCp+6`I4fgV2r6ELFvCYl6U9e!h0bvFBYM$j-wr7St1}-Ow9pVe-_6h5ODSbm%$)DxXPf(reiig~qIhg7W>OEgkTCLbJ?QPc z^Ta0%qms}fd*dP#dP()~yv3KvUtiFFbU?c&*M&kgUj#ytm(V>|hrc;fbKOfT&!!mB z%M6Ok`3vBf?AvXf4-(ESo+O`Nrr^izWzG?h(!jW+v+~z$@nQ6$cGt@5ARaC`z_X#^ zrzt{AfR*n4105G7y+zZtT`mbR*I@wxul3Z;0OLw6dJ_W88#v-;s@-o$n5 zvUQ~5nt=fGA%0DkiOn?l)4!N$C4qHbi_hx1t1$O7cm-?{@a6?95 z`r^M;-^H1$|5ilDH-hDW5K8bIcJ%CZm(54O!-bH)6MLH))}o%O`D zEv;Y{f5zGSmv%Dh*Q@_AAC@xLEbi3*+o5EPH|Xv*yX?N~W@ve|+flze+OXUGZ}*w* z1W9+VFKxH)(N4nt#@R=^l4(0>`zuzA(&dX=H16Zg^~{?gd(CpYbBkYE_rEMN?RE+5 zuchtuxa@B&e(t}tKNO6H;75mpcSlCoC+im{?tE3218&LzpF&tq&Co?@pm+T|LHA=U z)6}CybQ7@1j2?grF_FbtA9aGjay5PCmXz!!&+BbI!8Lt>Z92%tzej7je>Zbo4yt1g z0*ViCp|THEOV|iu^c1vh!o40^i$gZTA-C(!Y4E1~;yQ*h)2ndg`HvN*x5&`AQc}15 zKJ6g>(z;@(Y~w>cT1Dwdz@Z>t7)ri^aBrp!&A!&nt)T~6j=hJLeG?-y+nYn!@znA7 z#DD@q$qm{8NUvtVSxJy<_y;#fH*+4Xcrk5VO4|S~ZHbKU(~}Rb{somSIT&(yp^dQe zZ*cAd?ysygcMl-ZZyv{}gEBy{Gk3MC3A;l{+VHSrkpMdpxEJ_$&-{l91dB1~M<4w$8z*g1|G4w2poA_(r zi6!3wA?z}ih+q^j$TMH*A^a(l{d1DOLY21=axd~i8FEs=GXkt`7qMtaF#{u?;=u)0 zh&Bxq&z9SA0`WCnm;=&%`3V6CuVKl!T*}9Vs)^dpv&JVFLV2AvqUZrx!W_`dGW%qU zEO1-WM5{`rMzzd?)SA z)_rUq)O?7|xF=9-5UP7T<;_|FDAA?=GHkIwiwGB+?WI! zRm=@AMx{!|(of+Hbh?n)*|(+j;uF4HG1zlSbuIh)hnTJ_dr5ENpt0yT9c; zwa=6PNv#oDMn(K|h<(%ovo~-*Q$PxYQY+g%ga%0jrnawGNY(*^6h9(qg@G^?wbIOp z7+eMk50|sfJm)&=TNu^NW^CBv^(X86S)GEUex3CW#WFrho$>qj=n7+s@Oe0xKGqVb zG{}?eH||sRzPqy*X6JH9Vj`q%8DOlHAf;JW@SdJ{Z{2%tD(Vuy2Kscqn9^V7XS~sj zab!GFwrhkM`kA}3_q>!fV0{oe;~vvxeg4jqJU6J+DS8Y36OJXrgD!)}LLp3p+x<8r zFUdy@KC-pbPAUAh4#Zo|59OjzENU*Xvu3;Yw@=J!9qwoebJ~X6Ih`!MkSv&4j>GFz zyTl%7|E^E+5wlt)_2ypEtC9yRL&KACyWwRT#`c?x~)q;9Y{c9s1PSf7r{E zAL{>lU;4tu-Y=2D_)4U5+lxo&(j_-?se~!(ayM=c#8(lRn&X&ag}JL=YjUvAz9ziG zA_JOe-*T4)b^Fu?RASx-tTuA0C;8oys!|TR-~H|7mspP>Armv?+gMDs)#r1V(3%|2 zQj8x+Vvh}Oz$jIu)nGAvbRFg5M7Dv>LpM!3lcS1^%fsK~{PZIRhb67Dp?b1-qp=u^HXQDIs~`k#fni!UVEEg54pNlq z!hbQBC$zdj&FJfWXwv8Ijkb)lJxL&+1`-1wqvPZgRfMke?7#t9LYrGUnZE3fk6H$A zAA_Xe*(52NCQ%8did2Vh70+q%&@@lQ5@RT{H#k;t(Hps9&aO5^WcyI9p#QWd zF15{1g#?QEe!>h2t3^*!RtD({zE+BjSg0 zj~k!W;(t|9Bjy||hHmoOIWzYva-L^j-=Q>>o>d`VvI&f8PppVIO>Zp-4T#>^xg@k} zR|1{Rc_6#{D6GKYQrN>rwvPdRE5E8nTW$#Hmw$9xkNVi&5b@%r;ihkBpRGm5aY3k= zr2qEQEARX{2=y_t{c*f?mB|q|GlO!kuGh>jD7ChZ{uK-_uLUbN!i8MClWs~u=evbZ zD(7v)uC1?r+H5*`JgM{OmX((?H0wvr96~C3S8AzcOuh4mq0}A3psT;fj9vD~GyLcH z<;!q+1dD}=Dh3YES5eC_QM9_cOQNd)o-mD z9@dH{xQtEwXls2CkQ$@<`NJI7b&XL)K$TK=X0>HzK(5~>?2EAF*Xh%~3)6}-T<l(={y&uY*puZ z3B9?lOpYI6_kuhe1+_+oT$Yo0_X6}|etNhI98|xt^lvKW9;ul=uJ;|@7CZxQZA^=Z ztO{E3cjPVKmP6L6zYBuC(i%ME_}2N%=_|$4x8Qweu=MLUBei!wBbT&xTFZu=_N@j2 z#%Wz6H|KQ96Xab|0VSA{!=Q| zi`lVS;{Gsj=STWi@Jr;mTnFDCyx zQNQ!+@HOSGQwinIW;f-N-d|SiF?H0{rw8qPosQ~0xv0f)L9C?~J<_W=8vEjr=h;sp zD)aPO3nG<+^xa3SxMkjMCthuifR=|x+PF!q#b?qhk**ZQuF339+BzI*k|((gTmFJ% z=ZG^8AiHO4-YVA|h<*JU);)c_E3UWA=pwGNmsC%$f0eg~a7O>}B(C+F%EwxLOs!5j ztV1sDEVFj&{r-}y*Z zp4asKrmtD3f0OmxJ&|*<7l_n720D#m;%O{01A=NO(Xa=Y#`?^E_S$NZgLZN9u`hFB zI&xkuilS}z%HmKUO1_kzh^M8;qb}Lwe<#IC3d<`8DplO>d6v@CuGNRX*f)RCFrEO- z$`ga)*$7c_D9IGoY8WIbmKPI0B8ek3c3_)3h-0r}ejE1D8&&c4Gszgmt`I0701qi6 zw82=plK8R78h8M-2lz-2cuS#%V*}?0sr?EAcj1G0wn2jEAU>QXN^&sHdNAJ0n5dnQ z5I2~VV|+Jy@LuyEC53PBcC~TpnsMsbZVDV)|9Ig}MQn65H(S0#n_07G!Y`>-H2 z%n1YlTKyAov>VTsCq>kNprZ&SeT0?ev^_AbOvPklHm%&+WVIo!GW_jgby`)9$-ME~ zn&`KlrHI<1w@;%@v`vylPSco#kopIBLMh}oH&Vlx5HQuGQujzz8<|_q74o|yV;9+Z zy))Q4N!|V;#5|4x^O``t0OJC$hX8qeg1l}QW5@f)Zj*@_!}rRDJ6;T@l7=THhq-G2 z>K-RErtDG=3Iam8FmVFaVvszdDi9}ajyJG>XK9+!ukwcHu%$h&-6bwlqwhr_E?(?_ zpi#;}f#ktv)-vRm3DS7#OTiefr7hBf}fl-~I3D2RfqPy-LL;=aaXxuw0p! z=2bd(yl@JgU7>MgL(``0LagjwBhDIk1lRvIkNxhYef&=G2b}8Cyx87rv1m4%WxLEa zZe~!cSvaiU8i;B0YLgG|{TA1opWR#Vdz1rp`82LaKdxoB;@w{JyD!Z}??iLx3^VCJ zXgr!UFDbvw*?jp+-(@xti!p_9ZFlp*z}|$9{izrw)PfnEYVX$CWxc|YdARvdrx`<~ znSiRfpqaUZ!9-j3<*3i*Z)#0b+Dy6G#`W%v+t6EH<{P6o9cOT|5K1){E;7G8X*j#9 zN})J)Mz)Xh5XVGSCj|^A#TS}c#SHFVH|L8vr}?r+`ArZ1uI05qmV&94mPHdn0h7!z z36)=4|pfSWG&}8X{%kt5%hq+o+HJwQ-)W}qjJ3rdoRpbusFSV7)U;Cbq}BH+ z3Pa@-W03t`poLM;^q**3l|AdLBUa9DX6?Mk6U7FSbUxhs(4Kt!#uG7+`ep2X<&4qs zXnN3lcgFlX{7HjxGa@$}2qU)GN}HmE%f;T3k7T(+7m9S*uQ-U!1*u-4*O?u;XulKZ zu$$v>v+`qdo8^AzjQr5dV9gv|=N!e!-eBR1p|?%)=^SV{QzJXxq&h9Z|GrN4a<-UN zVEh#`*((p%4PSlfJjXa@aO0hy*~jV!_U?=h7x*3g7iAxtDZT%adw!fw9ouI zMM<%-=<2e58*jhR<+K>&u=LVCi_yi!*?BC;IXT7gogt2luv%ufTH&`@HFJ9X;K~ld zaKziDL^UtU`_s+ixm$>Wh7XyI_su%k`%1eU_ZV%y*x2ryy-$m`Xn$aFIx2Hqt?H5%ZlR^;Lgku;>!A)rQcIaRXsRSQytE3wF4WQLqpf2 zzntH6<`JW=!||Q3d1rVlBu-RQ=r7GNw2V*1uf9hxUN>~(X289->EcXt7k04{*}p;& z-QW}pp4l03=HMti=B38%oxuvvXE@TfNQ(9oJ;d7QeUZ<4`?~&UuWwWVSU@iTyLO=E zb?m7}x{bx_bg!`LV!tnmExO-*=B$|JwpF|=zcH%NqP=$8?BbJ^u7;In+4+}m)<`j) z#Fu==PdWv=J)O?E*iE}jzWMaC*)?&*EA55{PbUtOKvL>ne<$k}FE$TRn^$96>W*JG z-+!N6>e1M+%40ictKA;DyAQ#;*>1e<{m%h9?H~Wo zt4x<0bQ6MLhKU(auQ*ybGCo=oU%`P_OseQe<17~Um6=`(+E@#w+1WzurGx?`G~UDw zPXvh)?!rc;2%rr?Xn+N4A~~W6A{k#Kl4yb&zI^KcGC%!gVdD#BaWu%efo6$ge?@$M zbw9{aVSmkbf4w_s&1ZizA$YN$W;1PnCoOoVWq;3h-){`@<;VV7|NhthFC^1sBpy!4 zh!bW>5(bJ_fQ9mP*)$pL#}7G$ zp(T@~XGH=f0juRic#?tqAf%`z;KsuR8nu<18$S1c_@wOzCYM2TLA+odl#m23v^UI{ zg&m{ueE5Rf8icTpo%APucc#7XrhUxXn9HW|iD=2C*o^^vgAm5HZA5j(LoVtQ!jl){ zkRX&(gTR`#=Uo=qxp7st-dlKS@Ac@bLd^u-Em%Mf+<1l7C=ce%lVsl(i#zDm5qzlo zoNsvl%9LS$0U=blsRY`*C&TM}YZPKa0(yx_ZA%-Q&*Vo!^LEg4#D?#AfU7W53sdLhl1{ z@)08P-{Bm-f}3_`%n|PdB7&=4mj3%O!+0{wfAVp}!~N^`lKlv0y$Ba|@6Z9asP{i; zpZGe-huzi-OAn3||98k@4Zrut%>A36%_1n4Ujw`auD&!owxzk6NKN(0oubv8 zF_)vRmqdD8jvRG4p&N~iT#C%d^}QgK5gU+yPM6vKchH*#&7;ic)fW)@ic8|GyVMO!-1{4 zzNdJ*Uxf1!uir<>w{Brvf0xTgH|j+-X1v zJ$nAppVgyI-Oq91*V^kl*IPKlyMMf4-W3a?Oy8vhBa)(_H2)>^-N<*5oJxU%|C`Vk zFWO2K?oZ`G9le@8DCxN`tf9a*j?3SI_rX)#O76W~6*+YKaoliMqVH)@Sa{~z)v!p%E^YlinwM6=uGeGE z9UQo;S2CBZ-pr_MMcM0{7`5}twA7`lt?2$^bAL^1MJ{sk) zHAV0+JaxBaf1HO-h`*XQo+SKW@IfMLf}~BV@ksT@dy+lLmhO+9v#_sA(X(z;?( zPE_}a7d1CAvCF=*{+Ej-M`h&$=BB}sx2Pe-!BVu+%Jko+SD?qVfjB|uPSkpK?vU+N z(dD--8M!wJnwbSGjrVf$56ZSnJnr^vZN!Bv*?<$3?v#c)ZEL3VL*y0yYVwnFgp{j0o9`VO?(jC%7$$Yi^r;dxw1I1g% zedUg=b8LP$Ursy;tZe^R<(J_&a#NzA`q$Hpr%^1oW!qMgwdC5B4z1-nwx8Ap7wmTY z-tQPCX~}o3Mp(;t|7gkh~1~@ zu9&%T$!mKe)}O?K7gt;P3myBW{(gyA?mV*j`93%03i@LqXZR1>`!61G?3A8oi@Ki8 zd~)OBb%_(tj3@M{S2j%|mtOU;tUM~(|8)2$>uWdUdHb$aB-6sCm9Turk-nPi(l=|V zX8{}Cw%59PKh~Z^xnyp-{CXqup}uA3;wz^wKPh!C*Xr(-MQU`cE&J9U+!wvooG);E zRQ3A%@wMBO-Noc?+Wen~&+e?fDmgGW=&a^?AN((y9j-1$%6;=J#8%pM{PYOPgBM*Owg~=xBAAlXr|FC;zitaj+-2g8hEDi5C|KSaI8qt zV>&_5n9sg6Nmd{>G4}KHqs3LqrADq=z9<;4c%xWXW9IkRr*QGlhO#SUG&IYqU}64=#&FH(4gYUk z+g=jdpW9O--%b{8)@{oBS-g+QvI4%Z`Km0eWLQm=meM>UOTYoR41=g3Vpa%ussJS} zFF!=A=<}hoVpWPBmp7AKU?ciu!G}u3s(EMO?EXeI@di1YEi!hW>ps!?G2{jtK-Jtc z)T>D;kLb7UjClI9k`FROMT>+PeH+<2#Ml^T%UIl~i`1e}13|Y~0E9pSk!~!jAaKSg z1W`h?&M0RPwn+4w5|*QECwX{ESuKRo(3%5?XI#e2ZJ6^+)}_z{u0b@50s$eq60h~C z1W$^p#x*hGzdD|gwxVmXkv^v01Epwow1IcNuL>YS6Xp1ta8=<4O^)atkI5@WEf|&> z={NJ1&JJDU;+4(5+DQNOHT#X?she3}_`NT4If{v=wHPBOH2qON0#oR z+@`w5Z!AjWOD-W^9Cw@d#1s-=QB~lMIS<+i&L% zxy%%vxXIusJkZ+aH=SLO*|J5eRuG=PajnALbd$}tT{|lH-Xp<2KZe4iNm&jR!+sfw zbB@y!_of%0Tp04t?)Wv(pvzQNIl!eX(vgU@Q7XAV;jf|9+V$L-|8Mf2GOH@l4;Bth z54HG7F0qL;KWQ#*)ep+HFEki(Nh-O`;AcMU zF!fa+xN_k3_66^`u)yHJZ2qob$=2VmC@q0C&y>GrP8BMj7#VkWb$+$G?f9Tv{6=TF zQfQ{N(|Jxk<9@?$>z%+ya{Q&@W_FdM`#I5)vo6;=K6Hc_pZxwLm>V>BMmfZeoo{2) z=-Q}VN?z&ZiuHX&=v5}OeR+Y~?`!wJHRUeOC0zWu0?Mm>7ztXbJySTNwW&TM#`t9! zyuG8xuGKV@_OY!4vgnm#ea zm~}K<=QMB<+TK866bKPH>GHjs{$u=8QTVZcaaZKsmcJ%najm&FIc4YDS_B=VTqEaS zFZ+lT3~td_Vs&^7latMYHDo{LiO9@63m8e&1rR`=wE}uoU2X`GPU*`o#1umUFabk}%Yf3Pk1B0J$gk3lDT-cku_G5b?CT6UhB4*i} zImkx;E2nVxKL7U*B^?WbuhvU?zX)a?m)yd>{q>R_AwBvdlkH$-W;uxW@Sf|Jdk#M{ zxxL=-PW9QABbR{$XNYb|y-?|>6sA|vZAKGA%3Q8-16%(r?MBm+*M{4_V?g4t5?l!V zHldTv9lc1;!a`XA<=nx4DXdU;R^c*keuk;$Vt5tOLR0+-?h>MyLZ_pMnNt=}kl$RND`j2-^Sfb3Kz;lF}lvY~l0OY>HM;mGOur_(Cq zjChzw%j~@t&_u+fPo(L*D3NBty<}UJYmt$Abo0IR_ z@g@NZsrUoG+efidrBy-s$BPK|)kOyf$tTm2VGdGEOHz;dm9La2%h{ii?w2t#knMmA z^6)E}EUC&-+|+hl&+^Ql(sk!moR2_u(4x^(xAXcHTNf&NEJVL>3nGO}uM4&LmXcPpg#`{XEK0m_h5|);JlAV`})h3bu82gN32q7$^uS%?QPvGt+65u z)G#9HR?DUmK=Psk_}WPN)Xr)rXndCbu2^NTfQYYnx$nM&S%L)b3QUgeoFW)|PqFqtbaYKZ0F=o^;Nl~@_J&=h4=7Ky#S8~KnVVZbPvt)7PburG0y_(AdF)Y zF(0eC5Tb9_eSh4q!2PJQT#1#Bg5kDet9M}9Q7}cISM~cj;VXtrUSw7AO6<=3UxpVOnDi0Zn;nAH;&8hG*6yeid?%Q^2T5Ku1nor0RtTcn1V{L76z^X#14A+wp`t$?e=PT>+NXr z*|B?1f3R02Pg3!ec#o!66{!AEc811(!!lS>r+)7m(MQ>%4oYB|N`5@m2ljk#DJ$Zu+)St%=@$=Pv zb^*>9@2_nbG98c?pBQcg*BgZIZ}wxi3f^oz3^tpE?1;bBtCrh+w0pHPc(35iUc_MF ztXwj_ekECMdjgqrTAvR8y2JFfVJzX$rGC%9{wS<|Q%!zf_xZlj^OvSyzwRU-dpyS# zkqp}V;hon^md&qFW9~&Xe@)=kLu=EYraN5MB z4kLb$cu|t*NX@$!^>diTQ329qt{y&(KAK4yKDK?^)P{=;ME<%Y;i4+oYXydZ28QuJU53sPfg9-1((YC(-iN#~txclJE06GfGfSmf-QWEIaBz_$$K~IuYz{B?>y(^BS zTf=bS`fwzKAqT5cqy#+5)NBCgsnL1s9-K8E#)p6Tq=bKWSszIa-;_y5{75R}F@o;pXpE5mO&>qme)<+BU zV7CY-!f`w*AyW(CPlDkhq6gRpJiUkk?N-ie#AjO2K*0J2E<{C?-pGy>ZqEycnZE$y z$QDZ&oG=2kCSz0eA!ALrvG0d;1MFwxq}cFraEPnC0Yeflks878OArdjCXEpO=&BmN z+rny7df6^(|KNz6l?>5s+ z`G{gVYakN-18Yu>7U+|-2KKH*BBJ*7!lBSqMci7f@E;s~XIm6!oNPEWlaq2Y>N?4l z8VGQj(5H6u@Wm1WRB^pgnVdhpg!LaY!5KhxGc)`RxfH_1HyL&}snr<9R7CX;B%3!b z=nTz6*1m_W^m?M$f(jgC$f@lvoY{|zt?mIt<#3Xbzg{vu5;2hE17rnpY` z(oZU*^Bo2vaBU|nRTD0w1N<2Kq(gw*$U#;Ebwg%|@pq`KI^~T7h&>zdOFxq z-F_X5WPw8fkX&`fsOL;z??tU_bs{W^z+#P;-FheC@=hrbK*!2XlbHFd)L1g*=s#(-S_9#f#-mjDoF(KzH8Y8xV0t= zwY{to3?+crRRJ-QK9r$PJFyp&2x9XhU7Wb7pApaQt0OYh>(v70Ht#)W-p6*H@jQ1j zzp)O_=)O3ItyUNL+uv8eU0)6}e9*3Z#h!6QXgeYNd&N!BF+T#$e}5&7BDPO&Gj(2b57o8vMbk}A9N3z%!N+zG|3mUsk7_O^ENAz za~~}D&Eg6Z0hg+#s^nj_s?a9G+0+Ys#|rH^q*=w>(`@RkstoU{-}SdIZ=$0-79zOh z+qb&)CbMZ2ZkzH*xHKGJDhzV&3|SmxOgCQO>5kr8`~0G)l@!av^pIMn@3%2lTX z3N*}fC|khD5Lri(cv~cYb?U>lOax%9lEQwWL}}C%%-1aQYQ~rF{|6i}Bub+G8I4s9 z+~H94pB;W&J(P{pOXo3pQu8)n+?EMyr~d#*r`f3}tu7=!D`NBB3OuGWDM?d{ro$$z zoEs^|ISX8dU>}awTUVR1b*Hn4IN%ff6Z2~POzD9>med@#n2FA!H|$Q5O~a?}u4cF3 zumDLUKnT!3gM?M0r!OYUGU_;2U%wYDUAQg0l@rk)B%Klt`w8q z08qiVP?>#a#|hb+bk6wYlx`5`oFUGLsBAPQf(EFt#2@m)mi*=B(*n9`syJxWlzaVs z;wr|+@s7>?B0fvxW3i=Frh)VP8RAicU?A7)ZZ@3H8X(rHVN0P42BxB2BnGwyWqYPoVRAdC5lCr zf`DX5F*&u;QJofv0K&}4f(DIUAPQsA;h%Tfq|elBnW)soq0oNbc2xEC*b;l`BK@^A zZZFM0*(&4=9V5T_Dz^8$p6!b$-%gjMbfE4GMfP5+jh~A!xf<;vNGYxR z8J-44AKrK?j*Z&SQ%fvfL|9gAyAN_@uOzTb7D)>cg#8+-OoG;=_u-t8=Hbld^)4PC zFQk=?8Q!n+^Bm^%lU`zS3Z7pc5xBZSHsyXnm*Hg@>|tA8I`gvNlW=6Jz>wfHL6UGa zjDe)@kOnLmz>FSvr}MavJ{B{7?Gj!r$WC05^cy$i3?n_(~WI zl#&1v0Pu{$eX|LuuK@Sy!OB`;NS-|_Fl(dd2sXcNN>{3gOPQzva1dTp854p&oa?lN8!3`04AVafRr1k?LMVpmgpv*_fT1?XF!x3o6ZZs9gre0-Vm?+2dfyJ z`@1`ppL>_%j1!b*dG&=QkGM24CxIS{?y=BW1WLb?m5I6tz@-XRjUfo8R&xw4K-sk8 z86oq8T<@1wz}4TM_~+Nb>7fMR-ZW*?k;;525Qu8SfO?4vP=FyGUh1stK$ETl&C~*- z>zq&&(Uv4bO2(X!r^DzL4 zveL`d-UggW(o?M`tH2OEv?l!$85T%pNfQSFB@`N&M>w9vtgWnHyzeZ6Y>Bnh@eLGS zi7fVQEf26x5{(1Sa5ou({{La5VH60A5^yX1Z$C#yeQI7K*b(TWfZNb%MrG@%Z&`*f z#9<-E#qmt60B|G@CNO#t7;}*QQdyuv(bzt$3xQzC9Rmdl0Cbga|85LH2k<3=J!29D z%t2L5mi_FUj_X2(?uaJT68|sj{_N>WBuLz&QmraUkY$0CC%MET+wRZw2bcCVPY@Q+ zwkb5bPQG(mox+17^D7A;%;E8Z{}u?Ku2GbOwFjdS;p~Wy#v8ZwF*|be8K~xxz+Q{2 z_bI&49v=h7X%cfDkZ26?{E|;ASz`f+I=0hoR`EQGEKQ?{yR(i(^`HgJ^XGcz@5CXX z6^y8uAV|;>gA~625=~ekK}M`m`e)o-tXdK;fCs-wju-s9N8r-}q4=eXHOpg4%MN}vKyecl*BwYlMKFqcyTFANK`Lsh7 z5I`#N4GmqlaV-ivdk-Y`hsV>LK3+p(0UFJe%3z)Y0J1zutS}B8&vXPyeW4#q>F%{r zsz>qpSq;mL@c|1Y*0_JeLmRvlj7qf%elk;?&~14w3tY^%4CPaBG06V|keDlT1+y1s zElxocur&vb@)hzfjzJHzlUC`AeT$$QJ;r zK2oIiwRx;T_UvD9pU#(wp#z-QP(tL+fw1o8;b0F75kR?P`6b4!@F2ew)p(#{%qEO8l8r zHV6du{tyNMchyW&I&nGgq(jXTMp7VXoD#Jk0JeRUGN&f^j3I z#Y~Ty{vvt^@!T<&dOSbdUj=l-0NkGZ?<0P+ENN7N2WVHNqXk#Uk~ERPx+a$a=B#)B zcmjxa-GNvGiXe&UZ>L}mUg13ZmkV$7E57MqhyW0X$Ba>6;((R;iuL;mY&}tJR{#pD zl*8^ts8)H;2;5{t0w2YI+XMv87;%??anL8Tku{!+0Uo%sc^7MKl0RD*?i)x`KlJt^ zBb$3aneSFXAIbYt1wkrZHykFB*s5#nV!&C0fMAKEjiGb^FhiS~2}N%Kj{S!R$&lJxY|42n#1L&WEV@wT zFMH0TN7bVj$@)ed9Y~IQydShWaTW`oJ%PlQFSs8rW?EpfmQ~HvMbNT^5d3dr8}SIn z80?*BwZ2P%VoK<-jdRX$*4}X}L;{^bM2`C*ms#!#qWIj~<0X%CEOG(pXat*p-Zxs6 znrN{w+hjcZdEbwFpwg;5d&qV-uZ@Do&!%LV8n{3q-coGJbZdcG2 zjRmcy_g_s;-6NX&8rW_o@8@z$2}6UQaa=7nyw(PRTAvjhW5g5;i%~+92?zWl zlOyCV>b!cj38q#8`1ly~>hd`!RC(xH2|&oix--#R17+6}p*p1t;#o#ES>WEV`CrV{ z6b+L>H30;xS8|DuBv3$t#=ffux9N-GfYw9i8CIy&QdxjICjkKZY1gonYLmdiQaw2E z#RSui=lwQjr`;>G{$B!40-%lpP@E^m!BjRZk>iZjoL37T1sFrarRyuy|ErMStH6iz zeJsk8p2kvGQD71yq7v|?s|U~#a-gbI_iT2j;58hGzKuZ#0J7O^-4tMC9~TBOF0Oc1 z|FoMt(b%y@c&iu?`8!ok65R}lraE2cwntkeMf8);gU_~Zf0zTP)pC0xIVir}qo6ee z>wT|+R#kVr!bN%OFsdP#6;n$Q&j1J+av)7}9iBgv$(~o`VtqvC2V027F4Ebk zdSiPlH18!%;}uv10MM%Ex)^}P*B%vv_K%oVN#6M0^d6)5i)kG4{&ns(aE4IBpMpvR zP{=Bml)xY6>`G)>ePKGrQ@hUmo4j$hbK*K(BWxibt3!9@#R@9EdVb6oTuH~72cs&Z zOr?Op%MZt__3aSv$?9+Fba1%QiibSp##g z5`eZrvlmdwZBQoy#tHyLNyus%6@d%Ijd56V-^6x?;#5Wvr2s0T4I+fM8ni9-H_ghE z3}PIGSD;baq)gxpXIy#akAA&Q29vQKtWMP`FC^I7Ed3YY9jwwlM`fCM%=k9Vv;|ZU z$s`P5HT;TwZ>|47_=GhKMN(!Iw*0RKMaIL}s8#Bz-u4=pS5!@93Zeu+MN%L>#+avl zAm;^ma402eOb<_l2jdE9_>S&k=R0`18x#;CFF(*ssN)avTqrD=iYh_Fk)r_Y1|L@r zI30hM59E&BL(y3SwmGPq?_ypHcDd6xVhMmLl@iOL*5$2jk;68$0GI*D(os|d9t6dq zaL@B|Y1M_aQ9D62vb+*upah#XFqXYhL_=p0a^S&jw`mKo0ZDiU1(iU8aaZ=|RwHd3 z!Jb59N*i1me>Mwh2Ls>)JY6CYj94n(WUt9hyR+MNRk;mWo&#sV1GjVPnFP!RKGQX0 z+1c>TAHLtZxYdR>!xZ4v&As3vlbmfBNRWL`YZ}Mn9LOy!JAEZ||8J(S^Xo2DF46iz zDGVjoPtw7|Q-lk&^KF!+-r#$Y`~de}L}*_)7Rz8Z)CMV?00ODnd31bL=u!77;CdT@ zv7gz4N^Fe)OY1%3R`xCQ9|=@azCH!D;b51jVQa-fK2PYHNdrxd^b`p9c^W#|?q$A1 zSyE|^ZRs0OcID-iwyVe$?f+N{R_yPGyYK-rqmiBlawTk2#K|&Sgy+LylfL2IHt2o^ zU=LhsnCLc0ds|8b-&!&LF*wmC59WUAQ4tEE^y;hSXw!&Hx9GVg@F+0leP~B3+hQ;+ zl>Q$pJBIN2-7NZ1D4k2Abi^n;eN-t}j}G^jxjB^XvLsVI{+v-Ra{(R^LO{|CFok$T z1pa*C6)w3j`ud#bj(v2o6nHd%%Hmbq4W(-x#pd6yeH}_ykjC0XMFf+OOH}42in(+^ zLrW;)zGlD~kgNtBr`$+iPZ3?MVr&ehGqiDg9gZF4{m;mkE{aBhCxoiTHGK_QWJ(`} z$5O>xLh0HaW74Vcuux=64%-NN?on>wo+GAt6wz{me0-m^gOr_bi2l_!zb-f{XT$do zj|wLs?o*kkL+L8^SwOPS*uv;Mj#&OJpva@}>jad(w9s!VG9(mn5X40#EQR4w?{0m? zKVWPi&V7+YgIXk4tLPG_@JK3Bg4ew@l4PNJI`_ zoK_8Am#}F#AHN#n#oSN%CAT(b}kp+iED^%AcnrR&w2G*^&gI0@3oVEt}-CzQtmz zt>^p8`Tqe2D16&}XTSm1?ZLS1;qvWwJ=-7Vw?|I5NBMTfwRR?5cc$WYrptF`dUj^# zcjixb7Wj6Tw02iqcR9$6629o?r&y_n7;bj9ove*LEp#Nu#)0bwOT^YMS+;-FUHZpA zDn{sF*U{f)v9R0d-voc^>E_@0wU{_6Z@ef2Gu3*LNni+#ZQTTCqtSA#yjEwXCpJzR zm0^(@eY#g9uveP3FXq0-D8FCavj?RyA87RM5nGWyC9t!Im(t-~m*@v+`hpL};8EA*j6^9aXM@2e6h1`GA z=^Q1+9m3p?gnEAp(tgsr@2f5ySqc0s4*rEBAEBy_5=V}pRljhcUl#m_L>e_tjxFZ) zX8aFK?591)PkU)rEQu8d;jQS%*9ZB`YJqQ|WTgfyj*5I@sDf?#g^4IPq_ zetdj-7N0vI-I%YpFNG@vD>3x-nwM0$`^e?*uLM&9E&Ec$n_7%1h3yYb5((t-O4+=B zf+_T_7=Xsc1udhI~V0fj%($ZQ7P&-{*XA*vZuf@e_QsQfTPu0Bd z2vi;mKd_v4TtVsuW(*ffr(3__O`61R2~IC?6&j^ZH@b3; z%CvMEq?Y}ddHE#M&pDwCsq`-NCRHCAr>ZJ)1yn-Nor3m1hLLQbk^&geb1ae#(S$+L z=%kSzHKbVdpVb21DKy{_2JQRI$S$a!463*iywvKGq>(oskPhm0X80GiD&94hcdQ2I6Z>f#ZQn z19epaIAbI71uP>p$pe*PdYrIRnHu}I!9C@EX=RP6!)4>bZxP*>{iUEUrF)$P%g&UK z{KILT>MXx1l$k2^fT~-7UZpR*a-a~5pZT{b0gX>gsBib9Fehjc^eY93zaYu~g{%-2j z<#{Q0&(i^C*tG!&Q%bTh3U?EVandTZ2BA}lL2G*a>kheKI_d&{$yrc}aixK6raPFe zfq?i&%~sO~U}Dp~So!f}T!}kasEZ`1+M!WV)1o-ifYQ#wbSm)WsNLK2G!MUyeq~>q zrN3YLY)w38{qaf`M8Y6NGm)&j9WF3a2@8qaOK;wL!uE=WOH+2t?arXQVe{}SHIeKk zn@NIYFZdE5qJT;&)C0^4=!nt9U=-LB#yERy;n3xvZD;Ll;ScUilfp2O z;h%s0D>!q%vM^Ea0_p_8#8gs5lsNgAg<={%`Lw3>;YTf7^$&N!kyZ9#ekMe9+b5Il zLf2J$3Bh=HVvGl<5e=}D@MvZ+K&oQhZ+7wf1vINTKDqeS-NZT77!!smmX zhSPZARC~QakiY$lnF&52_NJtuz)OP8GgDI?k8TYFMZIvIKXT|u-Ea2u%VB*pyFh<7 zta(7UpD0C4X3#ed6!9vZNc`sxg}4{!WQBpn&!WRMIgp4lpPU<(8#RN=^`<-TIA4ky zwhAmtS!GD&oKbp^u9Re8#+oF8B>I6D`%#WKl3H;9tGREV_J%bSm*M`vZ@3>DN0k5- zCopIOeO#wu8B&h%NRym;0z3>Vj29FvBPHNS0D>cfK<8te=ApQs236GqepeCz6iX(% z5*bHE-v`#K@D88$c=@gD&9I021a1OTOK<1Sk;oxdcgVYQ8x1jbhT} zvtp0qh-Yzf=oj`dw=3-;qM9gu2!(UV_wxxbF>C#XryE%eiSBHAT_D|eH!syH+^#W9kQyruQVI#{ks;N5I}V6jM&jBDaBo z7p#4s2{>&~Q!k7*tp}qMCasGWjw^&2Fsp|qT=aYVdMQ=s z+t2dn<|Eqvy_7rf)`yvgdANDwSm3{PH*xd9P4fx-7OBsHy11jPkOzeKp@2lwtE3pe z$~dEA9jy-n2@(aoLf1ldlwUO*DL;PId^+-VPp}~3Ep*aA1iC>( z1al~@5(D*1qE}k@&RD67n~v#)X;#9Jq<+}za{zY%HCv?Y3HYJM0Jt1?c1d*wI=gh> zl2iycL=eGoIhj$(I>E%OVeN682G4R!#FvR%_-mbJTB?K)GEc&cj2b*>qt3aZZu@VF zFHwp-noOflyZ8OhFSCpz7G$@7`ZPVe;~fJ1Hp=NeGT}}d0ZqmjQxGnsfH2BS5<#e2 z?KizDgI({J7ut+Gsn)59m~Hy2sSsA-R};p)eK{0v+Y3aG3yITer3t;G6z#^P4A%BL ze9#R38cJ1;PIssdf0=IS0wsw`5aFQ{)u$JWtY&k0^*i8#+7oTzm%6h0NI7YG8or%D z9;>S$-1n!nTG}pE#_mlyQSV8pp2*+xmjZOUJs+wcb}M~&6F>dt@y442(^rRiZxY0H zk2UlvhCy%=NpB?sjMt(%_AmMAlg#+YihU;AsIU!K^G1@bCZiKxJ;~Z2w^-zt;w%0F zUDc+1fkb_Eb3TpO-ic5IcNx2RQ^#c`eV6pt@(lWa6!mn=B%BV@+-8yP(vlu7gN3Pm z^!)}2sr?L^eI%*D1d`$FoI!UUiOHvfxR(P)lZIC!IbGZPz9NT&xs8@94I{kL0uGCP zn)<~485V{b#U&aMWA9zx)_?=HcqwIwhwBLHxh?XL3P!u*; zo@$h|F;pjRtnx>%%WPP!Y4F;=;h)BD$s5K8Tthj5OwP01x3K#4TZ7gvCS>2Y8fnAf zWy1+jgUpx1=U(Dn&wG~ zA0BGH%NhM}f5H4Y_QRp-+hHa1R(Zse;RV#J1#7XUWHSGfsqs*6+|i=O-(qED@TLCX*oTqv z0`#s||JbqRZ8|IAh><>qcOQ7(?amr}jeN9pIQ-np^p^Uds`Oiz*pKU2vy;fTo3S5` zw?9tTSoN5X{7tm{QD#Qfv^<7de0Ldv-~UK&{{fsiGOIs2r~e6d-%0~BfY=%BQnD^@ z8ja%~%b^%OBE4H%8C^WIM%}e^-~QAc{_dOIPzTl$Y(K`VJc4HX)Y(6}-){-}JhEhM zW##n=74?ZdNCTE+^R0=(dBI95>f*mc`dR6VyeA*F%+27+V}D#eVNc9xf^(mKMcT-I zPUWc8T@bFrSy;*4r^5%?N?v$%E{IwBuC9#tMeSy0&7Z~>E?CRgj`Wyc1e8DNBu&uE z+j)9T=nwSsHdFXMUR1x2(tu@)DI0(CwVGY{B=0?`AY+448{0cHD|4}_wVQ-Ck9C3V z0{@M@JDl7pn>4VT_bBXd;zkU znXlT7Cnrs&oJ_j0jm0q9Qbv=7+enxNZ9e%Vi5xOFE{zut8qkaHU}5)?uPXa|8RW=z z|L1=duo<{yRi((x1GcIv<(V3LC;C4FwRdruX8~q0FasjVRy^B?1Qs6!@&K}GSE89C zSH=KiS=7vvlN36Iuk9AjHTGXSWSlypzIOfmukNn%jSI-QVqoKdTyqnpKkf816`Du9 zLu6#PV6?M*W=`riXEm4%fH61$q!v~Ze)=44&$&eegjEGQv^n?vV zyVKqu?^tn={KFI28!o+`%hYItnj*nWj(6ussUO2hb5VdyXfo{^Y<_`leoe(wI-d( zEpJs5lWOf1SHD~v@JQtyXPTdYWJx7aT{=0Zp1u4`TM)i-<)`}xJn?+<#hh0cWwNH? z811=FJn|Tq9eFRSo!YARF!{|*M}J(Nxcfy<+Or#&i`AcX*%?>awa3YRmg4ieyX_wt#Z)mx!er4HcZN=DdPSbqlKB>>9aLiC^mCw@qO^m0Og~cV; z6-U`s%lqCYNnXxJUM^Z6FTq!q&@0@cE1{n~%?!M_2aS0|r;O&@bzy5xvKh{UQ|Es! zt0t|g?X31^u6eI5_*`@GsrB;iSfR}=0aHXdA0NFVqC@gpV}Xwn`xTcH?>WFe7wUPn zZatE3J*sEn+6eLL9Fg?Q!O`Gq5-LXp<3T2CjWZA zEwZeCuFBQMEWg@8zdG4~X07k}ry5l9&LYy2W|SS4`}&*=UbR)*%|5C`E>MUYVfLmau7u; zGcI{6iQVzd+S(HPs%PQ%t=*-)`R)Cw-GjB=!=v4J_>a=yKs(VN3mrj?eL=;*)}~6p z3E%hc4&STczMng`PRf^?T5_6?J`LD^epvovy)K9`B>?&92UR6(VmAbKJ_K&`LxV4L ztix|SE`WU~c=$AggE^G5e)C6NFk40F=}6e5;a20d?~q?U|8}X}K0ApW0l(n^EUiDd z&jQmFgSRzE@Y`=|L+=giyBJf+u1_D4xr-=wqDzRbBN?M{@9UhaYe4B45S*_^%~g z=rwg`getHef&CRBfH+h?cc{T1CY*gJMhgQoheN(aKtuNA+^F~bsd#ly)Ab-*hh4L) z!F})u$#W4RulH3evK2o~DrGxhD#GpL!mPBzaM__Y*})et9q3#=z(+^?O+HYNJ5oCr z>Th+VTrsXI=cE5=eY^(fq};%8iARAEf0uT|J3x3G`0;k39zO{*w%tHA5bQ8%Km z8Fn5#(~2?f*mr?v5qul0y&QlJFL%%HK=y`_8#w1MFC>Td13vi^y zqRFDEiCol*zqhXEr$#4LM01}zlC=uGe0#5j0E3RgY7zk$JWm35gKP|?Ur4#_3xlSL z#y8jU)gPM_T|b&yFX3lAUh@y&kEQ^<L|$o$@yaYF!}bi23qvP z+fih>sCc()FMJ_i*pU1&T|LYdBPR z$&aX$>7tX(q?7+TPrja?-yb-kEnB!Hb|o~iq;ew@;tp<-yW+>wkj&`BzN<-e$1|<3 zl5R9RR~mfX>^#N9fBpU?j^W+u&aYGCgRh%zsYb;le-^Ub-#;I2L)b{jFh`OF@iZ;_ z$IZd0t{*#*Uyd8E{(AH!{U(59jDza?FPH=M8njas8t-lV=5`0x_m3C?s+|mG5B9oS zC19Mxqn9V`w=evzK-j3!?w*{}`(gz>|1!S=(UDAv(#rb*YBDL{g|2*h!Z9Np!d4x(dKqBO5uyT*<$&+Z133D-*+fhylZ|DUO!hI za_~;%-LDY+=Oj;sD0N3s6`GYM_gX|Jrr9`oNYf9J?$G@9Rf?^DIcKz@#b^{P-$mNV zXMN)QNuxu_^Qgtb8s{$qF8fgdv$F1uDqDAH%OES8DB0neH+ew{B&fes(%SAc`)n~RY&5ehMP<+RDCefN9FlYTzy?WMbOxBk0WXv-BP>Um|nv(8d2eRGZI{Tx|; z#V^^g-ZV)4KifRg;zO_E)jgBaatT?lp;%gDoQYIYhwQ*o#Pjn0NA-{1 zy~VY)&8#DM)Gw&?PB#P#&?pBd-&Ye&!Po)t;fH$QpdV0yp%{Ns`@9pNyI-L}0B zZ|S?kjYYxa?~UTpd7qLwcGJG(1<2VQ(@SQeOhV!$dZ^rh1 zw_M@)F484*mmULStYyS3=w|bv>3i@=KXG7mJ#eH8b!rr_|9gyPc zkRLkbD^{q&3rRlhVslGVc(t_iA>>p4E9tON#lPl<{pX7!qn=;RK0YY3J~tbjZfDl~ zqz5c`KQhVOb4#h-zdG^TD0@m!PYdTZZ!c&W2F84``E?;` z+1Q(DeEGRy@Z1W)O`?6N_}mrO_4>FL-kDLp;EPKl2_ID#-qN)wrCfWH)L94p5ky_8 z4w<*!%5RbN-tfEB)3Gc2{Fd6RkmMXQ5 zmU&}VHQp`yv({a?AHUn`X)6b`S|k4Bzw%FZIDfb%y&9hlG5(#;`?qH333Zj>>eQY8 z_TzrNX5bCIiCXyvUi{Tj7Zw!hIx$1_x!Bu!W%Sy~)5&9Cx>qchiM&;P1@*c}hgNGX zdhp`X$&*VI-b{4jeE!!RCFBLBiz5kz6BQsm)gm-Iv-KqX7^H$-=g=ZY_k!kE=DG8F z*um`72cC>;B6F+0XjqQL=oudtbOQMUrJBJyEI} ze0`80!oGVah+&z(+h|a_JU5GWad~&TOXz$aI_pkBH9Jf~U%2IQDpB(R{a(HP0e;-n zcV!8#;Wum|crn~FPzWdA@Rp`jr;t~!DJ=d?{N2Rmj~R85E91D$7NE~8TVTvpB)YrD z70wcnu(BL1>{sUyzk4@7qZZZaXyl%kT`Zs|YMisF7f^yKRVWjYOldG(<;=Z4tCY)s z<*oT;^@#kcLqQGg%@HT{kOE8jb)ILxjpMG_mfU^c~49cng=C=F#$NKUiE}yF|y@xogr2Q;Rg?P5X5KTO}x+QK~uPU>n-l7^gr(>)hm2$m|qc;%2? zbz9w%u>%JL#Sqcp)IouTy=;}51wNW%-<@XytG6S;pz^jesMMd4EUrl#Fh!i=-Q@P*t*D!9F;JkxlW5;7nB~bHg6axJ|D|+Jv8H! z*)*|zK3>?!qI~4AUQcGr#nX4_t^WwNkaZS&_l%Kq z0LL(vK1=Q&%~=%oK1h3i%aXm}egB5q=FjgGUttMN6}u}p5#yn!?Lnsnj0DC1q4^AW_JDky#w+anE zGt({l@=-fDGPc6G)%06~^{u!6-7xJ~!nAJd$Vr8JyYl=8iaOR4;InBfy}X?!yk5@H z6O}o{^K{?&I-hga;l^QEi*`jRP#)LX@HBP{@lE4i%V}s`z{#-Kxo^c9u0A&RyN5%g z3ubA&+1Cml-T%PCtTFK8t=>TW{k@MhH@_J0Z}Wdw9M1hAw5b+yqze z6>hF}_pU19y>I_*rN8;0>eJRng8JY5DZcNnZa4SDcK;MGs~zQ>f6-C;`gl>V;^&+4 zxb5@md_}o;{Nvzqth)m-W(g7 z&zq(D_sy0;-i6KXln;d%yep%8$=E+4C-gBEeBZIGqO1E6U^12y_xUtK+4TibTW!`r{ z5x-*=;18Tx#|K$=jj=s%u}f!oNgmch0dR2DdgLNYAC6N#2W{B=8buu z5Ago!KSl|)OB9p@6|Utj9o_Tz^?31Dx4_R{0sb46;!gafzys+x0hxD1;pESM-OJ_I z&J<4jmDt}nSCISCg=Ihe>O1Dukj3gNo7LUdAAriM>Hbu0wF#;62}qjqtKFzlTN6}Q zsM%BX5>;Q)fO~2__)pm1LFCU@b89{A;#7i@r?RXOpP*3K;T%58>&@H53zNF%D{Bn7 zmedWrSS-D8;g!1T?&@n$Wfwig1ur?*May(g$v<8i4lAeb{3e4?`E5OUoQP2HiiAR~ z{xuJ^I1lT0i`Gl}cqAZC6cOF35nU4!+ZEC^t<+W-a-4x`;Sw%C@RsoRRt;WKy&+-{ zUuz({BKrWUI=gb&$JkT_r(?>k_~VOGRrZRHFgr_-^j6X&f9r`1_| z)R+{AX!D3B39m8HB`M@p!f%MWBzude`3N<$!l@j#a@c-zT%fl|2#p~pFhOP^(01H$Gc z&MHw$EXz%n2RFA?-w%lR#^Su`D9Skr7ja+&2}<9uV@!pB&!USHK}<*r=O_?rN^tpU zcF|NY{E4^Q^V)z1xIo=ymv{Z{Dv%4}20U$m@d_!AoG1g3WRz(7yp<$CAA}(#A`i(X zmH%@|-o4Q))Rk}s94NZ>@PEL8_9$%loF56dMR^CVR^bQ?PwAN5E!4K_A)G|GHvY@U~FS=)Lv z)!1^>*m~O7r2a-8c%+&L!N+Vp?r5y4OB9Ip)oTNIGQ`1=x_YU-j7Sn^LlIyO2sfBz zyjzyj64abo3S07sef~hCykFC<9w?~2_%9xu7!OR-bitKM9FB!NSzpT6cS2?GqF z>WdHn73-9Q(|%Jy1GD|*Fp8Iop(uT${&`XYFbz>`H(-k)u@_M8pa6#t#Srse=1@}e z4uQ@Wgh1^@5=@IsNw=!F$uQ-_im^Zm_^qu?H`=mryu+l(05yX86 zHl9u3i|rL`OT5J^9V)z?AiM3nB<`DD8yMg3&i+PgbirBrYu2--3|a5+YqgoDt5?e( z$<8oE@`&Q8^I!T34UbEh^78zb<{&C-AGGR{f|EP&P9|lw7p8sw2+X`d4Yr?T)`Ei{+@sAj>?Pp;L6mFsYJaCJrd!Qk`#PI0(>1c; zGv#~r!A^i{P+$jgT9oSo&+6AcnI-j|tvD&;=dvHd>pnOHp^s#4d=R0GLDgImE=-GH zyScYa<=%r^S78izL8MB0sY)JCe@WS4UVpNRp2lR*@jID6x;rc~qTK`AV>>d{liLx& zSB_Qs726Z!e7RiXgpy3lyKV?~KW`d%xMLtG_!31>#6t#Tf81zjo%8rX^Z#Mw8e$w= z{qdSml=K!7UObSVu8A75KsJ@@vk>B;zj@E|J#$J|Ju**@(APH zW}S6 zin|_eRwvI1;WsH4edbpGK$aLyl7Yta#`cM;wb#|kYfJa>2wGnkJ5NxA>YJ&)s{S)RjIl34uq;sn4~V2z z@|_bvg(aqw+W~7bx=lYr87iU*l!(9rZV&0<^_9>RN#x+olfI5xm1jgUvr?i84=F^f znjWvqT-g!a`ON97%%$@x=T-pY1`TR(C`NAFBj z{7;n8)om#_3vEX>B#?xWa7>&1=k27}&H>EqW8e%&lcUciOa@{*x1)Z>T&04imu1^ zkm*T@2o7Bn4lv9ser@>p-S|Mlov)iuI+OuGN-2^3A7D02xlTtCjoiyQH$b|Bz~Vr9 z#d;ufC6fjaqFoosdjo!FP*174?ICSVBptVx5?X>nYm4onfwS+3{fG^OE8e z86==0oh)cg3HtQ(^qmYfL!VCn5zt2B{->uk3--DWVoxD=jDPMF=`5;;3WQQFASnWY zq$>3UWjvI}7m$>Gu{r;ItK3k~m*k0$hmi^uDgB~{pyy91Oq#mIDKQU+XuqrKqf8C~ z`m$c6rjDLVuk)*Ta3!f;NJsk)@#T9BD_RLopTNNYLa4scj&X<|*M&)g&Zz<~%uuzg znqjkgs0D!2h0;n7Fe~+HoA&|3Bp^mziXppf$a!u}k8YO4=}V|Y^s?miN87e`e*XR9 z+)ze@sxjpak1>e9a$00#O}+~>E_C4zN;5!g=DzBVupOCWx=)wq4R>3rR4j;n<(Wr9 zjP3bAE^D%&Z@-{?oO`pz?d7L021*UR*bN^&rM^2V{emuiJHhShyPDsAz4}JG zuz=`UVAfhZ*R#m4wItTFB&W4}zGqomYsIK%#Y$`SQqQWJ*4owoW9+W}qI#fqfzJ#K z3_UP(NlUkYGzdtCARwW1Hz*wg4Bg$`4bt7+-4Y5&2}q01;rDspi*s=<&L6OE_nukn zS>FfQec&j5=-z$kFMbr-eH1JHGqw9?uJ|zwT_P?3iYmt@(@XC3<#s~g>fGA(z`)6>Va*&)x5=H}9@ftLBWha7zMXFYg33HeCfb^0^S)B2-eRf!GwvRnAbhYXYdqO*tpN!9zli{901rqT z2!J2~US|EQPO3Z*1?>yBjfF$YyexC>~K2wRUF{xFdz#O56^n5f^o@vK4PERErcU zsYNSZnJrfvCcE5_Ytt??P~@^k>G3CFqS3RGWhKx8(Rol_z>Ri5MC%DcpZ#P-Zn=i~ zz*rO(<+}8H4VEM?{Mh3-<_PpQ+r|L3JB8YJtg_q;0R3Q*^Ssu$P9ARUWe~-Hoc!zC z)075|yZWG29m9G5XTUM_$d9~4W={X?X{HolkSu!hs=?#nrD&s*fC zVUyr};2Iw0VO!~-B!vZb25%C0kPWEkgMFI!)Y*UXFs_Rj<>iK~Ah)El(qgeHC08-M`lUq9PH zVf0m%RX+{e|~g-DdoBB)=#uvl`o|lF6o>_SuOJw0``RDO`*CPA%CM{bDT9! zRm;9QUM-aQz`9nHgqciJ(&r$oUdkVTC5_5rMi=)&f-?0D8h+C3uw;A^6o^wY0qhmb6rrynoW><$*>^<8iY1~$Z!Njc<*mEs}Cw)cpv z>Y|^ri!hddAM`|S2T6U;J%I9F6xvDZZm^~Kh)oYuZ?`bB(;;{N>^#DP{^N22tEX{_ zdtwwWBicrzh`Ilv__uIo;O$JdTSnZzfY6%+tQy!snc&Tgz&y6* z&1$ZQ&0Rs#p{?g}tH@1kPxb({kZrN0YU^yv^9n$r<=@%EuLSTXt+P{N|EKGiY(^7)3lG`8_5{{11As(QLw7wqwqp0+&{f8zNRLH&K7 zZQ_AkK%^W8&*IyDZgzJv5n9e5TnB3c@FS@^={p|tES5Hi=)Ni2=fod3V-#IYP7-6- zK?lsQiN?|-h3j|9l6htHRy>WVQF)e;NM;P|-_S4HG>fqJ+A%`PG0Oy-0Rp?*b{$=G z6R56=LLDDzp^Wckf@ak@Y)ppmsYZu5y)Gk-u<1#h>4teTE~Bj2O(6@T!vgK~k+wdC zl!sQsLi3j~hE;up^jF~m4png7D!PuOG$?`gP`CiRAib#d?dLIW7XH&|Y@9JF>G_aw zIw><1!ZjK>fq8BNw>T=>SB7cW;Y`;3V=7vgCi|B|Tjy_$!!&4WryzCR%Oyw-o`64I73+;~#E<-E-X zn3qb*lBuj;E?EClE|Y;Z%-Re5NNe&sTBj49iy56RPE>ahmS80Ry!BWU%ltJJfWVX3_-v#%aYx z%(PEwAvl`0R0cpxxV)$zZj>wjr9|{NnuO}QC)y}hKDH*ijO6V|F{`ydYB#-0_B2hl zP{C?hs+qk(e9E>_UW*WK@nf%?J7IH-Fkk80TjHjFZ)e6;v3kWVP-p9Vn$eDtQj&91 zo{EStVr11Gby=oKBvLXjzghvkN@)z{*j2q**X&0AOL|p}Luc_zucuSkt#(lVEKs^5 zW$u8#nULQO4y}~hoeyvAiE#$weZypXs_pfvbvqI+@9T3t!bRN(b9F>n!z|} z4KrOnO(1E904t^ABj5aJ4sT<3t9duBBzxX3&}FW0W@$^YxuF=+Q$?Hav!Y;l6G+l@ zR-OOF+I{=yynFbqFNL3P*|!3kdmW;GmO&_;9|Iw+I#f*Kp;SLVU3;~(H=0*?phxN7 zSG;Yf>vp1jlMxS7O6!Fv^QdcMk3%-L4Gm z?c%_ZurX#f=V7|e?-)ud5j*A}a}nF8~<% z+>n__ z)(dN(BrT3L4G>$KH%^0L2Mq9+qA0sABFBH)ky0e+C&{5l@ICGFxCjltoThuJ@wCU5 zFh8){hY8SqLt|0bCq=*mY$N7$O!V={H`d5;fc!95&wI35S%zDA(P>_r`FyIpe0LI=4*pVp0K+D@f#nFA! zy7tdXm;R5PrkcXig4|s~7(GD|>8RL8V7xi@=Q7KmLkygk9?_(knGS+H>H9U7nES#b zQU0HgN3h)!^OtU14(w5LRTs)M`L3ALpT4txn_STRa%-Pc@4Xx4Eq?ORT1V_~Y9I3{ z0rKhdpk>MB`^YEV+U;8x2}|T{P@Av(>wka7aFL)-{@+V%6Gxnc{m&M@J@S3^AFr2a zeo96jptzE$&6S8WYbkMSD7GZ|mswh_JgZ#8KDVjfq-FuO*M2DSEI&d`wsgD-OpPL) zebf2;+V~arwN4Vcso%StSacjFdF19I6a?|`!6g02B5(Sy#d2;bs8L47pH#6#D+Jp- zXg)QhrzON{E(CuykQ3=4`;{>K;ts}i4)S*bB2_wz(-=$W+B^YNbKJg_}}~36~eez@MzBX*t>hq zQRe9JBa_p6!|!EY!$Q>fZGJFo<30H(5(V!A(uk|Hi0jsfS<5i1Bk$iuVR6oJJCL}g z`#9A7I7^S1Ipk>kv3xwsT7>#t%J{`4;F-p1hwCFy)f619#M{GcvSo*;ygBFvKV0VDY{Q!>_3@@!ekSD|R$ zhj`M_H0DSR^Hhx2iRNSP!d4Tct>b)1Kk<;Id3Xk*kR^GArTs2TQ}awB#z^&m zq+c?pGbyCsFpC5|Xj}eF%xnu%eMn~}%m{s-rsSDclAb20oo*JMVlkEh9ZK^1oWcA$ zvnV}DvOJ__ETr8!sWUt&v@EHGEGtqd%M>G{Q6X)#O{29I;Wz0S zGb|Yo*6$XqKm2`&M6%>mv>BirzXOl!O|GS+kR_iBCA*}j9Fe6QD`eezrW28;W_*a- zUQ6F;%K@zCus!62tY!Cm=6y@c`_-6tx0I)MlQ;0A;GakK(91Mnd&ZnX-k*4f+{YP=Q3{296ej|Oil3fC=*?mlEH=oKp2G`C+&f^QKx7S!)x|T0pUzn&&Bq9FuQWgVLhl%N=g|bTm+QEiNl9%KG8fgGg>Of<` zuxRV>)bZ@%wF2YgTuC^DoEyr*jgCknX5C004!(Xp zv3EUbW<8`5i+rP=`cFM{qMk;ifuXXVPQQUUvjJxVi*=)cgbhF(i8Hd(fRl;mh?J}a z^`UH7K%=>Vi8N4kbyO4{khc@GWEP+v*QhQDS)XlG{nMyU(ezHFNlU*;wGwO2s7bG* z$zY@D<3?liMU#n0vzdOAv3|2vX7eZSW}A&>2eu}=Kg}*1&C|13u53+rMi6RlDCb25 znCFZ6OX%~S1SADyO|5ZIi1=y~F>;jpaVehP84FXAs*Ag=SV{{Nhe0SwjuMZ7(@UGN z1E36Sg*~Rc$VgvgEm&48P*o&U=LVVOfh1|5w%nj+UIdpLBwyEI_!1zv12WwKiYT=Y z{mk#S&QJ5oq0h)+e1tviplceT>)>O;cVZo!x>hzYK*qSvlHeetXaS@~IYn!$PkLmG zzD|HOCy`L_7u3q|ji~QR$p&IeJb)vq>+(6j1= zu*-vKLol#~jxz%O>Bo>LCS>TPq8hM$Bn`%X4|i z_7qpPzKV(mY^GjU4(PTiytxn5pX`1f+k6okqVpVhpPr~YnR0j1UxwPfTUk7Ok~5mw zp5ER`Zqq}c*GcHrNy9oa-qAj}(auzn=kH~%NnUF0RfwNeXop?qj zjYMNiHj~F9^W6-30w(icwinNq7vS0rKBbS!v=`2KMapc}RQ#!tkE(_%m%JS>F38Hl zGZ?R>tgSyS{Yp9RY%o~uGw7c+n8QBW#hw?tX%;VPmY8LcjGd6$nfl(YTjwcNNu!vDm`i-(`Pu#YlJFe#Hn+nS9HYBU?h7pEB9%b<#D14d!|No zvd&<#0egJZVB*npLfU3rSJBU5a{BIc`eAeA5BtoZ^2{*ytT^keq~fe{#sopK-suZ^j!W96*2b*;{9tvYAVmQ;>RY|WbfoyEi5LU;Iv;kQcUuuk&aJzTwo^xdn@ z-mC4}tIyv3Y8Xk$IaK8W)`d2H?Ze~ofwg;^ynyi%>G(pzhziF^%vd$V0^ zk6d-*HExgWbgTIJlw{2C?$e}a`i~!((a+1ppONE6=V``Mo3!U^M|LBhg}uIb18Feq_AvF4^E+a@CscJv%wfnNrhCPJ zt=0&Kn^b|fm08vAySl?Jj`)v2-1S$Nn9N2%+&Hj;6b3I8NS;Uhl9zU{W7?;C){k>D z;C!dpVe^#+sx%Ftng+-u2+giTw}+nC*}aObnKBWdGW)lmLj9c`h=;kuUa^jfEUdP{ z$9RAaR9*h;kU8{sIHcP?fvUo!UbUM!p={Kg!sgoMryE&IPgmvl+X>#*B8!Z zy(m#LD4NfH4-G1F97qZ3D#f)9tJ(44I(`?ktL3*J&2T>KwvqMgE+_V!q2>^h^T6Ew zz$$)Rig)ky?}zS-VZGQf6Z>-q&Oe^2N1nC&)YJP0JwHB5oJGe>O{sow;hIWRok|w( zUF=@8=B&>D_n1Air|@gcxJI#C~1u-`tt)n;+X-c;6$8s&N!)6Fjp=;5vY|qs{}mm<7}et$!~a#SIsMQm zQBfH$8e1qIDHkZ_CDco{UXIae;^lu_GJ6-IG?XKTb;IzX5!}{XeDr=-zm@Z+O_IK# zonfaZM#c{c-O}}XzqxIqs@V(4!SL4tIj#4nA4hQ4SWyi=@X7bnbFCn%J~RZ(X7aRC z{!MQ9nVrD*HH503Z+!7RQb~l`SLBQI7PhU9VV8dIVPGxd#S0+{hRfzIlta0Hq)i7q z9qD-d)P}8BH9gtFhggQ*vKJ!du`kXu7`?u4zWykoPhI12TWX#20`HUL?PKPa#ys`l0E{Ta!Te|8cKD=bl7>;@oYK4E2p{M9l~m5d9dsPk5YDjqlC)C zUL)^oiNA{PCNTe6FP11)|I+Fre~+oItxuKI%>R1)tK1 zx@mqnseNr!!q(?r1vlUiktDmIHRPabX!(FuPg!(Af z#dzk7BYa!d!YjH4H@?35caKOQv3p3(h&}VnE2wq$a>F0rdV7kpK3KjNc2MfKkI z>9|_$$ftYWQNrqWMbX9VGSV`;=@dOD`zq)!h#PeqP#B=Q17BQPmnU+&oWELWbZDgo=B=Ab? zxn1`63RXGMz&ZnhosZo>C2ll_YWOAMBuE>pm{BHRXhsyVF+X1vC_^Eq&RI3u3mFoU z<4u{1vP>EyTWXaPXx50Ha5AO*AvD6BWn7>lm?}ZKq^HelA2)` z9WNcqO*|iuuCPzfSU#eloe=HaXvQ=Wrl9g=9v*OQ#*CDbhoA+K_CwIP%j)qYIC*Wu z2Tj=L7G&zHX8DRl2%r>9oqqu~FNSC!!hy!vK4w!iw8sT>^=ZoFx1lK@uL4QCHGUR? z=m<(ATNu~92GsL@k6hte6(f~J)p_|aoj$@Mlh7<}Nm9M98&TYP(mZH>n;fy|^3cH~NmQnK=-{r!FGcED%dV7ez`w9tFm{OTu*e zlK0a~%JaTqZwcV1_|f55gVi^*XMo`+X1X9+9}p(}DwEW3T`(!OG0ojhFOg_p5LE!b z*0|CkKZ}k^E6YVTxDTBx!aCmhx!|Hm@;QR)gohz2O{;lPE(ys8!Uy*NHBJ`tLHzGd zc3c$O7j>ngo1xwp{l%enXu|wgq4?OrXg2pYy5I{$0j3#Bg#3xd*VIK6o4RaD9~-3f zF>CCbt00os*$@f?Zs-dG+By{LetfidAQ5IWLiANho7dcEmW|6zwa-L=xyXM+KvSbo z$o~)l%PrNuLyia$gS};e)*)F37k_Vq9|9|F4belc#cW%jRtuU(M!~OAfcjSarX+K# z9HLiFf$&Wu>|7$q|L_JTw9mYOk6QeERu)VRu#_uFbs}EcKSTSNhsJZUE9rYQK=Ln7 zo`DX42lv^*J0j|(9DUZ&nDb!a(fIl#-JL>Tf>rJQewaCPGPn*G+xL6pF|jAenM1mk2{@#J|-Icy2ZimfVg5 z!Rvq^oe%&qYC$N($p|Hd+a|=@uKtBT$LKqhdZMOPTvO-($@c81n89vLMA`t+Lt38R zSD}M=XI%|TT>XrnBrq`v)d7kt*Al>43vH>xteYnLBWcHUz9{h*DxXFfnz;!1-w5b( zFV~yL-Vz_t=i83gXmlRon2KiYj1qYR<+~<<+IK6o*t4uD1{%P{q*(f>Rl7oP1KM2s zI)j96eH!eItuYqripBcpS}GK~j|3a5BdP+isfM=ha^Kh551Ojxq|Yq$|E$wVHMh?7 z+vy8_-%yTdZXc39|H3u6d3Y`lmYGc;9n9m!k?iw$0aLPrP(H}V;XFf>-@5pMjH31&qD?j9~$1W`GYIebJASgHDhJ- zKybu!`g6By&fVsr1iIHOLY&ARwI8=$J&g6S7d=8;m6M<oUDqMWt_Uyzvz%ekO5Hv#}EJ6nhORDr`E?xoFWHVBd*?k<+=-AIj=_;LEX;vUetPGAWt_W3OmIMJvJC`@kdo>^c2rnsI zZD$umL`Vw~Tvlafa(Y}Oks-)YYh8HxNwtI-*$QEGk~#vrpx|S}!4#4wt$E#v+y*ol z#J@7eNZEDeDF<_*Pz1P5{> z;Bjyk^=>?Zd{d+6>J2cs6@h3)hmH!Q55T#gVan=&5TRhFLTb|nl1~(2Sfj0ikmkTJ ziQPnM-76Yk7(iY!j6V+^$P8kJLf(@CUb#lCz##NmVQBpPkFI1CgaKBh04*qlnOOkw z+)}LG4Y|&fyaJY&@q4WVjXOCin z`BL&m41v`l1AZY7ngDeuM24m^m`0{rbLct@4WNz)f&}9+LrCSHA4CT+i+w+mdk+nB zS{!6`W9BuB&>#)y(+mQ#Lv)UwNla2Pw>*BUp`c4UUloY1@w7^y%r(_sq zn7Chn5-=c$aFt1z8-CdejlA*}op7X77-l-0WXp@c$h-mM7x1_XYXc&EsO znHLz<3gKUeK+R*e@9l<<0$Z}$^vePm?m_74B0y50Ah!Zw2guN?(l$ZNdDZ(vBtpq5 z;D+4;gkb~*a-#!UQGv5)3`anK5Qv9R%)%v4-YS5@2!zS4Sn%}5_6R@=LBRk7U*@Tv zJYV9^s{WPZ#DT{6WX5eHo)ab9P!JyA)w4ZWT>*#msxXArhr)%MHFr3{7iCu-zAy3A@It4Gj+U3dWC|04Av%%ImF${d^s1}Wjh6qAL$!AOQ!n03A|v}D zb}>Ut0_&DMDMYmro z72SStTcCvl|Ifa>_yB*Jj~6>|1mBy{aC=)b1ML>$iSC!$oa8?F7EMErs*@boxsiOJ z^XS>c3yjzm8oDlv98ufpa~w|!Bx?31pUFj1;;mfn+E0sH)G0?sE`klfdr&zx88Y@$ z+{@Kyd0X$G(>;CX!XBI5Yg>2rT>y3-{WMC!=`v-nVyp%QvXK3C#ti0MhR(X zTQkNUT)X^8F=*d6OI1Hu*bTKAG@9i}z1W45ZD3qufO06^6j9U{F~D?t-^&kkd~Sap z<_4TwE9C_f+Z^SGJ(5jvg$o=X6(Vpke-b#q#e6+-J9g^1P`>PBTuT`(EIE6vyWh!75LNH7kC5nC70y2BDZt1i^7r zx7)99Zob2`a~uw;T2$Rd!x19N!^9GD?bRhg?5}>n_0J!FAtDX`3>mSBKU%6Eaz31w z-*pRL%$nlVv=}I4-Rrh|Did9w?Q zb9vidaNhNMXXKYe&~GfvN2gNpZ}n=@=O^1pV$v+Ym07?#+s<#?`%2X2SU9O&UcCjV z4`X*m`!Q(dE+?grU|r7ka3Tktakb}(B~FaKC>O(09!9ua6omb_gOG;2`4=A-A~~ri zgEU)(QueI$Vu1eSORsNd4K}0vIh>3@9?7J3$XsWU*lc2(Qi(7+GF26dh?8E50_AB;MWpygG zmhru)tK?P#MRwoB@vB8%p_a*FZq2mektXNRo@*8E&@tuI(|3YhNoKsCzdk2HetSGA zY_oqB9R1sMnX&Vv!n5E$$?!!pxEi}uSnx`DLxxW%ztLQHML{jRF_G`rwTdYGHFC!5 zQPXsv!RU3R$27Iy?_5ZtZfkr@-EBET7!7KCkhT%(Jt(v%1i&>QV=$9~s z7a6q80GKbV0;K{j zf|y#3Q0k%b_;MG)m{ssR`1?YADN^kr52AV_jw=3Kf)%t^k}!~!EGSTs0EYDWLWtFh z08sM)ojc#ZS@igb0X2A;2st8PLvK)W)x?h#K|Q z3M~$%m36A`HNRS1J}6S^a>r5H_0hOGNr7ve;+dhwG;~J;QXd%#$>7!spB`%iBHfCB z6lwB6@w&jz{Ka4qp|>Br>VoZ)b}&wuUpN`nN_ymhgIc8tY|;W4PyvWPm}aP7c}KHO z-Cn*Ev(e&=aV{Wc+$X2U92S_a&*d!Mr@kxK6vu7Iabh=<*cyORk;-Fj$Hg&iu3*0; z7)7OqZ+n5=8%GJb*zmkJ7XwL(qKFi^2)QwVo6^8CXaL_w<2Win7!rov8_q~$6wNxI z*cdT&mC846{w-}K;LELpO34MBD=QBI`Y-@#zzSrt%76Zj#{!;LbX-n5SmWRtqdVpI z91~w>+8=(SqEP7-VoPKBT!gXU(#FZBNnyE%k%*q>A!Gnw#C4{BSAVuw-^-C*jl4CD~EjC+!u`QIY6>)5+GI?F8D>kKO=PI{R zWX@3!R(Y#>;<{$ZQKq%7PGV-4tv>me}0g>sGWTI=C|@j*3mpdH{ zOR8Hu;<>M9f%dnh=-^+xQa)XIM|a^AUw>u)>#$ad(MwvPr1uQ{0+&pn;B4?cK_~Ip z4e~o{pJi-J-Fui`F+BH17JSdNc`QcF`5E-$<|s0TAk2C0&O-vi#v5?IM}fQ_ zRqJj{$$vT!K|ajtbgLDp{XN$Ic0bwEecOWcDRM&o*?IeflZLzONeA&^ zN(-!a4=iZ$e|EenMq!+*9+oXGL%eXMd{+}G7eiT3!;%0!!Co5Q3v`tw@P%j^28W!tPcAedL1;`Q2S1UZ0W72&^=Cu_Yo*KBW9*Xa-@JtOq<^ z9+9Z){}C7}5EdR^6fVaTrrj4Z#25mw40neF=tCkKP$TGd!bF_I9Mi(&NrDAmMs^N{ zW2|sitvc1*2NrpRbVF2nk3xNQ5shWe?YaSDq%tMUgk_`l%~r71d*Xso$EdXMg)p@V z-4Ks3=cKgAAxN-=hx`&L;Yyj(nl5akm3Rwc@l7{k_j$DL5&q@q%i(DBoDjmF^zGRw z?3Wc`#Xa%wdt2aII10vFa2pJrg%HEqf8gHrCuwM>6=CTGn(vN27>M`0;rD}b!FfpI zb%Wl825#R+iMhvP+*5-TLPahixOJ%9$T-leH&6j5kOCBiD9+*;KYs~D;Q@eI%EOjh zV{4DX(T@^zSK?HT{H1{?b|5^uUUaaA7RU%i{&mtO0?x|f&u$&7ZcT(WX7_F^D#i+S zOPi$m%zMzH0(g@wXdu!b0u_J8C|gJUwfc;dkF`~Zc@V-krGwH2LbGQ9*)&jgCltY6 z09ErRZaVrnBV*xr#%ZsOz|HAcCFwaBOgO|DXvD@v)<$_h(@pkh!_iRsM}YR+P{uio z=bu(C(l5WbKx7YI$~0&4%9(bTn|6_974@4AelV5%lJ!a;tIwJhP{*eOMWsG?UIsxM z3R2t9!uyzcxx>B5UPn-n5wakA&7Pb6AVIjPc&!w=D$G3*TSR^my zVRzv~f~=Z%VNrTQk-rs+UfDbs1w@nCq`Y2#E20Mzdz6$AhN;*Py=m8!9gjhHzVj`Q zfsF@|RHUdy6z+z{zI}{T!i+U1cii$s@cxYB|5=UM@ zF>9geqqTPgfj)TvHxd%#eyobX%;BqW3m+$bSWCk5l+#p%y{~XrSPw~NC5Tk?hbzVf zWoX7%Mrgk|EK9e6dn(3Pvl94Xx~Cqe{$VLDZPzNtEUs)1Y-z`@6?TZO zDES(p*cVZfs94gZ2OH6gG^{A>$#_47SvElKI#hwb(C)f)Tp7z6GiOumc|&;lFK4 z?iBMUGGsG_VcG3rK&+x0%sBt?;xU^d{D~5r$ST^%8i(g;ab+%cS?$?l7}BOJ;XaA} zr08X3oxOGG3uI&|k5b*?F;SbBR|jj!O1mWNgn-EV%~m_Um~ElNNyEP4n>QN-vPy80 z$YL_KGzzv_>*IR#O2^lK5N{)i-$&;2ozzPGkx=U(T^p}Aj7%{;sbj>dp|bs|-;uC! zT*Wa_AyQea#8%F-5vg*bVIA3oaT2SUNq}`Hbs&bm?>i`@|g0B-_FWHLlPCI

    +NoRo`yXA;7)H6<;va2=s&i(RP0~b*}H#kcq1h- z9A+WlJ?xMRv`7F)Z69954qAGh)Oo1ihP$7Z&(N%(uWskiwB?Y&)6meNuaW4m#|ojD z&+tU(@bpVGl37%00GM|dz!Qi1;sW&QH{M$SNLd{?M&~nFIy`nb6wo=OCp!9xeKbUQ z$OM@+s%tkK)j1S4IXXQHNQdfU>|lcHF%9r>U{2gcd4T3Reb5Chu}?2SdM{Vjz}vY2 zuakZ!{R)=<0!=crV7ASI{|z+Z=NlS_H?UQH>8flV=!}rq97j&H;44E<7&*?Dn0~|1 zDb+1+895$g)Bnn1l>TJgm`sQ>|iq%zMj@M$vEg_+>1&l9R|(!8_!M>MREg^ zq4>|?r1?OTmNAp|@~p}7tPD^V;LHRmI-6vYg@(gAmOh*JZdUe-nF143$pYFbYYvh^ z(_jJ+8qF26=d(;kl|?sZe0D$r4X_F+0L`2QsK#U9 zs#^+B&TB=C*BVS->&^FPPL6j>qT+*TplHm!te`xr!czc!K%V?gflx2Vcot}IQNV1F zPs0%Z6u+rSz$ zKkIT;O7X1joyZI}=4dmWYOkv*m+uNEo5ZJhN(et|i;V7gNfkL4Ssg#6x<3K+<*0t4 zJegnFooTNvsj}>CA6BJ2pIc3t&QTxh`}_`AMW}R$urJHuw9}r}j7&7OP%UC9SG85I zcHs1t+BbjgO3LO?o#LRZuC7d->Vn&^11DQ6&kBdS#*^*4N02!E6Msc4BMCH4S~sRv z<_s6N>>KOPWcL3OHASz@aNy^w!2GKRmd;kkRJwj|3Dss(pKz=%;H*a5%l+aY_)*<< zIJFLR_*Tf#+GStYqtY@kwedow9E)@3o60(VO~=Ff(xYIa_*Ci7>J6Nlod^4!-RR!G z_G-v%=nY35o9Lc4Bncl;G@;a_G^I8TiEc&5(2cy($4;&B_g1 zjT&x;?ew-L?!K|Z8U^ky+qN(|H30_hce0vj&+{!)P9k$8=b`0vm3udT5N9mne8tgW z)puIhe;OaIdJsE(khx8uU>K=!a8QkMJhttAs#O2vZmxFhF&F)l9UwF;Qx9K0hVtzbK zZ>_1)Zq%%|ajxFQ9PCc-%Epv^bvXA{-5-g0UE57@rn>VdX8ZSf1=3-oxcb||^xBV@ zJ*rrO^7Ef0wFf}Qtq$A<*v#>gIF#10mHyW`S?%5lGA9JT_7~W3@^6kI7uO|E?GKch zqZhS5*|?w_wHHLc)~Z#ban$Nx;hnMgM_!)q9M)X@JU>=aYgCCnS5rHB>sTe?_c4>DRRw7eO2VD8B<@uS-M$LLibra!II+b<(G`1!~`0Gq%TGw!4b$ zdp+bmEfB?YmVHGT+Ea(!F!|79cmL#dQCNG=Pkv3AfBUiKk>WB1!~e37vVeonmBo)!6xz>G7&@^ z9|zMkOl9>c#Qadn-Z98ocFE<)q+gl7P3ABxSTsNTp`1ZpUtg8Z_fj>R^Or2jtPM>H z4HgC+ft6ccn3!U=ID-8B@uImJ@^5Cw`xEUNlwISXi2uqW3@hb`^tI3Q3YW1JRVK90 zb^WFrhqE(NkC!XGiVFhh172Xh2Ay~9x$~E6=wUNGAgZpb=DXuL-u@-Oy|O4xtad@; z=snZw%)eRgvK4NyY%S(`{-*p0MYjbZ#ew&X0YnMp*l|AiaSCWDtduSc+8n8``o_mN zEdQNuUbz(36xUMW+UKiKX7n+Cqe&}fmx2W4YfhxWj=P?1WO^q{5U)W)wQ3a?|Obf09=MYfit$q zJ;68O_D+T3EK9RVur11UO7g@GhEyZFX`JX_|7*slj)FebpiY5D@HcpX+!tnO}r}rJK21I|bNY;rI^9()|H4w_Kew6bXu3a`C2uIZ2fKZO3`HavxT>ArjrhM1OOrPvTITwwddP^g zZ$b8DYS$-uJkKCD`Ay4Ic)IW1Xyg?C{W8BX_-s35pLgw*w&HY~Wv)M(@KI$7e!Ep+ zteoCaZGuI+b*V4YqjhCOLOxz z3m)SIJKVPOM3qR7k>uCf9a|19H%X3-=ML4I5@)X-oCf?Sy@$JEu~&b<4Z&GDeFJnp zPVM-DqL!mGO#Jrazz}b_7A)MS-;RaZgx89)sqXga;D3MQqjlbAe_Teldm0+C%rU%L z-;MsDzw`Nyy0q&W=D2cm^&?TO#+}&T(!h&Yt=7jQ*n0S%@R{0ozo#9J z9MLZuk&bQhR}=2%PxuR|{(qY{-2eSujQvIWx7oA@Z}*pMylL+J7nv@z4~}*q{%o&A^(G*HfC!?~UiMAJ-j z)hG_swQl~ncl6w6rCh}OFw{R~u!j@xG0sK3i&4nGhm%$JaV;fGS^1ndeW?@5_uGAZ zDyq-ME)qB~Z zt}tDdcXLsA5FjgBfSgt@73N=9Q;>B z*U9z%QzJ-<0%0h%Rel93TpAz38(6|TM2HKA(0UaR;bT6%NhXZ0v zZUn#!ZU{7@7egg;a3Y7|0Im9g-@#1XS~iR6{jk`GB+eHLCyTR^#;9h`eIaNKA^6y4 z`0_Mx^tg*q_+~HI^di7Kx#MHeG)ciPvtJ}H)+Nwki5yQC1B9nevG8CManO;B&!%KJ zJdGY#i&RE9H8bmA{J0Gz;{2MaYNW*EJbj>(ah)zo?(QS=Fnz*Lx}To=4KfRo9A9P` z5|Nmn$kbZ8-Y{JSxlp!K!5YTJwU0Nvs%Y9|(>dg*p$TnICdjANR6aQ~MCqwHOC)|i zP7M#j)6*OsoIav%!G~b?=}CS!mz}iP5O`{5Zh5fA?#*eGI}oN4(oZ&OW#N{!VrM0$ zmZ2RXP?kk|dc-I4VH8o~R=gFZB&_*$5tsLCu$Zr(O=w zuktIs?Fr2{qBgW$GY%)M-|uI%Uo*OErB%PMbktm(ZTftl$C1rBqQ8AW%+T&iWsP)1 zzD^mou&(?|#iSdmzO1l)_oc{QA^6YQFcz2lfcO0c&o_$Uhv||LbSwL)84A%G?VQm< zoGUTjw)L@LAt~i*S8kg>%1#e$$xG2bfP=c%1FCr7E8tPSy{3(S;bMsJ|3& zz22LaYA+x9c-30#a-LfwGW~3I_lfBIH2u}Vj}&(c!uoeUHrBCwIq6>Mo^W#8-8txr z>rjV6z3un{vi70V!&z{<`2VnV=HF1i@xy-4K4TsG&e)eML$<7A-x>Q-7$UMYB&o!V zeK%xl6C#pAi&SJ}U(yJLk2H3XElZTl*Y}*~Ip_J|`4jGQ-sjx+{l2f)b*1>;Xz?{T zOvyU_TIJg|)s%fb^NGQa`rohD>>gf;H)PD5apF_|Z}i)mk8JMrTXxn>L*$i@qw%ZF zU*DOU#e@;W#ncBrm2KXF90f8Z(DmD$wu{1V4igemhT7SFBe)MeAN;y7_FZE8yYK5ZsX+vI z008&hO7X{~UMPnXgVSzm8{K&$fYkf&;;gYks1Z8ONYIIz^q2ZCEAwhO+@EIbADkMB zL0oG@B+&Tc$`Mz#QZLHE{gJ8u2dRuB-)6`i`Kcd9!&_0Z=vce}vv?kl$FyB?hu^yTAGMkT= zb`XTpgXG|sw0qoy({EDJB1_=`coU1{F3zq3OA<+fK;|W-ah-#6P(b1o5}qH4)+Y0( zgX91UP%F#MI|+Oto0HyKh96WfZY%Xdi-jKs?zd&+Z`nzp8T(nLhQ=Z!g-eKqWGs~l zjcH85C-GXc$erLG*~!EzquA&VJ^`&!distF+0k*$ojc6o{3K_7WW5@bAU26iNk&>) zYT}^ocvbk070=kqmxBXSYpoBYsE@T_06LAlBL5IgHsDWp1%O6NkRXK&1CnZRDM*i` zcjuCf3g0-adcQ&OP*Ib+AKy=p|=;r;F`N zev5vpM?o>Z*Qehgrk3+(R(c@$J(9?MP&l3my;3h?1tLbhQ@jZI$YisHMnL(sBxXVS zE5jnH&<9iRxNej3KeV-KlePKNxslm78dJJxU}64rl@`#$Mi?AjCwAN3L61X|YR{Oa zth0O)nI-GV(f9;D?M_p6)UDf*$w&Yqz5@Jun=_pbWAaE;A_Bw#s1OaTv;_zgJNbTm zT8-ue+O(C$X`gfpAa;0OPueeG4n!dB4JBCt1M%ih_l-^3N0ZzDh$2oFl%A^FlBkGD z=G1UpUFcVI9Qiq&%j@kZOLpY@moJbrB539yn4^Wz2GtPya3ByfDN_~3#g73Pk8z`l z6#xfel%HO}Nf~$?JSu4f@X<1LVfr8n#FUsB!BU9B(Q43RnkeO3e6nU!68Ei4vyYr6 zeUBe&k4am(Sf`8`jE~tZj@j>xIl#v8JmZei<4zjm&Sv8-uH&wO<8D{RYtRUzMo7-8 zg4sdJdt6GyPxHuwcIIo)Gb_n8jVb21l&Cid(^80Q3+H`x*0U`TTsh_{7OI10S{fU_ z7vM%CK?&7^XDpLxM``EpLtOYvP?28@Ygwx)ZaM^5VqbEow^e$wt7o-qb>H|jCjC4; zNnacOuK$bS=Tt5tSv(!E!)GFiByempaW;{e(8u2ho4-qu-Xbxi%1Kmgrm!UdpGYM3 zBLua{lIegsUiey3rXvNwP{tBlM=lXrZqLsTN|j3V5uwPekfdq>Ej*KHI!RKF zEJQSquLW_TCv9DYQQ|2m04#_mpT}n2Ad@=eon!iYa%2{^CQm!K)BvL z<_w^ohooK(dMF1@;|5OXyhaj81qXEnZqI8lY0{iKaL-bRFo5C((gw>Nq{-mGLO)xHkLS`QV-tskfuI9~01a#^_hl3N{Y{?_dfunzgz=#()*nDP8fSRFi1QL0 z*1;s@z}(hU$F?_Kt*7}8Hp67B$a zcmnkCr{BPk91qfjV#zbX;O8TL%>+>PM>?xprT{PLZ#R=Q5zx%{@XJi*KrcFqf-0yd zoDv)$rgUx37^3XLa3DpGsWmjhNp$g$lvsa#UT;fSju#LHa>;norE}+hU?FEk$%0rX z0RIIi8n8qnt7|WqYG#vz(>J^Qw~XyU+GHIMq;)WmNJ|tsKy>}P1;?lwd|_8|vj*`e zvjtnvd^`adlZo9YK3b9)|J^WN61N-+$Z|16gUNOSUtfCOp~urDD%GB_lDd(+PbFg; zIT%iIq#J}l@nOEdw!zWSE2+b*r}0bVT2hLgu&+H>!v_wOyGl1_d#tS3^QVvrKo%!S z6Yxt!CMxi!yC2w!XOL?Ge$ccB$u!`m3=;T~O7;ND9Hdn@bA)2;uY6%gS}tpO5E3zo z^69?QEhU2Jq$mxvaH$Qbe1+7yunZ&PsF^crC6@c;r-4}w5Bhn_RgI2d$|PAD8S;ac zybW%GH!_D}`F&>~9N2V20JJa>I^F`R<0J_;D#o|K*piaCEm=;0!9TB3nK9Vc#aZ?Q z;N1ZfPVwqcMzW!k6Sn}|37!g&;||hrTTg8lf*w0zMJa)x(lAgdgu!K*t&0IQb--Ea zNq@Y?itVIJYG~tbINhHT6itwlF;lOO#ASqIE0v5qRC#%+ybmbsG?nT3g<(`b+aKT@voEGRvR36mtu4~jiNT;(T=V3L?hAvdR2 z)=HD%v_zRw;0ZL7&<$q?z^bLdvq~6W%N8e&ykEXOpUbk=6R|FepF z^5tMeZBWyX+o4%0*jn%%wty5giDH0OeS9-nr4+2WlA`heeK|HszI2OR3VoOhTxYPH~_D`^JQ#8WiL3z;kNY&)v5={W3VL(9t)CPyc# z*|6WQ$4KP=3n_vCU2xX_M^{y0>_h-i2Nok0-C6vnL#F$h9`@#8OfrS7o>%qXl5=MJ z>9R1~m8l>UA}QX%ZC0v!Su^hQ!lL1Q7)bohf^z_uoEcfcd*G$K)!91|IRjTmCGSeq z`8-+xm7f9-5@oG#51lK-0h}G4i5Gv2p{N4 z_oicY6ls*Z=e_11b)9Mn8CLKPr}7Xtjooo~^{1|N9!RumNw$JX#I8q++2=Cm)cbi% zv-#z@fl{o(u93C!=R&uEH0p!d0+ktE$8u%QtAO6m^}l~E5f=C_El`zlEPzIJAi%)z zoOxq)dE`x6mtHw_qAm?!0f4tUy-dh4*>f_-)Eq^EdcGidYa+-oY;gom5>|QR1O~JY zE{K|>>s5YFMv+x_oIuqugqGKTs8l5njr_3)uZOt10TLvQ_|gu9 zrj}i0k6@eUBRk2Y&wjOmCD9T%m8;nuz4z^8)HA^rET3l$oAF>AyrheW$sEz z2lGdTS&zsHn~US>t3E6YOUnc3zPGpW$pg~ETU;4}LDOT_n2Yy}(lv;aQT?aD*`HGd zGCj`n8WxR-n+s>6Z59F8Wz<1^@yz>o5}R*cMrlBR!2UO49hfIZ)02qtU>Zh8xekREH`7AXivYG=qc5T-3fyj>nCq8=I&SEz zE68s8#T=9w??hfyx*KK7>cc~WdtOp37X(>S{&4}q=+Ex%JbK2(vNpkvUIt1ow5+-q zN2tXzn2zJ{y&X(_2P7Qb{KWO~iUy8jZdwWj;7TJ&i=juO%*#GXswqGmCQDeN{0?X7 z;E6jPB*INNqj>NLYtWR6HvP&2#&*OoEbZLkAJRXzg5zN2>F9;-GlPy@u;)+iL0OD= zwE!yflX(&5DYGo095xWI5CrI>^31H`gj|ifQ4AL@kUm8^>PEWJBG3pYhhgI?Mj${c zr4VstPHYJU)j^glCyyjnl%%9Z6T(xyl+n6{wo&{sJ0Fank$y`Oj9{@dqD%1@J zI)S#OM1%P=7fkf9eKHcM{IE=0Fe;dXYVti;;IiBYC{UW@!YBTrxQM`3Pz#xNqNbQ- zS8{scNnra(F1{!NIHD0MZVCW$(^5zP4VL!kK{ivx3*fSaQOpi^GG-h z4RB~>+=H8<5mwV69+oz$2@i+kyU(!?v&{GCR>Ef|#roKl|uZXBb zBqJS?qvF>Yu|i<7l*@7!GkL^1{k9j0X1x>Nu>a_6pW zi~xY%Yb$LESi+zpL*0@De12#tsX-+vVU0P6Q~z;f2c$cr=O8bXcua7IdFP32a7H5< zHpP<(#$b4%H>VAygmUigf`I=j`ZxhR^k=y;O2tS7_-wHl_ zoED@;Xi6Z~X6!emK&9x7&$!8oex|BsY^o%7ES!g>w!@TrwIcCDGD+tV(tUsHp)0=! zkJd;E1fV}X1X0-n9v2`i-^@Sj+vR5?0FByJ@JtLEIDa4nm5)jbO`Ko|3gW0YoVd%j zO)n(#pw~0c9T;Y|pg~1{5b{ionXOvb_KfB~y@Rv7GrIq6rRKvf~)5E|;?w4spdk@tpM7u@r*lmP&@Kz^_}P(_^FsWiU-OJfuTC6;( zKcnOn1|AF~JM$P=9xr}%;r;?enUUR#wxL%#;y&`3o9wV7)xn)c(cHM}Oe=8!6~;Xh zjsF#mRW;6a=Y6>amBdE)sDi`IEX^V%H;v$Tr67J3RK_EdRVSWs87NnUkOzb-DO#90 zCeUm<<}DZuX_OBlUtu&Nck;m=RAgB+y7mh*iU5h01#^qXDtcV!$w!&1aYRai&1OZy z2*HPrJbnP6SWa@npiyYh`w=E@ko?;@7B3>0hhof3Er!w8_B5*;%~00Mw& zPXx=`u#wk*nbGAWI#(qWs-o)0g@?LtWw1*S=U(5y<_j)8N4L`e41uYJm@VZVOZvsW zaW!Dfkt4|Q`r-nQG|d&}&XI?|!oV6D;<>jugTZ7{kt1}WII~U;eRAoa(vCLUV@DD* zA6uf&Qpn#OgOr_kB?H7=x0wX+UicHhtr2D(mFR=#Rsw)$Tb$7Z@bibDcp{gM6x=M| z;=d-%^GL1*WJtbbhASxfpg9vD=odnP0}GC90J07NoyWyP$svVOdMD>i*Yq0<3XIQ# zJA$!tEixHwR$+qOkL5e$B2@rO+GrlS&=QVsXg42>uwj9A zOgeX#da$?}2s z8=)+X37m5U+ZDiu>aB(g@G5ui65>7G$y=+4LbJ%?9(XC3NO{vNA+-#_#IUa~gyjYc z#Fe_5%^JHv%Ms$mP!4kmPYyFRtBa_N&@&nDdfBKswa8DM<`E3R(_KRToct@Jl@ph)dvc2wgVW{E z699YId9)9+4hY6P>L|4q>j+|@H86>r zS)f&HtX}XKc`=sEqi!(w(n{1c^kWmm0+c`j`>ab# zB-aEOUp)ZXzyO+O?lSOFu7}rJ2Fg9Hn8u4w)l&c%)s5}rgma@?R8w%oV;BA`6gHy(^ zp-w~@8hQ5mdG3nFVusNfEDiaPej<0VR@-C0jt}o1L#1KhlGt+o!CaMmb~6d^B^;`l zhOh-dU-#K-(0J#QJQJ>Y+B`~Z3l`C6$sj#k<)# zXr`nsOaQISIaDn1H@i9y=n@^3L8PbLJw( z64Ln#4~h=gTqzZ%AnPW01aM9LSq(q=OqFQ{bCQk>g_E{m;UVo^#|vl{;yt#Br9@E- zzh(I2FMATj<6$T0qHa6RI@$vY3scusrYT3zExc7br{U~YRCDn$>W6D@cNTdh=<rhBPju1$X}(=a9GRkUHlXTPUA)xfPfMI8qBB zvjwuxy8_0%eVQOWUfn#Zb=;B6T13FR$%1Qty9v6_*YJpBZ! zh=_0iscOP>V+)>5(5-D`Qki9`DQAu!VNRvOqsx)bH_>&(S3G{qH3U|J3f7u(RjqC2 zG#Wf=hy5jyX$li*^Ol7~gD2CPT1fIF(G#Zw`feob{to|xxWyZUSoxu>4>m$ zgrpZwJnO^@N7N-eBCMLZ2F+>~$$krqh`=DZd$Wu6g_%f|#oNr0`iM-NzjV(R&zo}B z+vL;kPrTShT>}u~AJ}UeWw|3+YPOioW=}S0c9jvPWCnn^OhYPZe)uqpx{OBHSfTG? z5#i-XiV|@BCj zbwSsD(W7k9>;0mAS1oRM(Yom|Km>^&FM38S+OjQ$yk80{6DFWjFU~BysvG#gq#h@Gkn_X3yUE>=W>-YPq_3USd{mM`odRAwxZ+L$A_-B^E&u*XfhIr1e z?|DaZ#lIV%r|lPKM-f7q@dSF@Mq|I&LnoZApu7Bgk9Uep`q9%&9xc(^>Bk7 z+RQIa_6?;6JE*4JgWO+YXEqHSIdJV;ZV7uH5B9v;_s)IVlOEk8i0%6u?g#kpGq(0F zJlGFu-w#XRnw{Dwiv5n-+`H`i`_JOeYh`gQ$Gw>EzeDo&QFiYsdaizu{)l1CBpf z^m7$pyO9+-`{%O*?|%T-s0y&mz_7k}@b9Gq=R4nDRCaE2!xfG1hb4a3;2p;y2A7bt z$Ffatq?!ZY5>23uU;k;W~p2A$-gsM z&+}^e(spHf{pdyOVkPewDS?7{n>!lei7wZir8Hx8LcicI_b=ls&9W3Kv7@yP zV%H6pcC{U;&9S_&3-z(N{(5z;Tp@9#T$SCqt{O5fZ`GGR-@#A5*MGAwf9`GgDCeT5 zdjPBH)xBd_tD4(qs`6cfwi_{Z#@)-jy7nHbVdghkPpE5;&nk{@QUW9P&%L~CL91AM zt8_<8{rl%f-kl=TQ+s}SwG2lE^HZdUpTDUD{wMrzYJaVw;|iCG-gHgKr}})u1|cCG z%c-h_gfIG?=m=iGHO_*cEXF?TVwy}z~b^3M7d>#M#Z;fL!x;$DyPZf*Rgt$gd{ zk#A=>ac)WNfzMyU!C;b#1~nn4F1`NSe2S>taQGJ&o~_EUVlRv~Fz#9)(qMdyH% zQFqTc+FMWqi@XiBdAE^aqjFPn>>+kdaJ0&J2-=@Na8AJp(BZru2nKv2tsr(DiIs_G z)C8o`boYP0ke2Jd_1y7cfQXfzsg_IhNO6Ss568C>O7h7CZg|dW&SFwU1-AG=y~3z~ zOYT`Xw)_*=?cmj12)iu#VmCl%%0x zX-pA{JqY4NeLw?6=e1krD3SqqYi8b!55{>W>E)h)s5&h%&v(@|0Ia>yNN~+RNE!al zfZF%b+Sx=Y40<98`l4q1Pe^}$nvFH*s9_^5v4FesVsoMy=UecihIw!wH$sq8qXJ6` zmV3bZd0h@Ab~Mn-G#oy(;xRAEm<4>zkG`O^9U-QCI zw;IgAi`AURxD<%g1nzH9AV6{^;Vch=azq7n;DGEJFAj;+vBshE%2y5_o>C?nk)WR! zjdF5V$LaaWwr5BWsu|g8w8P^zEdApdmaQAbSe5?E%{Yc!8N&JlUAzfKB$Iu-+7TcZ z&O4ncQwf%GzrR%nCURSIB9Q@ulJ{$Yy9XU4yMt`jPivz{cs|9(k{&scRJ4C?Omx6= zgP~q{I%laXt+f6&{N}44iJiuuVW#)(fijOSLoZoC2sbM>MF8=e_85W=902LkazN0L z{1-*#UfM$HZ9r>oOoKQITX1it0TTQdos4>1!W{;%$D@sqe9#Izsa_+JU0U2a$1D=o z&AX$tm@Jyn%VPdDU%=y2bi!62i)%iZ-334{dO_H4P9WGU39b>fIFueXad^5C!9)ij z!Gz4X1v*#?V+^m0H3LyGX#FlDxb_wp@2!%pA@J~;&WgT$IaZe>Z@9l!-O z5)b}m;n~(f>8IK~7haN?^sglIzCQS<=I_qgCoWsmtRNXZT>8-c1E+2nW6bMvi}@`- zZZK;KB~>Hqv+bPTX!c0luzL5c9=Ez3$#C@np(pag6_g!~r9v5<{CWG8M(3QPpGdtd z35V;e-DNLEFu1Je)~Cy!V~>R^jA0mjC7N4#gKnf~TFGQIy~y^q)E?soDoDBmfAC{W zHd5-3V0xxQCAUbX+4o9Tpww839NgipNPWFrOGQg{6WTdfX**Re+NLmDoA%$I!=44* z?W%Ze2irnQqi5L}#8l~OV#@6aGU(d?RQ_{$I%c7R*9Z8(!7@TQ8!*ddCTA?eS(z!j zMMvhBhKSLr5XDv-;j6cd<=3~6DqD0mo(VF*Kbv2Wx>WU7y^ay;wklX1k^5LCZZ))0 z0WgfEvS(mAgoY|oIOGyJPR}MoXD}xe0T_G++a;ssmuhk32T8|DfMbd2SWA+f%P^50Vk<$z z)Hy*YB}tmtb<$J_u@Qapxi3++^ZMhT+1fP_yUAhFlnBtI* zfoWTkS&zlFavSM2QKckAS^0?Sk&?LFi4Mn_LCu#@_xr$U-EviSM;;;4 zII%nh)u1^L{YAOd!9TFy|BOlIvGO(M)xa8K9r3%a#%zt^Ky28YSOFcUs_&HOz=Y!n zvA1NSZsnaN0mF|dmyP4Xa_!X@*k1}kz@G!tnLH!~d0OhG7w$kzm;uB^OXecx&fqQW zKjw`K&!5TN_pxzj1D>7?oaf>}94_TdjJ`CqdO1B83WkCYOeA+p(AGpDC?4mzs%@NP zYB~=QMB@;=x^SUJ9Kh@GpNl>n!~iu`h#OD17-NjU`O<$3hc@zFymASDXnMnORMhc; zw@C&x;I!D=TC`!rtP})xTKxP9Z=a!mlzX^V)VG^=y4cMkM=bA@@goX)Om>n{aY8zB zVl{*JQ9J$paUtr<*&n+zF01~SKAm#_{dh)Pzfw*Yi~d9zQAyjKllykZHmz`Ua82L| z1isck@&{3|e#Im4pS!=<4Z^^2$%|0=_1VR@4vHJnuTQaTL^1}a_ndy4eEVj7?Q8!` z$=L5t|3tP%INsWIRiNC{yLfNQRaznqH9FhPS}Pona`_VsdJRQ2^J_9>6iA6EJV?r^ zl!|imZJ~r6N8Jw^T-N9M!=1y3mp?pCYnJ2?Cl#|r>fly)h*pbf zs0c0TpTBvDJ5uq5WZTy9Zx6?Ut@gln^9(Z**Jp@gVKNe5YJfT)ar2_Yu}tf4+WzaA zfz1hqR55{+TbdYgh_s`CMJb>hrVOESuo)3&ja3P*Y>)oceuvu5I%4?B`Qham4O~C8RnyuSY5wnGR)u$+9y1BEf28q5rUO=lbS_KnHA1?EWf{LC>Ob8aje9&g z^_@QRhq<~!C}mzVscK-G&+O%9NJt@ z&myj~<_$uvmMn=)X^B(=HA2K|$r7}ZKP05%OHQXFv~w8B#RcuUtLJwP#n##~*pl^^ z%D$G)6I9r9v8pHJWlv~VPgr43Agw22x91YHm&k1qw9pf&-h0`!H~OA=8NN3ry7%f( zPgHX6HAU9iM%JKcj?{GX>kGY+g}w36KGJSa0(W1cx@Ay6Z<32;id0|9QICLMkH_=g zge|jAkRC=wa3>YhW0YayCMX`bpj*VBb)%{PZ)<|eez|tu?4L(hu1kMjTvy;2TYh2B z>9F+7p|-3AwgB56w`{qR`u3s#tBZH7P$O(cw#a({CifRO%1kqI;snd9a1}2pvpdM@ zdpwU?GqPwSf=?)f48CPfrQ(FQ~vNcn7imp;%= z8t4ZNo~as`Djm$N9b|tqsB$)g-PZn%Nw{1)MY|u|^2L6&_0sO})Y~~JI~sJTt4k)2TkK8r&}_2eO5w-(s^MzV zW7mM8uP+~sO%IGu7txQ>+ZM_f;+nTzx;~ECv&|2G-yLqbY@_MoP^$fL_OwH*>8I^U zhvRIA5tpII$qvm!_RIC}3(pNf@7o_mf66#JJazP`8HrC4pw)_hQoc*O{RDp)fY+#Z zSZsBGJRL4+9X?iXV^*r;yy<|HW?j(3zbYINcttyGRpYOwaVa$%>2;y++wkq>u-wdN zy;2SSH^Q#3BkqkyZYwtfD%-7&Q-w6aal6u=G&c#SFX~S9+ap%zKmU8;bV|fYBwSq- zHp0NRy-^*&$W_eRs7IIBH%GGIkp>YK|JjdGY-$-lCXouN>NGnCr`- zaYeiF3mUGT7cT>ux6h-0a$9BKO>)0!Mne zzVL~EiMjtJjPz5Vi7vY<3)7f7Fy}x=~alew{ZYol7%`W45H%cnd!F6uz^{$Kc zKX=9)i%0x7S7W6K&wpi6)f3_2wCKf&T(gPpERTQpCU~EY)xR6lYWsTr5pa>gNxI57KBlU*@KOFH;<;{cc({Py+dukjbHipmp1*i=-b6G@9`AN5s^+i*tC`1 z+m7o07#}{i-(vmzl+_9^Y_+)3-Kf;s^w0Gn&uFKsR{?BB@h)ZlsZXt|&+vJlr&ne) zQ)XK2&T*WwR%n{JH{tF2^vw6CQ$M`_+thGu3!KVp8>hHtz47*)x#{vdXJl*7ogzJQ z5BB}}_(YlOcj*(&f$n!NJKrRIkKJzPf9sA1f$qhYgpjA&fAZ& z+UQ_S!oHIEtWtO39y$mMHAQRW;Zuw}puUy4Kik^Y%{(o_b-CHhd3-1*0IML8%z-V> zrGlASK)kg;*`IXu%zrS^Nw^yw(d>4y$mhtLB8vor=m>svQr-bniW89PBOmO1$3OLD zaPAYhmMoDz&M0Mmw(=KRTUz-*k|1{e@Sksfn;U3p^2Im$_rUpfIs%G04Z=ZfSu#o- z1u5lZNkWq4`=lG?3)amGHa!crUl#0^7VP%}9F9{Qco!XI7M(N~o#BBlZi}uL7Tt~m zg3t)};ziF#i%x8dUOkJ}&64>oY2dBoWRGMfBr1|}(q%>Q5EffMkmjY(o~6)7DPc=X5&KJ*;LF6GrEuQmD9z=|sTV-F<%{oAF8C~8OtYbScCBN%IM(nP6b zB}EkZLT%#v?@2R$TFuVdUwEv8NveHdMC0Q)06=Dgp|N0j3V5|nUr5YzS7aS?19X$Cp32zxZiGFWN5pa_FBAUOa#5y?^TQO0xNM z{g)85&#G_Os%ZRb!kl0BG>u(UH>Yf>&i<@oYRI!(pE6#*Lw)xMyYsojbfcxg+8ED< zjf;1$gl4scq&!+9n+MDDz9(ybZxVR4PyZ>?{pzrT!7_cWva zqhJ1`5PkD`jxTGR5kDX7u2tR-3D*dJGQ1{t;b(*9+83GsIv<5K!q*wty(8+4u`Q%hW%r^cq~dk zocS@;y#7m&xKy^*skw<1W*T|_<7>RrqRh`pdm_wYqsx4g)qNADQVajO)xESOJN$!P zYa7k}vz+ykjWqG`{`|xHTXU(Gmg6JfuQ#f@Hl9XL0E|l|<-{79@Ck!WedX=Jp0K|c z)>q&W!g*VI2ERsA{n0^@+`oxX-|auVk=G?6#~xi$-rO2+iOdo$t;;#cRISHr9RrLIfgFYL&E+Bu%t(cav#Nw8_|c3jiw*Abi2y}B-t;3F%$ z$<_OdtA}_;(c41S*0RKQo%afx%pS~f?R{C)-#&}Xxar9&y;H6+ zGv!tRL06it>`lk)`1X1UeZM64o7R25$1dn!H5X2w5uww4~DxAW_I@=HM=Rk=bgnU$(wHpd@)6@qwexYJy-t4tg^po|0}m< z4~cM+$U9hgf5?K^DGiF1$-A1HuqCZ^o$~$n;`&w7v@4rMzsWVfk6kbSKHl~GeoY^- zZ>_SI$|qa=Ro8&=M>*|dn%Me-tK0T`oAnQVCukiy{{B;vb`5dy`uff5>3M&+zeb%_ z`BTmQm*W00-{DgMWB!)xpF+gnU))DKQgI-SIKj>9g@~>0H0h?2vnB3m)<<#TdN-=2)iA1 z!8}*{s!nSLMHZi}b2gqOB(ip-+#o?F{Q7pFZ4F=O^K%LstFC2kFsF|p+&=~?eOMDk zLZeQ(zX*Zhq&;H7r|t*8c%SlwBi#L+;#wv*b4kNY`sE$?(qs&Vz<7~tGu(Ekh3HU3 z2{IU7xf;IM4@ZRBUoTzr@AlfeuwjdC_)%1?S;zL-V)a9pY@ZMfQn$YQh$7TGd~hj6lyM_FLjtYL{4&G z{nrWz`9QZqn;w;GTrFrh{qw$P@C`oJ<*|g6+X!EKknzhhci8HlPxKLnmVxu56KV0^ z{9v~e6Z60LUF#Ls=1E^AtNUcY)e0-!n*l=BiI0dRp1}Nu2;n{xLeA0F|8pQoF=9F+ zm2W0^tt!76^G52Hoz9_Dp@o8gbdjsqwZ;5)(0{-(EiyD;8GA7FmbnsG)Cn16peJ&*woK>kQg$#^@NcF*hWDXfqxCYX+vmp&w1Bi^Xrd!!>dx5V&i*gLfUA1 zsq)V;DqH8Dt$;nBJ1*^$nqk`=r_F}8yX;(9o*RuyD1L2YKtr>hSD|0mHFnB&>QM#+ zWPf_~%Or$F_DUv!zZ&Wu?R`;p*O!>Q@IcA=8&kE?+SJci9~;J1vlKP{i+X3*U>swU z$?bF_=-bsKQ@)!A?}@%P8jH_YcX{VybnOKfDvs^kPV|#(G0*&i+OAE;e$9!ty*6l| zyZ-9Gc-@URgYUC9+WsEvZgns}(Aw-2O3?e&|LHjY*GFAO+(x&F;XnVF%eh*?3|kxh z-#s?p^$%wM9=9DV-hH68v;3sN;BbvGL)m+pw|f{{@mEL3nL$2l|6-OjdSBau`>OuB zv|W@%lUU2va`ESsY`Nr}vkc4M?O$)(#k}tq`geRX@*$5_WtsjyCQ)h#ZQDrXt0&A5 z(o|nHDMm=_5`N%3v}-=*kmXO&2Z+y`Dz0Fa|8y495-VTU*Rll)bPd6!zjWrrq0`y3 zg_n+kP6l#DG_0g1Ia!h2qi@i@W>8Nav(XQOW|7Gjx5S|rOV5<1aA>=jW=jwVr@&?Za;+eG6EWa_`gfc$8n79d&vWLWer^Av;+Ka-MW8onE|e|yy9O-fb&Qg|K|KugyjxinO?z3UbMCTlJ_8Q zcUeK`+Gm@n!g9?cIg)YRo&2(@s!Mk-DmsUl$B15j(9d0q_p=0USL+-})+KM67nebtk@)1;nJPh`7M zHt#6Wf=O;dgYS{K0lb0-*)=qx| zm%jS(>XNB+h)(8ISEb}1mG^J|y3Om9v~lsCBnD1>+bjFp!Prx3xOU0Qeepft>uvpw zGj@suq{SF@{LZ>b=sOpL7r#MStD6sZNt@doO-tN7S@{aV#lJnb_I!%aMea z>SEFC6SY{e<D;G&3i4A3NiOM2{_`vL!n_%RejpjrjY<`>gL* z=Vy0PQ9uXy9J)`?97A!yV-Rw|WNm}*Gapm=r>h*cJsk34;~|C`kG7Iz;Za$REDL;z z1k+E8_l2+DLVlVti23y9-`_ce{hyVJW5=JY92yUtzIQt4M_v6iH`96b@7!|3mXb}} z&V8$H#J@b59hcctk;){pOd+rD}CEl^JG%_yN`zsam3 zpRMrQygn1ou=0Nw&+>AfeZ9`VZ|4{7;`a=gbwP?Bq5a;k5MaMBES0|SXLJw;fxUVB z_&)TxbOrmD2_C_j=ELs-3T1qEX7@n^GS3_!DlyM%Wcn!I7tXv z`yrhC_zfz7m`bTiQ8|UV*RLKR;xRQXv!ajY4xi3lel^GSUP5G!L-swVk^(_u#$PaZ zPOx}RrmRw>xMJVPPtL1S&>&4U##d#dK$fXe%&pQ2>VKD2;=G-thU>hh&-v3A=B4ZW zWum@ETsyB#eu(t?u3en0+5C_*Q=Dst@qjB=lz+qDTxm{iwX)>)9KZjp{*tf3@k6W0 z3XQp0&iK+BtP6a+RV`#*LkWM$0Y8gA{~GFSrbiWyf7W15!r+gG`Xfm-r+JnA3ed6m z8H0ymjTKJ`RZJlZmMxN}*dA^ko;NKBzzJ5WIZ2)VQYAN2W%*$)ohtRZPpX|*)wUvu z68F-voSNa8OEAr>|_ZcTg))_U5G4=owDztnz55*NJ`na6e1yC zNn_t4BugQCvV|y>ntOf^{ty1wb>G)D59Zmq=FFLy&wS4N^?F%H8o;|bQvSYIJJD6p zqV=ea>*YB@bt)4SPrw>&_dK&agV7#}O5*P7Ra&7Hzz#${Ljru5pjfKsR=43b=4O{G z;?H{D|Jp{>-yUV4N9_axp3c-ELCy^((8&nnN=gu`kKPW-~VCu+yVes;8pRe?6lu8(fldQjG=^O!fY1xl}JtlRhjgQ}Pv z*q3xo#Qvk$olc3!WMp!(Vehob`kG|}KI`zL_L!U};ztjtn>l}R+Ute;#$O*!7MGfT;O=3pAYfW; z0GjVH8(!}!9lsC$WTEY8l=rou+Tfu?l}YQ@n@3OldcPL-OTb)w%iSr-fnSXG{endX zN}heyOz%ZAU#lEWE(32t7dF$bP#)NO6L8luOrAbW-!g3Kt)iDUhov7ku_H5Z%x}-u z_mjNeZdoV*<6W?4>}E)1D*ou&5?sdAfy%fEdmhLHqEdCmwlNpGu~PBP7PTV2$<2FE zezABLXPGXnF25|HC7< z-q2Tf*`Y@WC+oNmk(Sa`MkUIxbqNvlzHGX6Snv%P__?a}z^OQt5w4k&z!8pPx5b@- zLpgncdW{|nyu?Ur-KB6{D7=d)k2J=fs9p&$q3}=#U0r@%C_f(IJb1H7j&d&vW*va< z?ShJt8D+_M3V3^h1fOS61pxXvJu@Zg0DU&@+NVgO0W3flloId6p8zoefbe>t5DYuQ zu|!kP+4>-b{ZBxsucsgN>Of3+2n-aDuhRuL#{;--=$as>uWQPR?+#Ud_n|(U85vm9 zL)OUP*Sg@;9-ZJW7BK>1u&dpcDmv?z9-3Ni0DF+s0JQ1BY_H2oQKc~iG`;B8LFI*0 z*Ph<-zOs2}Qm^-*i)mhfgP-g~O=v;^TM~G7e<({LXvd^#Cvc5oeQigOz(OJ8tl}XU z!kIQIF1i7*!lU?g`*f!vLGW$LB-lYWXMx;XuNr7(b2GZ>gp1~4E@-af*u`mwx! z(Vha{NEa%W&RmJdo8d;0G%DZh*4kNJ(No=&TVE-NKzk~+R2vK^zX?qO{@PPnYDka=GM?lo zh0;&|2_`Z=sFh|WslzR}bb>(P^}@ka?uJADQH#NhkciMEkqnXo+jsbUJdlbLg7?b2 zRlr-}&oDueM@6*;J#Ysn=;5JQgO#djk~~ilj!IZ;q@EG$U3=Qy$V}kcCy8e7ZxIf` zK`($E8hHoNi{@!~1K|E3sn}@Xrr0n)4%c6-gt>Y~^N~Iy?g>yzKZ_xQZKSaH_i(0fv+YNXY^$Yy=iUSFZ3kN5kjx z^l4Q%fyLpB&b)3x9iGWQ@k}H2dnoSSqMl5`Iku}uEnkmMbgR!RQzgb5AfB{%I)cW* zgk$w3F0(jO<%$p#B-|nw-awNtIJ~x5`Qo% zVuk0cgyxtkzMKDG3)TFf6WNSRR-~OaTs&e)ZfZ2@dS(9N`$o+tYvx#6qUAWdUM zl5YyA#YgjHw&s5xP0{|k8e_nn5(^g9bf^pit>YcP# zt?xiUVfq_LM;G@WZhoo|_i5LKj@qBPFlKU_rdHp#-xu?6Uy&L;m$e4&#%Q;JdOyYv zWEUgp!I*J%)4)+U|XOU!~ZYJJn_V`v_Ry!t*YnTA&M-b6m}&;io~9a(?B#~ z2BGOj#kmw7_22WIEnYtQcd z;QE=|YLYk+ajeHSQ>0&GJxYyk+;(236d<3_r>qvo;vzeh%G+NGGn=<~>rT^Nbz zzg0twJ1~lt^?wD4_o|+~VO==>GpQkOZC5Y0l?%9>d-`^GgM1@#pvK)JL;R*Qke_f8qlwyF5g zE0cbzxr*Fx1H>tVNjdNp2IIIg7zzc9_XeQXTb)d=Dk@-vpa3N`PE(r8ROlILmXEMP zQs`!yIj9tfA|VWTELZV%voX6ZN3L-aS%i|CC(ogLOo$`hyE3q56!sdFFBNM}FWLf} z8_es>oF-PO!a%#1y)eMXdM_bSHZ8%3&ri%o+_KtP#KQE{d1XjvY)80XfL^G$tCC#G zo0=oLem70PquI^)_U+8jH1(fix&8dIT|IOf9aTPxNB@0KA2vHZpMJ*Aw%ex27;m7%-P5h@rF{Q zrDz^&Jd5cF+^P%c8+JTr`V3Q}`y3n|^G>`39-JZQfdfxm%$pMKKl2Ft`<>+dc}TXf zcLy2yl*aEdNGH@4eN1WLp+h>;r-}vwH%w+sg*@v*HmyP;58o-pQMv{t%>k5t7fAFh zPNINc7FSr1_ut?d&vC_}7l8-_T`|&#f6oo{KCcYFU#G|*)b6}JEdKKJ1!5#;+|z^y zfLb@oDc93<4S7NeA*XB50I)n62s1*ZGLXCwG+*c*&GQlj zhxden$DwdFDb@V_u9PNgu&L_!U1VYv=oTgGOeKbkyCYt_^?)jj#ZpAD2T^w@4*|hw z1VJARD3FZAmG(7PB3ML9|ARqoa2zOG5+~>|oyoI@q&f~|0;lSsJnurHa8SlycUkzc z@tGn33V=F*wUA1AmzYZd@pvJEQ3&~S0l=wDUK6$ozQ{n#GF6^P4DNO(E8p5PbxVie zCaI;vP$XpWCKSUkPP!yzAXgDA0EjG+#1-7xjR6vD`iQMjoyc5t(u+;pXG|5-We9r! zmBxfXfL@XW+Z4cjh)vTz?O{haP`S=_r7230K-EiPrau7sD${6*<^ECvXBU+uskMT> zwhS^i*@qcq#IrjX0T73-TxI$)gBM5yuxM@J#y#zF3`w0(3JU#@EuNRU!H(&gY=tF5 z(ED@3CICqcwJ-Ftk+iI&h*ZFq0uc#t)Nj9db)#}tMLhugmXvP6j|am`0n@iR^rZ_9 zUBT0PK&9qZ`Yl0%D2amQZry##$>Ifc%DmYs&EkO@h{?$N927?eHQJ(cOP6)bx*l-M zs}#Hes8B8{R8Ols@>XM)fRrMV&`US1E5Z61V0*mMZ%MiCKQ02RbKE6i~dx4?^S zN;}?LdiIQNpqW~U*HdnNYT4!?Lhs@6|6OI5i`Ek}n}7=erBI<$M%Ld2@ft?)xBqi9 zmT`X%wTKg8g5huj#m!aD$Wk<8TNV%v0Mg9jet0$S?SF2pjYP6!LL9*~Yk~w>J1acG zyB6tmNM)ybNJ;Wg_e9(o0cL!O+_Dcytt(f1R!w9i7yzrLwWT^7^~*iq1fEXkdJP6z zfPcMPFO{Wq#Tn56$cb^Lv|^&NfHdh?ml)Cq0hk^_VXqv1!G5Kts;UK()-d;xbZdzo z^1PeCOV4ipafVG>6k41oQ0fYRV+lm$H1N}rbu5@^_EJJzTSCj7>&7y0D)3DBg}4e$ zf~pkV1Oo=k#LYLztuPS=0B3?_GYcZrc`)Gk4?GnyX( zqVaA|0g{~WEAdBaR1}88huo1mX8C0Z^k~|P3?FEb>oR~s_w_-{$4q)?Mlg@nW~u@h zu;GNuB=vJhz==`!7;q%U$6ql>D&|GV6{tus7brucvbvgC;tSv8KM;UQS1;|lE;64# z|C(V%>J#ptgU&O~JcD0tIwCerC)rS@Cz_D|=8aPkLU6w*dqS=!0P`xvo33&pzE8{i(tt9NLg_ zC0UeApsL82#l15}iHkr)ED;wI{WVs#Y4_K9G2 z>ILvb1b9C}56z?A%kf4RNyD;+DHtgq+!vd|!w#8iN5&$?kk9kdsLUpmh zae!4RnHLUut$H1>A|?9ROCPaS34`DFB&CKhgAbzpxo)7*4qT;|(}E%V6rkyVp@0$S ze$QS2IHJl}go3RNgBgV-QSCo2g3Hd_Qy})z6frfy)-MG1Swmam{O8?9V}99 zoo$F}3_mO`?t@S~T=Ehqj%xTeqbWF;37`iD!f+|&;zx`C(>T-OX3TvY(c%&qyu=Mg zkyJK73&KD!mTva|mLwRbBN(BjfV#r}V0RC26vxR$+R}A|0t%%-ffPs{i=a-GVM!oh zsE3196@i*SLhge9hoMtoY}GtmeVlp+aC?{>tuf~@R_*aVE-)DRE+-+3OVrMahvU9k zYp~uSkAv=I9!)HOqdkw!Rlww-VlBdeJ6tRe#3)b%2zyUiy}-{Cjt&F>kTgmk0csvk z-oalBo@FN|5hlABh}{rdO7^wq46$vY=rROAfylZsnP4^P7l!({bYrTM!g;q0EWqW3 z(G$+&69L*kfb!vDmHBLRU|EqY#*cFQNP)eDaGgb|w5P-wtw5A0z`KKVFiCTun`2Re z0sP$6sE>mm2h16A*y!d#)iY{DfXpA@3&(6J|D%i{CvXN`A~s#o?I9|YSrT}v5NGjS zCgO>B!ed)qV@=*Kp%w7&lM<8g zT3zb4nuw&d3z+WvQNK{`WshTx<^+>w*gLsP+P@^5Mco6V94_&o_W%$x_6|6Q3AYw6a+6cNVHX;L%EH{%e%+Z(Z@|9oh;h^>?hS!AV(Mur62 zgluUb;xfc>6C&qU@K*Fr`hjOI{$|M&o-*}^>2CVJl)}890RDp{I)2Pm!Q<>0G-gC@ z=ZzzVW&+~|-37vCjBHH7z|Glk$P%CwlQmqBwGCHw9cORsEBE5QD{jT}hgQSGR+(C~ zRFRp&1^?=@=E$QBID}|c5`2cjH%ha9DaQc&iE?f%tX9C94TA19cxD)W_oRXk0c`mYD;0n> zH82FL)_%dQ`fSXgBv7?1e2LEpY;AD^Q19S|7KK7#M@(#zP6S$0;&xS;~G5t@1p5{@1t#ZaswH-Z7q zMhS2*LZG}T`xReU~*|>m%AI4{nSeB&h&L_pEK!r$;=C7L+yTG zly?0fM|e3;LM5`YngxPu5ICEZ%I+XQ3M^*intxdC#rw=`TN#$@-M#_tVDME1(7&i! zv%hUcf~6I7i$;Y*NkDasTpS7prU`?POU!6DBpllWCOr!J$ZiaYLxWyk zz=iY-ksgoJ6&tYoR*2|jpcY#z^`%11sRk9o2%+zU;1B}uA$vz`35k##6f#f&^wy(! zURt1#3P35)_;ExAmEjx;`unK){uUkj&Y@B7@$WNc_JQA4vt6XWk>84kyK#3 zheO1Ype$6c#M-=JB)W(SK!TxUYF7XNu|c8{HDLE8hMPneMlq=062p!4GAX@FI2@vc z!oW(^dbC}CmhUBv$RJ9?F*v9o%&0L!mDl;G5PB-st<*M(0Zqc0`7I&tSgA=+1KX>z zYT}X5ap2N^&%fl?12FR2KK4us$bkqiDMe^U_+{TnH~SJt?Ke?wgcnm7d<*r95P;KJ z6xvjhnFN^c_YC#2Y3@I(4ME%*hoT#YV_F!d@sI!#JORZZNxFzak1FoND{zdwR4xC9 zoq<=HI3+cWafkve?3hPUO!dvQ9pVL)3u{IG7yDwg;Kd(LeYfX88vTk8J7Y|}hbiRe za<-#yZCc0xtGq4i(x@-L*nV0)nh{O%{@T593EBjLPB7H`XL!x$x(@1q0UFQ(#`cml zYNsQRbunECl0~W%RWn2VvgXI_8)ujcbg8e7XcG)!k|Be|gDr8@E zIHqsX&CN7w&7Y{->D!m@)&=U{dL=8P(!q>=NrW_^LG=F4fGjX{$`;@F;3@>YrvMv) zoi^Ev9$GG&Ua5l<5Lof=_E`xf8 zL+IkPp6N06zEBwBt0J~v!N}lW-7P;5VF2STYo0eQ)rZokhG3+CFZc3IWCQ!+ zYCX^2o3CTJBtw@NGO+i-SZu8rGAPSRx(+( z;J?JUXs&lU{&{xi1!oB7x7WkU!mO9W7<+FrKgRj7gdu-%p*Mn&H{opesEh&ojOQTd z+qn``g4ceVb4&!o`2`hm=jXv(OAYST^}uJ@MFe@AAqI!I{WP{F7b)Vt(KD=Zf`DUM4NQ7|${!MS^Gq;oInG+Wx|%MI=UPOO@@ADd)SG z(D$OW!@*~V%X5e4bhfm=q0Z~~-zs8{|d8-L_nf_5$0^)3-~7uxYWhYF+Z`rbagtaEhb>QV8n zpGfr2_r*W^FaM;D-{BJj?GDw|^Di`aRV7{n72CxOcyAUEOxl`Q>u%&v@V; zj)31D*?*ok{K@);I#583(%25LEMKfp^qF0S_ora1zezdLNwj4Y<=tTk+iCE*(@~34 zFR#WlT7Q7+^Cdze}DdjIX4Quz+NcPrD<6ueZmo^Nf8 z<*_{XEKpM@CIx_31I|2c@STW;uBv>9vZY#qdRkrN)F`FHnM~55>%7xT`p-4HyrGWv z_5F9n8J{JcoEt&6MeJsEh{aF3WCwBl(>k#a9=@%|v@H|8w{$7~H;O5kKghxMo|AP9 z%W#yWfN}Pa>j2SuDc_OG>+b2V(m<2>8^;bEGOD^rbPcX;-&sucPxtdoFu$w z8%#r0UE{99y@E4JanW9ct z?UCuj&tWB3(Q)&q=$ub9*~))L*BZ_p4X4v7^LMpDum6y)Se5_f)3EBK@iQyvW+OeH z=x#UR%zNMsFM>4T`ewemDOQ*z-S1ldMi;q6>7X>vC^)A%OyUt*o?SrsIh~Nw%GT!| zc!d_`O(N9vXDohKG|WEg@_>QB(bQBMK@axwxcM?RO|gWX+(BxFY*42d+m)t~_`;pQ z(Fg2rjf6zmV@gpum}Oy9f*_idovA%UsJN7GwM1Nyq{57!xPmtBtSOr?RKK>buT)T{Tx45CR?MbYr9_sRZDXGZs%$ zfr7;lQW|cQw8SeQJ(48S?q`M(WwvJ`K8x-{Qffpr%qWUSoOhVF(o%Zmp1rFySDG(g zKi6=S0Z+K(wI7cJjrr=rr`!vGJ2(d`T~aJSa?4ic@lDDX5_DNBIqLuy%R*|ar*Z*m z#+#_~C_fLdKX2Mn@`$W^F%`sydd8V&Y(f|_Q_u=cEt>t4ptbYV6SQErn97LMM$BhESrC0&)$+Q<`a zLy>Y|AK6dXP`#Xw!MGP(Vb_yKj;^SqMV|$_H;r&D?d(rR1_jLSQwB-dv>Y-s`k&%2 zA#CU1(|BXoJ$)>8QQw(lgjDd2cV*- zU$o6O=RXAQ%*~S|0Hy$EnOzYI+6T0_W^tenav~B<=0(P{*g_@zNWW908I0mNI?L(v zA7wN_eI!HNick&_Cu_y?HlN1U9%7};YOW_%qefp4QR50Iz9-V(EGA08HCo02*LXX+h z&4^G=wPikXbN92G>q+h$h`tA&hREdu)npEa&*?khDp_D;#v98eR)CJKW3+#Fx zu|7M#vjtWGy^5M|AIGlD6*8(YXJMMY-04MVh87PLUd8+1ZYqzjVK5P&on2=43P!v` zpO%qt_*#iMG?t+sFW;S<7ldWQTP#u5I3gy7GH&LNs!I%{r zkfj)bDf{{ue<1K4GkiCH@$`zpm(+Jrd&)AxNux%1&Z+n#FcXg2t@zKHk%1qNJY@%@ zuK;&dPDPmuqIJ<%LKB6eh55kb9ly5U6Dy=z^ff{L@g z^grS0(GVz!D;2o|Lh;rl&~N^e`QapXYa=pXaG!H@Z;eU1G)WvAj7SWRXMgQ*pM7Jf zJf?~3zTiX^rS2ogE!AzIEfUjt{_YRT&Dy3&B zO05#7BDmSXe%jxESsoR5Two;Ri$+A96ySH&mUJxtpPDW46MmjG(L-&ERNQ= zuaY_mzq7?`OR*A-Bq1ed+eCg98GfGmHVT!@x4#6`EiFiVZM3y*q=M*00-$|_u9hrg z;EgnwVlQ>&{~rB>`Px&5UPZtTv&N!eG^mJiV?>?O^P4tJ<|=eQTShX-a$dObyprR{-fOz{KD2QJV8g;^mxwe!QyMwiVqdF*T08~>; zN$BnB|BM*w?@DxHMTiPr6)Kpo@P+1b_2bQ|Dp4mWs0<1I3SrcuklE)~gh)Ua!>K3A zMe8ghO$zj8iJX9p#v%E9`*cE4BNvz2>0bdj*h6aeo=q2o!$H?5e*(hfNnd1NPh?_t z&+2?moF#MJVc?e`NnnLVa(zkTqJ$$DuS>O&VgBTDPx$lw3h2hjuww5rmk-uoTx36He z%gb7p7;7-=_?%kZ{h{ogcotzb64*y7RZe>e2_oSkuo^15&h=DG=(EkxV`and|1DXL zs{Yng?-O+m;*V}4|GFvM`hn5`E7O8K@0dv~c{$^_OPgKQ~aehTDN`fcq4 z81&wsFseEk_ntzf=L7yVQb|2jmr2~8>r~dfEVjfZ)J`_~Z8p1eCWmb!hJa%A#J>#g zQafO+$DR3+piFo0o#?Tj*+Kt~?Q9$G5=hJv?BKzMOVyv?dET<|7P9fJNs1Ms#ho)1 zX3tBmF~OyPm}Nv4Dl3K39m?KKD--Qbacr8-)q#a~emK!dASMYKKS>?bYiaC!MCrC9 z=N3Gzs>yAB@~~&-sopP##*w?J1{t{Ghu!$f?ySw~si#lMA2o~CDHnBj&5(MT;s|Kz z%*~o!&8NNOlQdh;KKt;#%ZYss{(VW5zAMdrPQCi|ZK=*{eXd9Pl>I&;rr$vI!f@~KCqmks0p_bg)MjBX=)&OJ{4-Jn`*|AmZ(IoGfL<%ikmWm%nwX|HAMe1 z{Ejj<6CKJGBh=Uw>3KFqG&e^k4v{L26zhgEI*gOw8mCn1O|}_;4~+Swjql{KWGHvW z*&1g}!LxUCDa@G<^0Er*21_%B^XjPg5=-)@DEIl<>J!~AtzXYl^5?i2ynl!1DY zVfM-&KI8l#u~M4W_|~ky4qm%vP`AVUSxawX2REl>_%Y6Or4qh+WVklPyspf&5sv#( zhznQNy|reB@f_WtTHvNE(pD_cM`LPQjalJuv-#hxNxj?Ad`B{Q$Kz~Sn5S1^OXxc4 z=Ovrdb9Ki{rr-BX3z**x99fc}LKG%@#C#|&-ksrON}3>jn|u5oj8vd`;V7sz2y|h<{Hi7HXq@6J?$soXwWiWcSg;Ds(b6aq`!%$-A~jibcaHxl2s??E2=oQno!M*mB$1M!%h;YJH%2=3rb#f-}cM z7A8U$bj{>U%{f_uitOzd-kW$?u5(QMGrP>-a@jdaz{Shj)y4j5kp=x|hNC8ND%0_} z>0Znj?Yh@=QiMH(JWXzy81{ev4d-yjZq|QvmUYen<2G|9;xb#(jM%-IG_9GjHTz$Q z4xBD?RsoJ`H|O4DI35%_GS|;V7TK1qUHwekG=M3rDMr| z=dhX6QY~|3=F{ax;}w~9q?^-K;(gV-Z09HdqZBwZ7s}&HVi*KnKAGK!e!r3WeyDP0 zzWMU26Z@YEpMF^-B5_F`M&vFHIN>D0<0Of{k^G-|R=auDE0)oYfXUbOcRG(VvUbtf z2l4SI32dowLJcsm{-!2#?2hx)M$byLV1Iw7TF2 zjs989TkKaBP>MfhA1!<+Z25#sp1|i%=x$8vxxP>3B&EH6n|^UM$9y%n&tqBuEyKkw z8+l32!d5;Res0=Hq0_=da8!FbLuZd!Qq@vwFPpX6@j|t`*NyD><^i=IE{RQ3&oLXP zSnpC5@4Sop6dP|H{4_wJ790?n`2;*V*fQIe>30P_dfY+3hUQ`$o_|| zeqOzPkL>ef_4PpLoF>mGCWUO$s~0)Y^&OkLAf-P7A7 z?VZ=H{(pM?Uybj)TJpy%EV<>ox2SFGEnNrXcH7kgUKs^gItKU!?lwgS&_3=2SQP}c z)$F#n?OGh~j5F+7x^DM!eJl<1Zx8f*b<49O%X3(MbJlfc$@R{1@|~5=53BZj&;Rah z3+^(02y9u}YuOLn91Pfgw%2Wsnps$HO#b-1f2k?|QZ1`}odvOe`r}6awzsR?lAYo5 z!cYk7YN)+`nwNiIU_$E*K3@VC-Ieo$hxYtV1W~`T z4kC(2BLxqGTn`W>{$eE`KNr`3m%nplf9Lpz)4s(ufyds0jLYmk`y45Iw1ND%4Mg2Z>B3t>JI!TY@jDp^M>Md31r6aw2FeePz1nI*$--z%I!xI;BkLa)F1j;#z;W;mYN z`B8KdSq%RvU=V>m_Y zqyi&5lMVzG8AlVZwcqoK4~nXL6Pd_%BkA0uShe_<7r`Gi;q(p$ngobmJ6Y!W6Kx*( z;&xQ&SfpNd3|ATit(NS?0~$XMcT$7s0>BmcpMlZX`wOw+Low5fzejdsFd^h9G)YyV zBe5;1|Mux*RS2#)PW4ILLgy*}SRDE}U?7!h*r+tl{r5#1cwu2-XzmNmMRKd^!nJ!o z-ycVXZFuLxf-}vmNXhV<13Gv3DT`mLfbF8s`yX6G50S}@+bRe?DGFdneSt}6Oo92 zPHq0ey{YVyBFzW-r4RTRgFvOn4P|&)N2y#oWe#Wspzy{1Uu_E2?<-v{ZjKC+7%PMb zwVu|{?FA*e=q3VBxYT4~!dcJBaA69S?>K}#ZD6TJU5Q;12s&=_G&j&EJir+4f!m8h}S>8jF{w-ih0>PiE#R6 z|N4qj#s&3o#9Z=UY@*t?0c@RXROv-k@6pP(y0lNmv&j}oq%w|xvp|FA7h zh79>wB|TD1b&D2|2p7ICoS(Gf%lptMHEyluhRHqbh2lDHsWA>x}+A0W& zokpU1sy6p4q6vEhY%tziweoIyh_6Vl_E|)+u|}uVdNz&D-16SDV~twRKs;;}&k}z) zB%1ds^Or+GP<(22vLmum#7nfizp{vU`1M0!#s@!1y=a4)$3TM8hR>bAhtj@zXuFniD-Lx|7pgJr|QnN zpiVyD!Wa2ZQT5lCpI$F_<4ap_nBV>Rgp%8TMb>|4EJ8YqMR9xeCFU^3v-!JuY(=g3 z4ZrfbIl)+wn{PK_KECiv))#8IbYvLg2)$JrWioU=KgP;L z3K_d7GynV@{*kQmgiyV6^E*S)qQ;Se^w^EI@kOSqot}H9o^NXWn7CgK+}M8q5^5OG z5dTH~#&MQoc56#ht9MFp1(DkUG0F)Tf0H*Kf?7l*`Dj_69n9{Tyhi{kuGBrY8DP zPx{ASw@W^${3^OPaO+oe!I}0ODc8O%YBY8H6tro0bKm0lYs@EY={?+*h1F)zOlI4T z@no^Q@iy1h*AHfNp2U@R27P>;|G7f&)~dr@OUEDXpnnoOv~9@eqWu<&+q+vvNm|im zY|dLRKK*NY|K?RBZ}?$&+hZx zU(&|!xStW2EwK>x$}s-V{odxFpyo6xd;ijcprcQplDi3IRk#wxVvIfrQOL+R5VZlm ziWx>S<~rwzU0Gr5zYrsz_2s)8$M%DMgZiA*t7~VZvtJI<){-c9=ME~tui#HbST|GM z%|r^X6%6B_OUj&YTJTclwb8f`i@sNw50Ki@U$WOOAdQ z^!V$disUig%696bE2)>RuGLklL$<~RBVUxh)RMw*M;TpE3Qsw6Pn0lY+^Qm+mnr&T zRVPy#6N}WpOE}yJrTTTJU)e1`e7kuL#%C7MPf6Tm{-P<$ZYes(aq(Epmyo7D@yYgu z?2NOo8RvgOk8Dze>Nj1_g@by=2T`fAEPlHfjlNuaT1ah1K zWaz7uTuL&x+Z`DBdvcg-xnRvwjU`zs;5cE9dWdG>ERLG4iqFum0{R-p*4?@F!CGIX zH9eWY9lF>HZE(E95(Akk49g#t_GWrAXCaUijU7qO%}!sg!@3kWostkFi2ASm|O5jBqZYOC%P`45Y+?A?AJU;&Ic< z*Lye5#jSo~a_apleEj;{t?y^9I?e08`S4<19&1twUOz8MMKt53)d`tI?xJUaU9 zp4X)>hwh6VoZ7RbZbV=yf*cNpL!LmG926J}^VM2&3gxs?oX12)*k8We@x99Od*%al zTIRA#ZNQl=pTP3$G40mxk_UCR7d`UcjXH;Gfa+}~RW7%_TksF4s{IgskN37?@@PKj zlNaqtL|(qOWVMiqZ4+P1`>21)0mct~@Af~e$kaZ*W@El-cRslBNLu!y3-br_^V|+{ z5ni>LueMurHC{fHKdTua;OG2BeM;dW?U_Y?A;+`M!HFx$&6?tJo2u<|DniB>xQRy;iM%vFqO)&o`-J=VOy)-b9Ve+}sb!)*x2(i!>%J9&p^AR}sE?Fqp9Q z?ap24?F!!Cz9Rn&J$e}DEbJmX^7YGvV1IX<7?nC-|2q`vi<9uYF!F&W_7lT$>&C3> z*U^hb-vcdQFWC85_UnjVsD}qCM*L*{NV{0^!>p<3Vj%bT$rc}6@awmS-UFu#|IHsK zZa!K$z4d2yRr|Nuz2ZQnk?u*G$QSdg%n}{%3V^+X*h1-m6DgU_1LNe=&rW_nLTdlc zqg7w51^NG+k}UYva8>EL*3~~)r_P_}8UF2G_CGbf-uZs=g8i{j@%ywl$15(2(GPU~ z*^?PRtm!|Xb;I}%CPhyE@XU`{yL3AiwJZ!T*|{#4nY=If@F&3O)OZ2Va0Tfu{%wJK zdlK6eh<{W*(UzToE$47F@g46{H)!E&fWbzZ(L~w!M2pMhlfKU({h)GUkIQsVl?#)^ zrDpV8^G*AqB(C=nrSC6dNA$6Sy8@m^v?8;&#M{nGSf)#MuA%hRVv@_9K35ZT z8RS;!N)mR}9Q)U<^zR4kHzPOiI-jK+uW!rvk zZzh)Cu(;9w6XNME;TaazLOv7bWPQXbNZ1x$*d`0k&n-tRl@Y!Q&m1gs zo-GSgUiqZ8(xETn)#z5TQ>qfN7#&yKm*mR#bj71_#iPy5yvsdmuzWH=WOSiyR6qnO zQ4Y<*!tzUD<;&Z%A|6XC6>a5q2kwz4<;;`r=NGa5>!lmU6~x!2U;38Pi50x+t8Tc8 z$I%sK)}j#(tMmY!@N^*+y^7|ed9aTOi9Re7Rq{~3=1~+P%4A=TcNSsxUXkstU{Ng{ z<`te2E?Zn)Wq;^Cqb>|7Sam5~b=h=}ZCnj)t8lQYbSf?HcU*HOt|>mL=sjL49&#)B zGeGw7NTL4?1#rUb!a1&7O8v_Pz^O zIpaT19)>FTq8MVM67i4boJdSy{@?x+po;00=^#PE2@Z=Z4qHp^tWbP%1^%DA=fgo> zdd!syVS0eapMtTT;Op&GSEyB22E95a)`|Hmp&J5D?SxE3FMlc3fccBtw3GXW`=!uD zdwY+|_WhUH7n@EJG|coAQ4j?Hq6qIfpV6aTrw`ML$Kk+{yimhvf{Pi5-5Gq_8?1v7 zzNlJxQQMQK^u>jJquZQW+bki*rblz9r)ft|(>Xx_(7U(>6~&U118dmf(5M^t!M2jO z1fguUI7Fc@G9&(coz$Jynme6R8T~aGV^W#_;^oGrvNme6_I$Gz>x$EE%c zQ6#0dZk+G*zR+Kddn;i(y`j=AfJ2b9PP&z;3EGwRg=L%;7)lrB5=e1KDx46H>mc(2RGv0+ zc{;2jJ*i?6R%vn8dgZKZ=-qAlMxtBdI9w*k7 zEP=0!>8p#;uLrwEwXQ}<^o5NjZ_8$AnL!i_uhUHe3hS}(y=J~4d1w;?7NKkzV-ZHipfObWgz;T%ko zJ{|QFqn>qJh9; z-hDsm=V(^X`PYA(VX`GMXzY5|%(>2ao#*rMd|am}VS=oFmK;fe;mFSGgA8Gm5NN%j6%p~75t@fH=GpX@CT6oH z{SYF6D7ZOM6RD$~RH(KPjz$)h?!CL+BP=(#QbZL*kP3%-9_JH&ZVvDh5UVoOUtP$J zkM$dK@|(-`o15}m2lZR0^4kmz+iVIuTn#%y3cHdGyYdRZRT_S42HH0E3hSgI0^B!!`h4dIW!ykmIpWIjJ4ITR`2eT*e zTH!e8abF%9y`@WpAVGNPIJh{yZtrtz%=86fOsg7%3MI00lQGgwNXKmep~o`T6LLgB zVB??~viLA<$P@)hpqGxxYX48k-;wk*{M#Z-iM~sSCA}A=xV}jBUB+(GKq+Uf}oLcxN2?KHj&=wKik-7)=mseiHDcS8jA31x44HL?Kn;4e8cE=GZF~z@ z#j1y!nd*J(o&pMRH*$jQ>4OX7fwG(4RA z0uYF22n7S~TUbKCObqMIYCQ9HpO!`sa#h$s4h&h02juW51ew*lS$c(ho&}({>Cx@y z@D$v2Mj-gjF28iItoRGiQm_S<^uGt)j3)fiF0LYu1wqin;r^VW_U;SyN|RtmP-bcm z-tIRHO%c=3ZuiU;5F;}3Q|Sx8z!9#L2`7yqMh=B+m@8TM^|0{-fen7)C%{1VM{G7g zhqS{voC7B)ywL=40#TcpjIC_}{3s#_vH-n?zCx8|Ax37z=^?3bTmq2S3pl4SP5>-& z6dtO=k?48hUjzXljLj?zPiess@C0TkB8|4Gv=VkaJ}%I1qq9xqg6>~nCZ2Vqu$JJU zweo%fAPfrurU=#+?_os{m}|Mx0itqx4rMj?n*<)sLWNQ5@p3&k*hz?4B0LhH*@$m& zk`YHe`qf~-S!d}hjyZ^8wG9D}>E8JM12h9S#E==VM!Ud-4Ya&2wenEHHsh+U}S%5O^ z&LjpUvCQJg+(Z~NjUs9VM7<*@sI>wncx|m>=FT2{Gm-=I19(t)vcoNVBni$!U>*zb zpfv+&J^sv4Siu^ll>_@^=;}{Bh@jShefvIuK083+!z9SgY*$UY8f$SP#6X6$&aar%E z2>KAhb{}KL&gG2rTz;*9Kn-G&1a|g2^)G?ECZ83jg#06c_iEL`e&bFKCDbTBz9a~t z4|8c;?$TfVRT4O(S4$usY_Q#krp9xVMa79q4T+-eK%$a1Eb`fT#n-?Xp5gOLzIGz6 zg$82AzNm7zHI{kD1ZitRfOKr(VUewPZxGJm*ejmQHBZrBw<|x@Zxpv|C;}5xCrZBR=+r|AfQZ04Y}1}tlWbr05MA+^JP%7 zML>*^07pbGfSrNd{qXIG()*rdcAd zA8-RfM7H}$A^{e^>I&g_1`K`mgCZjC{B!vF5feg2dC0 zrQg8O_@wI+#+vGXjk@NnhZNrV8M9xc({On(NO;%dJe&p}) zGH_ua=TdIK_16(Q%hRuO18;Q4g5V5)(;EQ?^bm%Ni0BpTNf*&~GPWxr3JUC655(Dr zc)crrCF2Qo&ZOAFdxm4cYT*Xn{-K7ReZ-+jLAxBqI>lgQv73TJ5a zp}R2=Ank#EuI4|t-B?{Uzh(WxI}uxrXB@za&SMe3SCYHAoWXHt_qG<|@3LNnWE>st zz-?#@l&2>&P|Ik?B^*yl5`Z$9s9S`tQt#`wS(-Hx|Nk)u+7`|LI++ebg%bHv0yi znv|&xA~Kd6NmVS0nyytwBToMK{rT|*4conT3r^|#M#+bBC!Xx+J@^6Z2WVz}g(WON zMYF1uPyNNCtO7Vj@y=f)5d;`~JGBG#{7oD!h@i0A6DJ8b5fm{2z1C;8?`=bZmW&vI zS<38fHj&+-SRNJV0AOlx4}I&SH3QE*Dbyq0>n6$iLbiy)+_}4gDN|0#%9T`JW`G>b z#SW{^_(l@kzvrrbG7k_D&Gt_b@J+Q4Z;4(p6Erya{yC3)H zZLjzb;=Z*gN1rdsS<-@OkHQV5zu+!@l&?o@{=*jZWtC3Ys>;`V`=kEn+h=g1>IXY^&foXHyG@%Ibi(#R!?Qk0g~f?2M3 zTnPf+zWZJ=F2X2V=G^G3J8u-;v3P#sY+@~bK=@4ot#wSop*71p$jXMgS!Vble95t% zxb)(JR(m*(^JKn)%RyBFL=jd6uz;Pu)q@W*^6fSvS5%Sn`H&d9Rybgeiz^1mCummW zQJggneTY0m@AjKn#I2}22{BM!SofW8LCPH+H9%Y~%rjyKe+@S_a&<=tTVY`w=@09Yww`ciICsW@icraQb0pVKF zdx-W*=oUQ!?2LndLjcV8jmC^?MWEAh34qD!SFLMkt~f<)wFZM5AZbzh^JH0Aad{GR z2%L+Nr&lHbAac9w(-XR>TpA&)V48*s1CX&GOZ_iSrIwU}ZkGh#ZcJG|KtjIP^@I*v z3K#4FL=ou(?TT}7q=`Q9p>^{48$>WLc9brA;Np8+I>Zx=e#Ey5mTCh4CYA-@yD23t z#Xy)b2%NN#&<`mzC}0K55|}wF5Qh+E$eeSIE-;U{k@Nsq-ewm{OOxF+Ai;B9l7E&; zh#~Wh#k0NGK+$kms#=2Z+&z4XV}NM>4+QN|>*$Sh0#QDbN6O-4xR#fd(|^0J^imTFdlQ2%vZ`O`epXBHJS% zZhmj%DUmsqM^~bSUQjFmOQ|nXptH`5+DQOlMlnPJSg27W34OaAgo>>J;TylBq}#=3 z)aJE})4tQQt$=7ynL29{mMyCtA|rP@u3pBq{O=?KlxsfiRU{aYLJsjjx50X}#_wn{ zPw$hr2%sd8*Jd_I3FKAp)4O4`P*9?JC%b8$k3_+Z1R#>yDjY3J|^f>X1DfBok zN=--doOuG+io!+cfFDRtn(Z5cP{k7jK5-mz!ZFy0E;=JDj@}@0tz$?c%Kq_)L}#G$~cILYl%LX#s*G^5t~} zfM?RXsR)+&_cs85m2k*joPrC>PsJIY2@%`&4q!8&|HWwL5TKy!4Fq2fkY9HXHa=~q zQ4%5cC+wk^_R%OPk+;1!{i8QYRxdyG(z&3vR}~$Z%tj)BxIk^ZT?icAw79IP^YkhU z5hPlkBzx|T50?lJAddrc1YkjcBISnWOs{<<1DvG+mJ0xVjt@XY4urUHrDn?;W>;3Q z+KFU?anIEnp5&3B%25@)caB}n39n8-jn8O51qx}PM_0#|IO)amlp~RNhJv5MOLrKP zPr<|-+7H$@rlx!Vj$BLt0aoqFj_1tWQxx%^ivK)!Idy>p*afNb>Ss8=UckTQ)4NWm zV2?%s$VFf$6)z&n19iS;{Z{8f7Z|WzR?lU_079xLJZP%5MD+c4rxt5qH# z_v36uu*I*$kLxgWoPI1xMK5<-{WCt|ht`yLax7&>^1!9%D)CB0@tG21jCnahI?KNR z$^qAMX=j8!+y_M;XB)T@8Qxzn{EwMvL;&H#RI0f=srugc3Y%Ba0`X0Jt)UX%`Vz z<|R#Q43#7aGGB<+%+O#R)CL0~>O0P?DkShWM5|O`{}Ea)k5_j-@B;z_nIuPYMcg>F zq7i{fo=k{HP?CyJiX>7e4?WfIr@q6)3po7GL1=^-en_HJq71%evO9#F<=n}rYESiw^uXu&etY5ZHdjJ1NDHaRz!hrLdvIqI0=UlK`xA_| zZ;aOpPJS%~XvTxJ%n7(~be%qmTnY%BL2^z=FB7@TRf5lh0PF^n{xpsEd_kI7nER+>XJr!iH5Fa`ufG8yMxTpI~O-qx!Dwf zZom%;(wIR2{|#||ZNEh~N2-$1E0e(xJK|S3@RFEcouLU024PSV$UL;vIc{I2=zM3y zhz}wIhZ0?m8t^wC!sTD464r{&#U{x8NxKT zeGbj8c1A#r%v0R0dDWpM&)boy$y~lu*=nWYRe3HRc8}GAAA>3EXhk3{OKgKoiuD1} zMTzoPCO~6pZf^c(HSRA%_fN%;9Qc?+HI2665P-rMN+&Of57yP>k5%XmD@z+07$%b) zMge`=K@UFWv#m&Zc1Wfv7HTyWhW4;yw>?AY*Z;p&?3{f(Pm~ZjC|bu>k+s!8elXlM zg8z+8E-fe|2~m7e{GswQA>Bo^y@7{T4{6|#{kYd!?3~8=kP^;db||Ha^6_RykZ#-( zHf|A|8k|#VF5_vZz+Ieoe5@Flyr?# z5nxCKII@HuH&SP-Am<2}qZ5bb5(biG1Iz++~6Cfh4j}F-n z6(8DMGqpQL%Ri!@X7hh0Mxf1+HH?+DXDX+XN#zD89XPODU3u2Z3$Bl<$zZre6lF_7 zb2S2fTye+V#v*IjIy#rp_@Iq8q3?IC+U+7Y`$y1s3TLAQ57RP$pg299yaq--<5ouz z!@-Xu`M+SB?jj%efSsF-$b~7b4}P+VnV?v$wP)@ZtiHA?nG71HvSQ zlqkNql_1PyL(njA_6ZT(qpM${FhxKajB++S4PFb*p-~u98XpYFuys@YzRZJuNy^@K zFZ21su3=F;UI~JfRH&oc!(7Cz zYVkGL^@?s-ffMH$!xc508qGQofYEWn>Jf9cHRR1}gaZY_xnmij$dqOVnI1`Fdh#@? z!$1sxXPYs`G(y>E+tw-vPt{PB^{-yMozS<;khdlR+51hdlYnssV*wU6sV1p-sen1N z8B;2*;>-}xXfH4g5M~mUUdvdSU5=h-jBBjcowt~Z;xB|i?kh3{%mZ6}mb4Q1)<=`V zAcU(T*b|2`VlLu&%x)wK4#Y7&nt+=CpcWjeD#OgOks*NC9R>;$-i8I>3~41rFBdHN zCg9~62zi`+%u(xZGJ5X}u$BXjEnzG&gZG8n*n6Mn%79k{A+EoM4uM}?+C~&^!&>fW z-!ksZpHx=`D9IUWU*>_XV6c}t_)-u&8_5)p6LHTd#a9Upeeng5pul;?WW|RH^Jk+l zbsDs&GEIhLw|R!$-|Q*47iL66VFtp72)4{ntHz~qnZe>p5TRHo-QL*TX6OG71RG!7TPV4fk5Ikc(KGksm)P4 z=<0d!;R{WOBPCWw;?G3amriJv3F;rZhqH-gG+Nj!1IL#Zn!Us)fTc(XkexsInc?(1 zet-|YGbBO*PZRF#3}{%3w${3HP9{6R#U+Z9F+5@4@u>-Y$WCp)s2SbwNyA;Iib0p1 zIqRHp&gP&vtnMHSdO!Nz?{f8ya4t1PBL@zcwLLP?m^*e>?=za~lA=nl@~ihFLob6M zAgeUB9YpFHA8!WycPO)Q#<;TxAcLjQN?_$-poc-AyTcvL(fkPz_5(B*919c0RI#9# zt8fA6mrPM~Wq_z`N3!%vH!#xxuPYIyHbpJPP4Y zIXm<6CTkU-ln-LBYn)Y``~s_;eLdsUHV^kJf!76by}16LGR=Z9&it z8dj^q#bPFz$N)Ta0&zLKe_(+z6bX<0kMoHl+`k0Te;w6WC-gRki96hR6q~N~TDT(v zLDv(Kg1$Z1o?|W&BW~2a3}&IT2)BqchtBg&5lq=2u|M-nxCiJz8H{wZAg+-S`~>+C zJCgX1SG|Y_Yz(P9t7SzT)y@p}Caz_({mcOvbQgYBY5r<)`qg&# zS9{T~j;>#wbHBPy|6k^S>a;#^cYUa6eWYuBY;OJS>HlR8G&iQ4Ha_0n_*}H{rE6oh ze*O0R1u)1hO@1}XNi4h%xkUG$Mlmb$9KW1?Zq1>-pJH~LercA#_Z}wy*j)MfK!hW4 zbANO7-vbWX=4PAFHlGXY#vBF_yLMQ#1yR}#lHYk`zRiT+iGHvn?y`fO+)m!y;V#_{ z0PU8XZeOY0YCc`%qhSQnk+L^d6ofg>(za0I-&QVsLyBJAq6F+75_grp321d=&Icm# z-OIY)P&)5Ws@*Hb-AMH- zyC{W&z4`;Cg?*nJzZ@G-0mUf4bdg&MNcVS`h=vtQ+QD|$p_J0$8R50yViYMBMZCd% zr})q~^C)QU@NdBH2i-gNT7Osq|1bw1amD?)9m|m>j44PL$7+AkS<;JCQl}g19u2&Kz)_mC24Y7o*! zF}`23Ct~)l7))YoeQj0TRk`z4gtL7^c(Lj|SKxUWoXkh6+~^2r@`0PzM6gz_y!1s0 zpDF&ESl6%D!e{Mn(Ozq2nVB)OlS%Rz;QN&&29AFFy=#vgU+rEW&%Myydh^xp>ig%$ z#YNZuhHrj-6AKp>I+5L38ZXu_c6t-F`|AaBkT9*2<@1Y;@&^}sI_b+BT$q9~M8fUN zQpSX!qwiV9GEuUk@87EH3yQuG=_QUX?}(JqNCmu;6(x>Uf?Td7LLQRdkgfn~Bk-h?1+C^4L(BrmCxvOCOK zOg$&g(@%0?2HDZy;6T^R<4epD9B?=Yy*Ak>eBpVsfv7_m$LJZ>n)Aj5 zF}e(Y>OESoHd#U=Bbu?RnGi%sDTxD{)Wg*qO-P$aISQM+ioLL(WZ9}A!8}EVPD>ZL z6rHnH(Rm$G_0WN7WM$m;VpCYD3j5!d>B(qQRst@Db6U>gET4+5m28MR0|ct*%wV!- z*k&EESF<`T6%q5|v)r5g467i#VD57_Rajezht%5lnfM7Fl@y_}Gu2F>+f73mH)Pfz z_s~J!It9s&09DjKXHn%t7+NMmCHT1nw`*vB*5|HU{4&(*WC8W8vYb`yY7Qe1*)Phf zT#86xS{`!G5ZL5tpZD`0J-6V*J@CSHMrgqPGuOMP23|Arp3-ChbFK78vXLD)F|OB+ zlzvM^s}6DbP^MNZ(DHSZ2PWHQdT_mM8y{e9g} z;ncTS078*j0NR}}lpI9W3nP(yu zGY0`xV}}GBfj;4}#zb(t2>rw%ABUsdWcW#dt@g7s_~nq$`SMPzv|~39;VsFz1qT!F>y`9^D4zB$fjv zE^P6XA2*IV1_hD$Waf%-RzOjl9r=s^GU#F0o`<8zfZ=7+=G!^6>`@7&C|%P4#p{A5 z1{$77!0atHMNHX1#yS(sZUrEG9CQR>IGs0paS#sTV}9|aI8@Ry*JU#R&Vz$kE{egq zu^`mBj4=-;fFWL;f$bb6jyu~V1vzWu64`G`b+I&>`cG1S>%}njR4l8YamaORj&>^o!Pe^o8@ywcuvf9hpALMSg#P zf?;ALFkf^7ohBQ=5`*OQP?eJbt*y$rF@_#zeqKv)Z!>(7W9p?POVpQ+L&P54JI^MQ zAUi~5V?mlp8e}r)LPglyw!z2;&Pj2zqRhq8+Ng6%NNbHAV&=TR@O)7DtK=VdEgGu@ zg%)5!v!&omNI;Bb*Y2IWN2*P-Ux)K3$Bfg%wwR5P*nY5G`>G9acbh28fhVcv=`f3# zLB-sA85ukAK!X_+8seN}>fXzee$>Z+EH#F1&m&zjfH!*E2}S@Z(=CaD7TSUEu~aaq zI}jh7ZxPXNsweJsXYmrK@$T(?`LB4Z|z|muDye1;%s{88SQ^;hU@2xa)e+p zk$&HWv*szLtQI633jsAFX+VeQnUT@|VHPA2&!f~cv^s-W5Z+HjWSsANTLJC6qts4j zQoOP_gC2sNvxzs{&r*W_&Yh6Go8?8w|2Q^hB)~XX=zN-(6%NW--K(`L0%e_gg^dH^ zfYXU2bq+Fz6C8wbwb0I(z@jFPhz!sP5Mz1|gWM4jc4gRsz2zY*1O*;KfEhV5Hs>t5 zc^C48ni9_bt+CWMnBEE7e{UuV+AhhF#}1@BIH!ty&O3u2FeAq%onoIA+n1`p2u!}} zWO;=>d1*4`j|85^XT>c%ik3tkVCtN_dxgTg`fJ=jdS=box$pTs8Rwk42R(B2p-R=< zKwcSoT&oxE^joa^?}+}l?hjX);V-3Z*+sgQ+oUj?uf0!KB0kKlebfB=m7VX1-RP8m z^3CfJt)uPBrmr*)(5e3(rk;LyNYjxyeyy?ho8_$z?v)v(-I)@|i+f4Bco2#McXkI} z>t+h$+%6a0`Jf7t>t@S-&OX&yN_i~c3P})?swKZ>XGl zfkoF`8DSBIvOGbmvz+0c>b(ipWsB>#qf(E5bK<5Nt~mBz_0!d%&tX_G+gG4H#x(S; z@CIZ355Dv(toM_g2Qa0&XI|)*iw>Y&`kR7uojUbELj$WKeJn=0K7>Ap+5rtY{m_$s z#1uhxkzftgcf;trN7qGa=&OVc%>B}9>($Rh3~5CT>g)|hMH8G+dXj(j;#mfz7WF68 zhG_Li`b-@Lq{tzHtbxqqp?V(un{tC`iy8N!c&mcGbe5cq#gt6)V3zxkcbI`U3*iyL zAf{r-DBIA4S1X@I?}>n30gG&IG-ICCP*E6qrF<}7z(87T#A4Dgv)14h&d@M__(|>H zIY-0r+P-Je!!^qH6ZVENQ$|%*!wz)O2|8MiF>Y@k$yOXzAPhesw6*#Tx4AP`nCLY- zjudN*mPC&z?Tz3~`pE0XPiL$B$ys6UdF=vYACm|}CuMGn!#4{?HENAZ$wSoyuJYN@ zmm24~9Zg2ujVzl+EBi(Z#0jI(x?^J_rL#u2){XxD9r-vrIJ(|Hra>J~8#8G!rS*mB ze-hXKEN47G;QD4_9Jpr^HaVI-KYG_{?4zhjOUvLbmMd4Owjameit$rF{c^Bbs<`PIx$mIBY?&|-Z8g#8Ze|{4mO6FyaBpJW z#O(Lj_@>{))}8_4YuS#KInu*?Q|`)^#uY~0D-H8wJay*D(Qh-8uCNro{Qw=YF*F_d zYbL^K{!+l)SkC;p#w6S239QGc6zjNjUC)^d_hmS*u2)R_*EtEhWzLZ>`8sTjhIl%u z#Ce7J^1D2Y87u59`0KkvzxQ%yEm4;(&zM?HJAUBh{E)eOwWY)C`IwnFtBJ%v^9$o2 zI;Y)9O@wis@^Oj^L;m%;ccO67$AF z_3XO^ze$0ZNkIuSy?>_88rJ8YS_|l26|{aQ#L8ze{#a#WTGez~&D2PGRFz6;(DJZg zW3{xLp3;6JYn@=+)~w*Yr0VnLvYYi3YtA(1KkM_Y(<{G_Zjet$=ub9vAKVMA)#|35 z$EjX98fVr&>gtZ`!KU;*#xEzl*MxC8G(s-pn3E@<7q=mjvt@UmwvW}@E&pX(O;cO5Ng@gjsGETT zIS~rD*5^q!RZG^@{WFelY^=V@`U{#mFTe}L5QK?KfvpKl(&|l|2%c4t!Zui55fU17 zkHR_IBQe{1VYW|qmTEoQ?=d@YYj#k=@j7vK`04CO>+ER1V^7ZP*wXCV{n>Zcvu;TE zgv8hP7aW_$;B9}DnGFzL&LD_+5?4D&nn;pLB6&|F&Q5>*y7YB!|10eqY;K;D{v$42 znERnSH{Y7D=rOl^Yi=cBZq?f9=hL~h*12CEPS+b5)|cqa!Q34pf;mG0)EJM(A^ala z#MG*c#T}l#nYm;-`RtZO+*b>dL^d`F9QhDTN`g(CzsH9p)nKNNqd)COU%S_1Gwk}` zv16X8H&MnL%;;T9Uuu8i4Th?L#c^N(mv1ghlVC|3nJN2cX;W7Ut+aU)&H@k{X@q(s zMlUFyCmf>Lj$zkxFtdLjl<;m~VJ2gH#=7uBFzl*tztv4$=hoI**y$7@!4?~1Ejw;6 zmtb|AWA(R=0y?!qGE9p;x^cPgOWd0;^8U8853cT}4mY0K(wuWFT?EaZTyQwLZyj~v zld_)e9o-KH{zFprHX1qKiT}PIv$`1x{$P;%VRG43+3Dl$>pvV?T~r5LVhcaY7k$^N z|BmbWj{iu(UAECt5fGo#_B0*C2Ds`=e79I~Gdys+*mmvGfu+Wk_o|80(t1mUXBUe0 zrd87OThI)GM!9Gq~Asx!Ep%a?^CsKlSin_0$cp zapiKAy8F$pYr(hZ6T#+(pXZ{ArnBj=OT^cOky;Pot|jO|#r4WOCruBJq8mmkF0y*K zC^l`=InTq(Za1&Ex~N!~t2hTF(o^l8!(=Z>OIJtF@9~lzw9Cuik6OJHJUwyYp7=yh z+YQfzO3%at_v_-T#TQnQddpIVUgw;=uB^GFA1(NMSSO!;vY2zf!R6yDX5Y1H_;%H3Zq;~mRfKKrNxfHDky~*658bXGdYWF^ z_CDGHKeKNCyr1;5?eb6dgO%dDOFCSuSC@afTv>}{SWBP#QJVOxZ0=`y<*x=6FE>3e zgO3ZS)3FyHlUh9IAM5?}5z20Q>)sdsHaziXgpkj{53jXyuQv=Ubt-H1l3o;>HTNs4 zoe$jVoILBDJQ@N#8oB(MB>iqZT0bJJr<$!xc>1+HGOt};rxiT7nN{?Qbl{W!z`e76 z^~2oFcbhjS^n54VetnnU_z~_q)wNRn*2{R#%Ve`}TyOL3m5p~!8xsK=6sNVGD?hyt zHrH%6JUutO!Z&skH+~;@uMMp3e_TCSUOklbuRK`JC@LB~eV4`XeIa1IQYCQk?gs6n z&#Qx*3-vc&%KJUJ8?bla-{l#!eEMrgXyc`35ackB+1J}OY85$HGB(iLCK<-Q!UK2bw%E1;vG8C()r#BprdWC~?Q-1uhWyQ^HU6pX{z-2) z&cDl2zCoR?@Q~@+d^Q*SZ+ZJjFX)IZWT`7i>fJU}3W07=z$k1lI{t3({hbmS%JGR3 zQ+IizK2-Oe$6RG#bz9)Gfh}A`*z%8^WR-x@%}plmJ(0m6xUKDb9tTa^VCCZA=KA39 zflvocmzk3^TLn|2munWE_I^5r><{ez{kZEryC3*+)tm_6NFJFsy|%1cO~ELO2ty$tL*I>LbMKp6km!PO68)sL#JCB#?8WS(e_tW zZn?Y+xuOt$RVy4M&UEK$g#1=0Z|+t!cSNjIgq!N&iOLbpuK2fo`nqOUX!O9Xm;pay z1>Mc%2rI8$yuzXOy(8A#$V;V>7aDHmcI{B#26N@g25$9yeGrncb!fG@r$O7hoPKmm z|43^qBtz;T5q@;9$~Sr|Sb-L-6MGnC>wNBp9}jIi`RY*x_i-?H)IF&`Ql{B~sCeKUqVT%G$))u)E$dw-g;qT=@=+i21+BfP5z{hvidWH;Ql_!d?` zizsA|EK-ds&fV|6`Zs|)x=bp%T=gWsYX8iQJ=3O8j;>n~Z}(s5-=-V}e>gqDu}4`; zh1uNO6|V{&c^5YP?s-$XRy%jd+pXKrX@A1m|GrlJ3$Sm}L}P}h^m`3=X;=6xJ-~NHN{*Az6o;I953;etC&gRX%(5~(niPGN>0>j2{hovNi zb-pZnRh88-cy~7a??(D5x9aZ$I4!$-FGuy)qn8`G>HqTJh|6H;Y@do5r8^eRea>%n z`+v-Vuw;Svj_5$rsGQB%>W-MfJwcr;_x2`todjvyW|Nub($;7Nt(pR#-<9lfP*yg9 zsNYpX`8fZg?A1`|_a%mBx%|(BotY}ax#@A*@B2~5B}vZO2pE~_i`^;Iay_&JSsyF)(737?m~FyC6UowOjO8iisQmstP7G_b1+`TCJ90l!ujt?Rkb#CjMfU__mT%{8 zxHv@oJ-w+6)G>4ggPcxuG$@nC3T+d;bJ3`$wsz6W5_yv(+y%r!eC+hSukrQ3#3=4| z+V%~CsN6h|%(vIfl5(b|T{QJ<$B}57(ukVa{R>~(zsstwwTq=+K0b0wQ3pRO19bSJ z7WE8j3`UiVzSvbf)aVe)RD)EXL-H#T)r7nUb*pD%Xg4k#Ek(N<-Lpx+oVxSdxVSEX zun@sX>Ld2dm8VbcK92gB7ggW3VvKHnv|Mu2iQ7KkJwwq*lr54T{*$C?2c%vpdS#-pu#!o}CZ@8+ z`I&g($Ydi^{cVS4?7qyk7nB+a-xm|G@YjNJ;SP#5|3HT3r@mcTsOB=TY+tZMDqNQIT^*gy+hHcWO`r*%O&ASeo ze>IGq&yDy^@mXF!JL$F`z5NagfAfrbA@%inWBr>?S_X{8zJ^&@ajP_sJC(cNYPGvT zJ*O)l%9``}ZrtV8Nd~d6ZHCuwyg9H4d%b_qa66u$GW_Ywb(J~8KWDkVmFN4PYZ4T8 zTAZKcdNB3FPU1@NlKsQA_IdAcjX!3OZEvZUruIo4PN$dqPp`1OI9ArFsPeg8Qk`3O zdr>8xEqm2`*hysLEJ!GPMPWbSWK&D9duofF;YRC5+~3yYwqr>e*E;Kk;`!gQtn7z- zuTt;4IbsRCvAnAhSg){IcA^L z(d|U3u?6sN?)rRnCE}2e2&(+E+CgUHMVkUfrr+VOLoX;fpN$q1_#r*0{=Vr!c&C`q z@9IIdyTR#qPsFg0Geh`;;EY5KaZz;CV4iey=7ZYuJD=OBQm1EPkbi_&&)8}9X9mW` zIDEJKvf7U&^=FZIMVCjCI4orALG@0Aqy&Sja=nbFWn#X{|y_e2{_MPcr*oU{LKJaQSG&o?fv-}g!{a?_%8%-#Dypr-2D zN7JYMVa6~miFdiKEu~Vrl}eXJ-lVrpm3>+FF^TmZFZqHgUfo^%h*>oWkhxXtD#vW< zqiq$E7$zacdfm|D8h6qaLNQ!WDyAbPt6`TWUu%8&X2RG-^A?i$^W99Di_iF4&w?*J z-BiXJzgn}%d~bRGU{=lJ+sZpqR7ZU!zLhkBtun^RG8` z*!8+|RXwT5ll}YHoSOKkDVS5{c=h(Dp4+XB-5PQp=)buiN2bf0TQjZ+yE$Zi=W0U7Vopb6-8Y-2n^Uo(Ij;i?f8Bi2F7$)znE(gE4}}*#0K@zUVPos{>%KGcC12)6A&U+gqS|X*uar>e zI3sX=zyDR*PV(@bDXi43AxK*T(cEZ$hc9vr!FBGof}{HxNao1czovWE0xd{=PpVI1 zvt3AsyhJ>CxatCTvE{*6A(fABV2SH-xAL5ii+KBD+t%}Ayrhc9DIpqu`5|EsyJ0D=lY#a>nvaJmT6ny2J8ICG>dQiD&GmTSC2hA?!@v8L9ABTTo9n->ZepM{H(X|2H+uKyy<@oY6Oj#1!#?|- zMJ|=XQiHWiv6tSxa5`wm$NchN;rp7u+*;db`YZasj@kA{zgx2FULSEBez_WO(B&}h z7Q1!r>l@F*hOc#j@xS>O7BB9tTl@_SzS%jytrF38M&94@68H2uCd+k7qxReJpjr_fyBk z2`s#5NcJx3?sl&b{2BaQMpJsJS~=5&$lkL87Wepp9uDpDy@9Kmzau`KOm5!~gJotjmv|LruI!9qb(v1tvf~D;$*Ewl17HJ zHU^^E0@bj?VNW0uiWH@jKB*(THWrUMi9a8S!^)NNU(OPo6A|j2Jhvz!eBdIqSt`s> zhUMcBV|5kVpwFx82*l~AE@qk|w4seS=n!7Jwg(|jkd4MMdK1}aA%c8`@&1Lk&s=9Y zSJ)4m{oumMBM21@U#P0qxj-3|Snb8i})3%;$dCb)noTNZ>Vg@ z(lXSN$z6BTw}Yn3i<5=AmSqV>zDoqcl39_h`L!i;R}YIeu>-uWE#Es^83}`=r%9L5 zOld$p5eHjjs#hL$vOz#9D1^PI9f)Q70wUxy)aACZYa0|6J!CJp{6V7^TjETgL}zmH zd{N?@Pr-|tkUcwSqh1{_(V;j~a^e^|{oYFYf2{PMlMGm{ z4A_(mJg5vjl?-C23SyHA=Bf%7k_yRBrO%}^sgTbTdL>J)+SR&>Ov5w;dIhYUbUMM< z*|;<7-#L7Ft{1q8Y^0tU>k(ZQ(-F`S9qYlW^$nXyMID$Y53d+dGIhOmJcNdHPDrA) zMV4b;T*uH`HlqS2IF3jnhcc8K3qa?AyPV!pY}IqK5S9`gihv7cql&5lY|uDJK@SHL zOqrBSd@q&o))-5mpwa+#WdeGLg6afdY2YS=^xZ4og$vTk%iaV6gpoo-8c@pBsO%Vu zz$01~dAT}Wl3BwF=k>l99KE95sjW-|k%f5EWeAFY66h=529-UC1L#96RYZ;`WmK#f zlbPK7jQbM-QrRV1QOeXS?H^FZnX9tETQY-4v0B1*##CfB-*{rZ#ovI!>7IrqHy zieD?eB0n##f}=<@&MC-|TRHekMCH+O8G;!^&D%pbIT}PooXi_Zkrmj~+LRd?G5$XR zD+1L0!V)OXmI^#vKxe`O2Oxp~xC1RR#1-6to>s2TqNCL6?w*P)M0|k_48#~jp8y<# zI0!%^^a1l$KooRr;qq#Dc4@U_fd`lY3>a@7Xuv>70urQv1|WeQ)Mw>tYx$mTQfR{m z_<$HpfKUp63}k@-Bmw~30N^6Q*JkTE0;}Baul^pctCqwXWB?i501C*2A}qi_*nkv> zK@l*(hK^`3@sYl+Q;(YO`KpF3RDcqAfdi}{2*3eD5UpZdu#Q&numr*sxIyv?fGOz2 zD7b+PyFmn3lCL5y|6)Zim_ZdZCnDgaDa^18-{J|Q?^xmgaEeyvO(4P)s6jLgge%CN z08m00OhFp#$BmY3dFn6uvIhkRa6`BP7+^tK`hkru#2#FUqiQj*f^l-bF&xLS9M3Tw z*RdVnF&^i!9`7+9_pu-UF(3!BAP+Jj7qTHAG9o9kA}=x{H?ku?G9*W`Bu_FWSF$Bv zGA3uTCT}t)p9K_TCEg--a#Ii3RGcrTPGBAJ^2tXJFvl}O~G*9zNAVCJeg9qe54pTEX zcQZ(A0sue(03gCPd$T#8b3~}X0B}G)L^C?SGdj;X0RVh~F~hSx!}Av$fJ++jJ@<1m q_d*2>K|T93K_~M)lz; +Poincaré maps · TaylorIntegration.jl

    Poincaré maps

    In this example, we shall illustrate how to construct a Poincaré map associated with the surface of section $x=0$, $\dot x>0$, for $E=0.1025$ for the Hénon-Heiles system. This is equivalent to find the roots of an appropriate function g(dx, x, params, t). We illustrate the implementation using many initial conditions (Monte Carlo like implementation), and then compare the results with the use of jet transport techniques.

    Monte Carlo simulation

    The Hénon-Heiles system is a 2-dof Hamiltonian system used to model the (planar) motion of a star around a galactic center. The Hamiltonian is given by $H = (p_x^2+p_y^2)/2 + (x^2+y^2)/2 + \lambda (x^2y-y^3/3)$, from which the equations of motion can be obtained; below we concentrate in the case $\lambda=1$.

    # Hamiltonian
    +V(x,y) = 0.5*( x^2 + y^2 )+( x^2*y - y^3/3)
    +H(x,y,p,q) = 0.5*(p^2+q^2) + V(x, y)
    +H(x) = H(x...)
    +
    +# Equations of motion
    +function henonheiles!(dq, q, p, t)
    +    x, y, px, py = q
    +    dq[1] = px
    +    dq[2] = py
    +    dq[3] = -x-2y*x
    +    dq[4] = -y-(x^2-y^2)
    +    nothing
    +end

    We set the initial energy, which is a conserved quantity; x0 corresponds to the initial condition, which will be properly adjusted to be in the correct energy surface.

    # initial energy and initial condition
    +const E0 = 0.1025
    +x0 = [0.0, 0.45335, 0.0, 0.0]

    In order to be able to generate (random) initial conditions with the appropriate energy, we write a function px, which depends on x, y, py and the energy E, that returns the value of px>0 for which the initial condition [x, y, px, py] has energy E:

    # px: select px0>0 such that E=E0
    +px(x, E) = sqrt(2(E-V(x[1], x[2]))-x[4]^2)
    +
    +# px!: in-place version of px; returns the modified initial condition `x0`
    +function px!(x, E)
    +    mypx = px(x, E)
    +    x[3] = mypx
    +    return x
    +end
    +
    +# run px!
    +px!(x0, E0)
    4-element Vector{Float64}:
    + 0.0
    + 0.45335
    + 0.24817464176177093
    + 0.0

    Let's check that the initial condition x0 has actually energy equal to E0, up to roundoff accuracy:

    H(x0)
    0.1025

    The scalar function g, which may depend on the time t, the vector of dependent variables x, the velocities dx, and perhaps some parameters params, following again the convention of DifferentialEquations.jl, defines the surface of section by means of the condition $g(dx, x, params, t) = 0$. Internally, the function g is assumed to return a Tuple{Bool, Taylor1{T}}, where T corresponds to eltype(x[1]) (x::Vector{Taylor1{T}}). In the particular case that the user wishes to discard a particular crossing (or crossings), the function g must return a false value, as will be illustrated below.

    For the present example, we are looking for crossings through the surface $x=0$, which corresponds to x[1]==0, restricting the crossings to satisfy $\dot x > 0$. i.e., x[3]>0. We thus define the function g as

    # x=0, px>0 section
    +function g(dx, x, p, t)
    +    px_ = constant_term(x[3])
    +    # if px > 0...
    +    if px_ > zero(px_)
    +        return (true, x[1])
    +    else
    +        #otherwise, discard the crossing
    +        return (false, x[1])
    +    end
    +end
    Note

    Note that in the definition of g we want to make sure that we only take the "positive" crossings through the surface of section $x=0$; hence the if...else... block.

    We initialize some auxiliary arrays, where we shall save the solutions:

    # number of initial conditions
    +nconds = 100
    +tvSv = Vector{Vector{Float64}}(undef, nconds)
    +xvSv = Vector{Matrix{Float64}}(undef, nconds)
    +gvSv = Vector{Vector{Float64}}(undef, nconds)
    +x_ini = similar(x0)

    We generate nconds random initial conditions in a small neighborhood around x0 and integrate the equations of motion from t0=0 to tmax=135, using a polynomial of order 25 and absolute tolerance 1e-25:

    using TaylorIntegration
    +
    +for i in 1:nconds
    +    rand1 = rand()
    +    rand2 = rand()
    +    x_ini .= x0 .+ 0.005 .* [0.0, sqrt(rand1)*cos(2pi*rand2), 0.0, sqrt(rand1)*sin(2pi*rand2)]
    +    px!(x_ini, E0)   # ensure initial energy is E0
    +
    +    sol_i = taylorinteg(henonheiles!, g, x_ini, 0.0, 135.0,
    +        25, 1e-25, maxsteps=30000);
    +    tvSv[i] = vcat(0.0, sol_i.t)
    +    xvSv[i] = vcat(transpose(x_ini), sol_i.x)
    +    gvSv[i] = vcat(0.0, sol_i.gresids)
    +end

    We generate an animation with the solutions

    using Plots
    +poincare_anim1 = @animate for i=1:21
    +    scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), label="$(i-1)-th iterate",
    +        m=(1,stroke(0)), ratio=:equal)
    +    xlims!(0.09,0.51)
    +    ylims!(-0.11,0.11)
    +    xlabel!("y")
    +    ylabel!("py")
    +    title!("Hénon-Heiles Poincaré map (21 iterates)")
    +end
    Plots.Animation("/tmp/jl_jCESW4", ["000001.png", "000002.png", "000003.png", "000004.png", "000005.png", "000006.png", "000007.png", "000008.png", "000009.png", "000010.png"  …  "000012.png", "000013.png", "000014.png", "000015.png", "000016.png", "000017.png", "000018.png", "000019.png", "000020.png", "000021.png"])
    gif(poincare_anim1, "poincareanim1.gif", fps = 2)
    [ Info: Saved animation to /home/runner/work/TaylorIntegration.jl/TaylorIntegration.jl/docs/build/poincareanim1.gif

    Poincaré map for the Hénon Heiles system

    Jet transport

    Now, we illustrate the use of jet transport techniques in the same example, that is, we propagate a neighborhood around x0, which will be plotted in the Poincaré map. We first define the vector of small increments of the phase space variables, xTN; we fix the maximum order of the polynomial expansion in these variables to be 4. Then, x0TN is the neighborhood in the 4-dimensional phase space around $x0$.

    xTN = set_variables("δx δy δpx δpy", numvars=length(x0), order=4)
    +x0TN = x0 .+ xTN

    As it was shown above, $x0$ belongs to the energy surface $H(x0) = E_0 = 0.1025$; yet, as it was defined above, the set of phase space points denoted by x0TN includes points that belong to other energy surfaces. This can be noticed by computing H(x0TN)

    H(x0TN)
     0.1025 + 0.2478237775 δy + 0.24817464176177093 δpx + 0.9533499999999999 δx² + 0.046650000000000025 δy² + 0.5 δpx² + 0.5 δpy² + 1.0 δx² δy - 0.3333333333333333 δy³ + 𝒪(‖x‖⁵)

    Clearly, the expression above may contain points whose energy is different from E0. As it was done above, we shall fix the px component of x0TN so all points of the neighborhood are in the same energy surface.

    px!(x0TN, E0) # Impose that all variations are on the proper energy shell!
    +H(x0TN)
     0.1025 - 5.551115123125783e-17 δy² - 5.551115123125783e-17 δy³ - 1.7763568394002505e-15 δx² δy² - 4.440892098500626e-16 δy⁴ + 8.881784197001252e-16 δy² δpy² + 𝒪(‖x‖⁵)

    We notice that the coefficients of all monomials whose order is not zero are very small, and the constant_term is E0.

    In order to properly handle this case, we need to extend the definition of g to be useful for Taylor1{TaylorN{T}} vectors.

    #specialized method of g for Taylor1{TaylorN{T}}'s
    +function g(dx::Array{Taylor1{TaylorN{T}},1}, x::Array{Taylor1{TaylorN{T}},1},
    +        p, t) where {T<:Number}
    +    px_ = constant_term(constant_term(x[3]))
    +    if px_ > zero( T )
    +        return (true, x[1])
    +    else
    +        return (false, x[1])
    +    end
    +end

    We are now set to carry out the integration.

    solTN = taylorinteg(henonheiles!, g, x0TN, 0.0, 135.0, 25, 1e-25, maxsteps=30000);

    We define some auxiliary arrays, and then make an animation with the results for plotting.

    #some auxiliaries:
    +tvTN, xvTN, tvSTN, xvSTN, gvSTN = solTN.t, solTN.x, solTN.tevents, solTN.xevents, solTN.gresids
    +xvSTNaa = Array{Array{TaylorN{Float64},1}}(undef, length(tvSTN)+1 );
    +xvSTNaa[1] = x0TN
    +for ind in 2:length(tvSTN)+1
    +    whatever = xvSTN[ind-1,:]
    +    xvSTNaa[ind] = whatever
    +end
    +tvSTNaa = union([zero(tvSTN[1])], tvSTN);
    +
    +myrnd  = 0:0.01:1
    +npoints = length(myrnd)
    +ncrosses = length(tvSTN)
    +yS = Array{Float64}(undef, ncrosses+1, npoints)
    +pS = Array{Float64}(undef, ncrosses+1, npoints)
    +
    +myrad=0.005
    +ξy = @. myrad * cos(2pi*myrnd)
    +ξp = @. myrad * sin(2pi*myrnd)
    +
    +for indpoint in 1:npoints
    +    yS[1,indpoint] = x0[2] + ξy[indpoint]
    +    pS[1,indpoint] = x0[4] + ξp[indpoint]
    +    mycond = [0.0, ξy[indpoint], 0.0, ξp[indpoint]]
    +    for indS in 2:ncrosses+1
    +        temp = evaluate(xvSTNaa[indS], mycond)
    +        yS[indS,indpoint] = temp[2]
    +        pS[indS,indpoint] = temp[4]
    +    end
    +end
    +
    +poincare_anim2 = @animate for i=1:21
    +    scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), marker=(:circle, stroke(0)),
    +        markersize=0.01, label="Monte Carlo")
    +    plot!(yS[i,:], pS[i,:], width=0.1, label="Jet transport")
    +    xlims!(0.09,0.51)
    +    ylims!(-0.11,0.11)
    +    xlabel!("y")
    +    ylabel!("py")
    +    title!("Poincaré map: 4th-order jet transport vs Monte Carlo")
    +end
    Plots.Animation("/tmp/jl_6eEcFL", ["000001.png", "000002.png", "000003.png", "000004.png", "000005.png", "000006.png", "000007.png", "000008.png", "000009.png", "000010.png"  …  "000012.png", "000013.png", "000014.png", "000015.png", "000016.png", "000017.png", "000018.png", "000019.png", "000020.png", "000021.png"])
    gif(poincare_anim2, "poincareanim2.gif", fps = 2)
    [ Info: Saved animation to /home/runner/work/TaylorIntegration.jl/TaylorIntegration.jl/docs/build/poincareanim2.gif

    Poincaré map: Jet transport vs Monte Carlo

    The next animation is the same as before, adapting the scale.

    poincare_anim3 = @animate for i=1:21
    +    scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), marker=(:circle, stroke(0)),
    +        markersize=0.1, label="Monte Carlo")
    +    plot!(yS[i,:], pS[i,:], width=0.5, label="Jet transport")
    +    xlabel!("y")
    +    ylabel!("py")
    +    title!("Poincaré map: 4th-order jet transport vs Monte Carlo")
    +end
    Plots.Animation("/tmp/jl_Ok4fhx", ["000001.png", "000002.png", "000003.png", "000004.png", "000005.png", "000006.png", "000007.png", "000008.png", "000009.png", "000010.png"  …  "000012.png", "000013.png", "000014.png", "000015.png", "000016.png", "000017.png", "000018.png", "000019.png", "000020.png", "000021.png"])
    gif(poincare_anim3, "poincareanim3.gif", fps = 2)
    [ Info: Saved animation to /home/runner/work/TaylorIntegration.jl/TaylorIntegration.jl/docs/build/poincareanim3.gif

    Poincaré map: Jet transport vs Monte Carlo

    diff --git a/v0.16.1/search_index.js b/v0.16.1/search_index.js new file mode 100644 index 000000000..9b797ef04 --- /dev/null +++ b/v0.16.1/search_index.js @@ -0,0 +1,3 @@ +var documenterSearchIndex = {"docs": +[{"location":"root_finding/#rootfinding","page":"Poincaré maps","title":"Poincaré maps","text":"","category":"section"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"In this example, we shall illustrate how to construct a Poincaré map associated with the surface of section x=0, dot x0, for E=01025 for the Hénon-Heiles system. This is equivalent to find the roots of an appropriate function g(dx, x, params, t). We illustrate the implementation using many initial conditions (Monte Carlo like implementation), and then compare the results with the use of jet transport techniques.","category":"page"},{"location":"root_finding/#Monte-Carlo-simulation","page":"Poincaré maps","title":"Monte Carlo simulation","text":"","category":"section"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"The Hénon-Heiles system is a 2-dof Hamiltonian system used to model the (planar) motion of a star around a galactic center. The Hamiltonian is given by H = (p_x^2+p_y^2)2 + (x^2+y^2)2 + lambda (x^2y-y^33), from which the equations of motion can be obtained; below we concentrate in the case lambda=1.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"# Hamiltonian\nV(x,y) = 0.5*( x^2 + y^2 )+( x^2*y - y^3/3)\nH(x,y,p,q) = 0.5*(p^2+q^2) + V(x, y)\nH(x) = H(x...)\n\n# Equations of motion\nfunction henonheiles!(dq, q, p, t)\n x, y, px, py = q\n dq[1] = px\n dq[2] = py\n dq[3] = -x-2y*x\n dq[4] = -y-(x^2-y^2)\n nothing\nend\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We set the initial energy, which is a conserved quantity; x0 corresponds to the initial condition, which will be properly adjusted to be in the correct energy surface.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"# initial energy and initial condition\nconst E0 = 0.1025\nx0 = [0.0, 0.45335, 0.0, 0.0]\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"In order to be able to generate (random) initial conditions with the appropriate energy, we write a function px, which depends on x, y, py and the energy E, that returns the value of px>0 for which the initial condition [x, y, px, py] has energy E:","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"# px: select px0>0 such that E=E0\npx(x, E) = sqrt(2(E-V(x[1], x[2]))-x[4]^2)\n\n# px!: in-place version of px; returns the modified initial condition `x0`\nfunction px!(x, E)\n mypx = px(x, E)\n x[3] = mypx\n return x\nend\n\n# run px!\npx!(x0, E0)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"Let's check that the initial condition x0 has actually energy equal to E0, up to roundoff accuracy:","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"H(x0)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"The scalar function g, which may depend on the time t, the vector of dependent variables x, the velocities dx, and perhaps some parameters params, following again the convention of DifferentialEquations.jl, defines the surface of section by means of the condition g(dx x params t) = 0. Internally, the function g is assumed to return a Tuple{Bool, Taylor1{T}}, where T corresponds to eltype(x[1]) (x::Vector{Taylor1{T}}). In the particular case that the user wishes to discard a particular crossing (or crossings), the function g must return a false value, as will be illustrated below.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"For the present example, we are looking for crossings through the surface x=0, which corresponds to x[1]==0, restricting the crossings to satisfy dot x 0. i.e., x[3]>0. We thus define the function g as","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"# x=0, px>0 section\nfunction g(dx, x, p, t)\n px_ = constant_term(x[3])\n # if px > 0...\n if px_ > zero(px_)\n return (true, x[1])\n else\n #otherwise, discard the crossing\n return (false, x[1])\n end\nend\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"note: Note\nNote that in the definition of g we want to make sure that we only take the \"positive\" crossings through the surface of section x=0; hence the if...else... block.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We initialize some auxiliary arrays, where we shall save the solutions:","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"# number of initial conditions\nnconds = 100\ntvSv = Vector{Vector{Float64}}(undef, nconds)\nxvSv = Vector{Matrix{Float64}}(undef, nconds)\ngvSv = Vector{Vector{Float64}}(undef, nconds)\nx_ini = similar(x0)\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We generate nconds random initial conditions in a small neighborhood around x0 and integrate the equations of motion from t0=0 to tmax=135, using a polynomial of order 25 and absolute tolerance 1e-25:","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"using TaylorIntegration\n\nfor i in 1:nconds\n rand1 = rand()\n rand2 = rand()\n x_ini .= x0 .+ 0.005 .* [0.0, sqrt(rand1)*cos(2pi*rand2), 0.0, sqrt(rand1)*sin(2pi*rand2)]\n px!(x_ini, E0) # ensure initial energy is E0\n\n sol_i = taylorinteg(henonheiles!, g, x_ini, 0.0, 135.0,\n 25, 1e-25, maxsteps=30000);\n tvSv[i] = vcat(0.0, sol_i.t)\n xvSv[i] = vcat(transpose(x_ini), sol_i.x)\n gvSv[i] = vcat(0.0, sol_i.gresids)\nend\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We generate an animation with the solutions","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"using Plots\npoincare_anim1 = @animate for i=1:21\n scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), label=\"$(i-1)-th iterate\",\n m=(1,stroke(0)), ratio=:equal)\n xlims!(0.09,0.51)\n ylims!(-0.11,0.11)\n xlabel!(\"y\")\n ylabel!(\"py\")\n title!(\"Hénon-Heiles Poincaré map (21 iterates)\")\nend","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"gif(poincare_anim1, \"poincareanim1.gif\", fps = 2)\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"(Image: Poincaré map for the Hénon Heiles system)","category":"page"},{"location":"root_finding/#jettransport2","page":"Poincaré maps","title":"Jet transport","text":"","category":"section"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"Now, we illustrate the use of jet transport techniques in the same example, that is, we propagate a neighborhood around x0, which will be plotted in the Poincaré map. We first define the vector of small increments of the phase space variables, xTN; we fix the maximum order of the polynomial expansion in these variables to be 4. Then, x0TN is the neighborhood in the 4-dimensional phase space around x0.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"xTN = set_variables(\"δx δy δpx δpy\", numvars=length(x0), order=4)\nx0TN = x0 .+ xTN\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"As it was shown above, x0 belongs to the energy surface H(x0) = E_0 = 01025; yet, as it was defined above, the set of phase space points denoted by x0TN includes points that belong to other energy surfaces. This can be noticed by computing H(x0TN)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"H(x0TN)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"Clearly, the expression above may contain points whose energy is different from E0. As it was done above, we shall fix the px component of x0TN so all points of the neighborhood are in the same energy surface.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"px!(x0TN, E0) # Impose that all variations are on the proper energy shell!\nH(x0TN)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We notice that the coefficients of all monomials whose order is not zero are very small, and the constant_term is E0.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"In order to properly handle this case, we need to extend the definition of g to be useful for Taylor1{TaylorN{T}} vectors.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"#specialized method of g for Taylor1{TaylorN{T}}'s\nfunction g(dx::Array{Taylor1{TaylorN{T}},1}, x::Array{Taylor1{TaylorN{T}},1},\n p, t) where {T<:Number}\n px_ = constant_term(constant_term(x[3]))\n if px_ > zero( T )\n return (true, x[1])\n else\n return (false, x[1])\n end\nend\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We are now set to carry out the integration.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"solTN = taylorinteg(henonheiles!, g, x0TN, 0.0, 135.0, 25, 1e-25, maxsteps=30000);\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"We define some auxiliary arrays, and then make an animation with the results for plotting.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"#some auxiliaries:\ntvTN, xvTN, tvSTN, xvSTN, gvSTN = solTN.t, solTN.x, solTN.tevents, solTN.xevents, solTN.gresids\nxvSTNaa = Array{Array{TaylorN{Float64},1}}(undef, length(tvSTN)+1 );\nxvSTNaa[1] = x0TN\nfor ind in 2:length(tvSTN)+1\n whatever = xvSTN[ind-1,:]\n xvSTNaa[ind] = whatever\nend\ntvSTNaa = union([zero(tvSTN[1])], tvSTN);\n\nmyrnd = 0:0.01:1\nnpoints = length(myrnd)\nncrosses = length(tvSTN)\nyS = Array{Float64}(undef, ncrosses+1, npoints)\npS = Array{Float64}(undef, ncrosses+1, npoints)\n\nmyrad=0.005\nξy = @. myrad * cos(2pi*myrnd)\nξp = @. myrad * sin(2pi*myrnd)\n\nfor indpoint in 1:npoints\n yS[1,indpoint] = x0[2] + ξy[indpoint]\n pS[1,indpoint] = x0[4] + ξp[indpoint]\n mycond = [0.0, ξy[indpoint], 0.0, ξp[indpoint]]\n for indS in 2:ncrosses+1\n temp = evaluate(xvSTNaa[indS], mycond)\n yS[indS,indpoint] = temp[2]\n pS[indS,indpoint] = temp[4]\n end\nend\n\npoincare_anim2 = @animate for i=1:21\n scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), marker=(:circle, stroke(0)),\n markersize=0.01, label=\"Monte Carlo\")\n plot!(yS[i,:], pS[i,:], width=0.1, label=\"Jet transport\")\n xlims!(0.09,0.51)\n ylims!(-0.11,0.11)\n xlabel!(\"y\")\n ylabel!(\"py\")\n title!(\"Poincaré map: 4th-order jet transport vs Monte Carlo\")\nend","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"gif(poincare_anim2, \"poincareanim2.gif\", fps = 2)\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"(Image: Poincaré map: Jet transport vs Monte Carlo)","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"The next animation is the same as before, adapting the scale.","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"poincare_anim3 = @animate for i=1:21\n scatter(map(x->x[i,2], xvSv), map(x->x[i,4], xvSv), marker=(:circle, stroke(0)),\n markersize=0.1, label=\"Monte Carlo\")\n plot!(yS[i,:], pS[i,:], width=0.5, label=\"Jet transport\")\n xlabel!(\"y\")\n ylabel!(\"py\")\n title!(\"Poincaré map: 4th-order jet transport vs Monte Carlo\")\nend","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"gif(poincare_anim3, \"poincareanim3.gif\", fps = 2)\nnothing # hide","category":"page"},{"location":"root_finding/","page":"Poincaré maps","title":"Poincaré maps","text":"(Image: Poincaré map: Jet transport vs Monte Carlo)","category":"page"},{"location":"lorenz_lyapunov/#lyap_lorenz","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"","category":"section"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Here, we present the calculation of the Lyapunov spectrum of the Lorenz system, using TaylorIntegration.jl. The computation involves evaluating the 1st order variational equations dot xi = J cdot xi for this system, where J = operatornameDf is the Jacobian. By default, the numerical value of the Jacobian is computed using automatic differentiation techniques implemented in TaylorSeries.jl, which saves us from writing down explicitly the Jacobian. Conversely, this can be used to check a function implementing the Jacobian. As an alternative, specially important if performance is critical, the user may provide a Jacobian function.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"The Lorenz system is the ODE defined as:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"beginaligned\n dotx_1 = sigma(x_2-x_1) \n dotx_2 = x_1(rho-x_3)-x_2 \n dotx_3 = x_1x_2-beta x_3\nendaligned","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"where sigma, rho and beta are constant parameters.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"First, we write a Julia function which evaluates (in-place) the Lorenz system:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"#Lorenz system ODE:\nfunction lorenz!(dq, q, params, t)\n σ, ρ, β = params\n x, y, z = q\n dq[1] = σ*(y-x)\n dq[2] = x*(ρ-z)-y\n dq[3] = x*y-β*z\n nothing\nend\nnothing #hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Below, we use the the parameters sigma = 160, beta = 4 and rho = 4592.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"#Lorenz system parameters\n#we use the `const` prefix in order to help the compiler speed things up\nconst params = [16.0, 45.92, 4.0]\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"We define the initial conditions, the initial and final integration times for the integration:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"const x0 = [19.0, 20.0, 50.0] #the initial condition\nconst t0 = 0.0 #the initial time\nconst tmax = 100.0 #final time of integration\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Since the diagonal of the Jacobian is constant, the sum of the Lyapunov spectrum has to be equal to that value. We calculate this trace using TaylorSeries.jl, and after the numerical integration, we will come back to check if this value is conserved (or approximately conserved) as a function of time.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"# Note that TaylorSeries.jl is @reexport-ed by TaylorIntegration.jl\n# Calculate trace of Lorenz system Jacobian via TaylorSeries.jacobian:\nimport LinearAlgebra: tr\nusing TaylorIntegration\nxi = set_variables(\"δ\", order=1, numvars=length(x0))\nx0TN = x0 .+ xi\ndx0TN = similar(x0TN)\nlorenz!(dx0TN, x0TN, params, t0)\njjac = TaylorSeries.jacobian(dx0TN)\nlorenztr = tr(jjac) #trace of Lorenz system Jacobian matrix\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"As explained above, the user may provide a function which computes the Jacobian of the ODE in-place:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"#Lorenz system Jacobian (in-place):\nfunction lorenz_jac!(jac, x, params, t)\n σ, ρ, β = params\n jac[1,1] = -σ + zero(x[1])\n jac[1,2] = σ + zero(x[1])\n jac[1,3] = zero(x[1])\n jac[2,1] = ρ - x[3]\n jac[2,2] = -1.0 + zero(x[1])\n jac[2,3] = -x[1]\n jac[3,1] = x[2]\n jac[3,2] = x[1]\n jac[3,3] = -β + zero(x[1])\n nothing\nend\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"note: Note\nWe use of zero(x[1]) in the function lorenz_jac! when the RHS consists of a numeric value; this is needed to allow the proper promotion of the variables to carry out Taylor's method.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"We can actually check the consistency of lorenz_jac! with the computation of the jacobian using automatic differentiation techniques. Below we use the initial conditions x0, but it is easy to generalize this.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"lorenz_jac!(jjac, x0, params, t0) # update the matrix `jjac` using Jacobian provided by the user\nTaylorSeries.jacobian(dx0TN) == jjac # `dx0TN` is obtained via automatic differentiation","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Now, we are ready to perform the integration using lyap_taylorinteg function, which integrates the 1st variational equations and uses Oseledets' theorem. The expansion order will be 28 and the local absolute tolerance will be 10^-20. lyap_taylorinteg will return three arrays: one with the evaluation times, one with the values of the dependent variables (at the time of evaluation), and another one with the values of the Lyapunov spectrum.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"We first carry out the integration computing internally the Jacobian","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"sol = lyap_taylorinteg(lorenz!, x0, t0, tmax, 28, 1e-20, params; maxsteps=2000000);\ntv, xv, λv = sol.t, sol.x, sol.λ\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Now, the integration is obtained exploiting lorenz_jac!:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"sol_ = lyap_taylorinteg(lorenz!, x0, t0, tmax, 28, 1e-20, params, lorenz_jac!; maxsteps=2000000);\ntv_, xv_, λv_ = sol_.t, sol_.x, sol_.λ\nnothing # hide","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"In terms of performance the second method is about ~50% faster than the first.","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"We check the consistency of the orbits computed by the two methods:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"tv == tv_, xv == xv_, λv == λv_","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"As mentioned above, a more subtle check is related to the fact that the trace of the Jacobian is constant in time, which must coincide with the sum of all Lyapunov exponents. Using its initial value lorenztr, we compare it with the final Lyapunov exponents of the computation, and obtain","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"sum(λv[end,:]) ≈ lorenztr, sum(λv_[end,:]) ≈ lorenztr, sum(λv[end,:]) ≈ sum(λv_[end,:])","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Above we checked the approximate equality; we now show that the relative error is quite small and comparable with the local machine epsilon value around lorenztr:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"abs(sum(λv[end,:])/lorenztr - 1), abs(sum(λv_[end,:])/lorenztr - 1), eps(lorenztr)","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"Therefore, the numerical error is dominated by roundoff errors in the floating point arithmetic of the integration. We will now proceed to plot our results. First, we plot Lorenz attractor in phase space","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"using Plots\nplot(xv[:,1], xv[:,2], xv[:,3], leg=false)","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"We display now the Lyapunov exponents as a function of time:","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"using Plots\nnothing # hide\nplot(tv, λv[:,1], label=\"L_1\", legend=:right)\nplot!(tv, λv[:,2], label=\"L_2\")\nplot!(tv, λv[:,3], label=\"L_3\")\nxlabel!(\"time\")\nylabel!(\"L_i, i=1,2,3\")\ntitle!(\"Lyapunov exponents vs time\")","category":"page"},{"location":"lorenz_lyapunov/","page":"Lyapunov spectrum of Lorenz system","title":"Lyapunov spectrum of Lorenz system","text":"This plot shows that the calculation of the Lyapunov exponents has converged.","category":"page"},{"location":"pendulum/#pendulum","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"","category":"section"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"In this example we illustrate the use of jet transport techniques in TaylorIntegration.jl for the simple pendulum. We propagate a neighborhood U_0 around an initial condition q_0 parametrized by the sum q_0+xi, where q_0=(x_0p_0) represents the coordinates of the initial condition in phase space, and xi=(xi_1xi_2) represents an small variation with respect to this initial condition. We re-interpret each component of the sum q_0+xi as a multivariate polynomial in the variables xi_1 and xi_2; below, the maximum order of the multivariate polynomial is fixed at 8. We propagate these multivariate polynomials in time using Taylor's method.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The simple pendulum is defined by the Hamiltonian H(x p) = frac12p^2-cos x; the corresponding equations of motion are given by","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"beginaligned\ndotx = p \ndotp = -sin x\nendaligned","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"We integrate this problem for a neighborhood U_0 around the initial condition q_0 = (x(t_0) p(t_0)) = (x_0 p_0). For concreteness we take p_0=0 and choose x_0 such that the pendulum librates; that is, we will choose a numerical value for the energy E=H(x_0p_0)=-cos x_0 such that the pendulum's motion in phase space is \"below\" (inside) the region bounded by the separatrix. In this case, the libration period T of the pendulum is","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"T=frac4sqrt2int_0^x_0fracdxsqrtcos x_0-cos x","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"which can be expressed in terms of the complete elliptic integral of the first kind, K:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"T=4K(sin(x_02))","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The Hamiltonian for the simple pendulum is:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"H(x) = 0.5x[2]^2-cos(x[1])\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The equations of motion are:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"function pendulum!(dx, x, p, t)\n dx[1] = x[2]\n dx[2] = -sin(x[1])\nend\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"We define the TaylorN variables necessary to perform the jet transport; varorder represents the maximum order of expansion in the variations xi.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"const varorder = 8\nusing TaylorIntegration\nξ = set_variables(\"ξ\", numvars=2, order=varorder)","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"Note that TaylorSeries.jl is @reexport-ed internally by TaylorIntegration.jl.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The nominal initial condition is:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"q0 = [1.3, 0.0]","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The corresponding initial value of the energy is:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"H0 = H(q0)","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The parametrization of the neighborhood U_0 is represented by","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"q0TN = q0 .+ ξ","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"To understand how the jet transport technique works, we shall evaluate the Hamiltonian at q_0+xi in order to obtain the 8-th order Taylor expansion of the Hamiltonian with respect to the variations xi, around the initial condition q_0:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"H(q0TN)","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"Note that the 0-th order term of the expression above is equal to the value H(q0), as expected.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"Below, we set some parameters for the Taylor integration. We use a method of taylorinteg which returns the solution at t0, t0+integstep, t0+2integstep,...,tmax, where t0 and tmax are the initial and final times of integration, whereas integstep is a time interval chosen by the user; we use the variable tv = t0:integstep:tmax for this purpose and choose integstep as fracT8.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"order = 28 #the order of the Taylor expansion wrt time\nabstol = 1e-20 #the absolute tolerance of the integration\nusing Elliptic # we use Elliptic.jl to evaluate the elliptic integral K\nT = 4*Elliptic.K(sin(q0[1]/2)^2) #the libration period\nt0 = 0.0 #the initial time\ntmax = 6T #the final time\nintegstep = T/8 #the time interval between successive evaluations of the solution vector\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"We perform the Taylor integration using the initial condition x0TN, during 6 periods of the pendulum (i.e., 6T), exploiting multiple dispatch:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"tv = t0:integstep:tmax # the times at which the solution will be evaluated\nsol = taylorinteg(pendulum!, q0TN, tv, order, abstol)\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"The integration above works for any initial neighborhood U_0 around the nominal initial condition q_0, provided it is sufficiently small.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"We will consider the particular case where U_0 is a disk of radius r = 005, centered at q_0; that is U_0= q_0+xixi=(rcosphirsinphi) phiin02pi) for a given radius r0. We will denote by U_t the propagation of the initial neighborhood U_0 evaluated at time t. Also, we denote by q(t) the coordinates of the nominal solution at time t: q(t)=(x(t)p(t)). Likewise, we will denote the propagation at time t of a given initial variation xi_0 by xi(t). Then, we can compute the propagation of the boundary partial U_t of the neighborhood U_t.","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"polar2cart(r, ϕ) = [r*cos(ϕ), r*sin(ϕ)] # convert radius r and angle ϕ to cartesian coordinates\nr = 0.05 #the radius of the neighborhood\nϕ = 0.0:0.1:(2π+0.1) #the values of the angle\nξv = polar2cart.(r, ϕ)\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"We evaluate the jet at partial U_x(t) (the boundary of U_x(t)) at each value of the solution array sol.x; we organize these values such that we can plot them later:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"xjet_plot = map(λ->λ.(ξv), sol.x[:,1])\npjet_plot = map(λ->λ.(ξv), sol.x[:,2])\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"Above, we have exploited the fact that Array{TaylorN{Float64}} variables are callable objects. Now, we evaluate the jet at the nominal solution, which corresponds to xi=(00), at each value of the solution vector sol.x:","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"x_nom = sol.x[:,1]()\np_nom = sol.x[:,2]()\nnothing # hide","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"Finally, we shall plot the nominal solution (black dots), as well as the evolution of the neighborhood U_0 (in colors), each frac18th of a period T. The initial condition corresponds to the black dot situated at q_0=(130)","category":"page"},{"location":"pendulum/","page":"Jet transport: the simple pendulum","title":"Jet transport: the simple pendulum","text":"using Plots\nplot( xjet_plot, pjet_plot,\n xaxis=(\"x\",), yaxis=(\"p\",),\n title=\"Simple pendulum phase space\",\n leg=false, aspect_ratio=1.0\n)\nscatter!( x_nom, p_nom,\n color=:black,\n m=(1,2.8,stroke(0))\n)","category":"page"},{"location":"jet_transport/#jettransport","page":"Jet transport","title":"Jet transport","text":"","category":"section"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"In this section we describe the jet transport capabilities included in TaylorIntegration.jl. Jet transport is a tool that allows the propagation under the flow of a small neighborhood in phase space around a given initial condition, instead of propagating a single initial condition only.","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"To compute the propagation of mathbfx_0 + delta mathbfx, where delta mathbfx are independent small displacements in phase space around the initial condition mathbfx_0, one has to solve high-order variational equations. The idea is to treat mathbfx_0 + delta mathbfx as a truncated polynomial in the delta mathbfx variables. The maximum order of this polynomial has to be fixed in advance.","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"Jet transport works in general with any ordinary ODE solver, provided the chosen solver supports computations using multi-variate polynomial algebra.","category":"page"},{"location":"jet_transport/#A-simple-example","page":"Jet transport","title":"A simple example","text":"","category":"section"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"Following D. Pérez-Palau et al [1], let us consider the differential equations for the harmonic oscillator:","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"beginaligned\ndotx = y \ndoty = -x\nendaligned","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"with the initial condition mathbfx_0=x_0 y_0^T. We illustrate jet transport techniques using Euler's method","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"mathbfx_n+1 = mathbfx_n + h mathbff(mathbfx_n)","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"Instead of considering the initial conditions mathbfx_0, we consider the time evolution of the polynomial","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"P_0mathbfx_0(deltamathbfx) = x_0+delta x y_0 + delta y^T","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"where delta x and delta y are small displacements. Below we concentrate in polynomials of order 1 in delta x and delta y; since the equations of motion of the harmonic oscillator are linear, there are no higher order terms.","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"Using Euler's method we obtain","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"beginaligned\n mathbfx_1 =\n left(\n beginarrayc\n x_0 + h y_0 \n y_0 - h x_0\n endarray\n right)\n + left(\n beginarraycc\n 1 h \n -h 1\n endarray\n right)\n left(\n beginarrayc\n delta x\n delta y\n endarray\n right) \n mathbfx_2 =\n left(\n beginarrayc\n 1-h^2 x_0 + 2 h y_0 \n 1-h^2 y_0 - 2 h x_0\n endarray\n right)\n + left(\n beginarraycc\n 1-h^2 2 h \n -2 h 1-h^2\n endarray\n right)\n left(\n beginarrayc\n delta x\n delta y\n endarray\n right)\nendaligned","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"The first terms in the expressions for mathbfx_1 and mathbfx_2 above correspond to the result of an Euler integration step using the initial conditions only. The other terms are the (linear) corrections which involve the small displacements delta x and delta y.","category":"page"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"In general, for differential equations involving non-linear terms, the resulting expansions in delta x and delta y will reflect aspects of the non-linearities of the ODEs. Clearly, jet transport techniques allow to address stability properties beyond the linear case, though memory constraints may play a role. See this example illustrating the implementation for the simple pendulum, and this one illustrating the construction of a Poincaré map with Jet transport techniques.","category":"page"},{"location":"jet_transport/#refsJT","page":"Jet transport","title":"References","text":"","category":"section"},{"location":"jet_transport/","page":"Jet transport","title":"Jet transport","text":"[1] D. Pérez-Palau, Josep J. Masdemont, Gerard Gómez, 2015, Celest. Mech. Dyn. Astron. 123, 239.","category":"page"},{"location":"api/#Library","page":"API","title":"Library","text":"","category":"section"},{"location":"api/","page":"API","title":"API","text":"","category":"page"},{"location":"api/","page":"API","title":"API","text":"CurrentModule = TaylorIntegration","category":"page"},{"location":"api/#Exported-functions","page":"API","title":"Exported functions","text":"","category":"section"},{"location":"api/","page":"API","title":"API","text":"taylorinteg\nlyap_taylorinteg\n@taylorize","category":"page"},{"location":"api/#TaylorIntegration.taylorinteg","page":"API","title":"TaylorIntegration.taylorinteg","text":"taylorinteg(f, x0, t0, tmax, order, abstol, params[=nothing]; kwargs... )\n\nGeneral-purpose Taylor integrator for the explicit ODE dotx=f(x p t), where p are the parameters encoded in params. The initial conditions are specified by x0 at time t0; x0 may be of type T<:Number or Vector{T}, with T including TaylorN{T}; the latter case is of interest for jet transport applications.\n\nThe equations of motion are specified by the function f; we follow the same convention of DifferentialEquations.jl to define this function, i.e., f(x, p, t) or f!(dx, x, p, t); see the examples below.\n\nThe functions returns a TaylorSolution, whose fields are t and x; they represent, respectively, a vector with the values of time (independent variable), and a vector with the computed values of the dependent variable(s). When the keyword argument dense is set to true, it also outputs in the field p the Taylor polynomial expansion computed at each time step. The integration stops when time is larger than tmax, in which case the last returned value(s) correspond to tmax, or when the number of saved steps is larger than maxsteps.\n\nThe integration method uses polynomial expansions on the independent variable of order order; the parameter abstol serves to define the time step using the last two Taylor coefficients of the expansions. Make sure you use a large enough order to assure convergence.\n\nCurrently, the recognized keyword arguments are:\n\nmaxsteps[=500]: maximum number of integration steps.\nparse_eqs[=true]: use the specialized method of jetcoeffs! created with @taylorize.\ndense[=true]: output the Taylor polynomial expansion at each time step.\n\nExamples\n\nFor one dependent variable the function f defines the RHS of the equation of motion, returning the value of dotx. The arguments of this function are (x, p, t), where x are the dependent variables, p are the paremeters and t is the independent variable.\n\nFor several (two or more) dependent variables, the function f! defines the RHS of the equations of motion, mutating (in-place) the (preallocated) vector with components of dotx. The arguments of this function are (dx, x, p, t), where dx is the preallocated vector of dotx, x are the dependent variables, p are the paremeters entering the ODEs and t is the independent variable. The function may return this vector or simply nothing.\n\nusing TaylorIntegration\n\nf(x, p, t) = x^2\n\nsol = taylorinteg(f, 3, 0.0, 0.3, 25, 1.0e-20, maxsteps=100 )\n\nfunction f!(dx, x, p, t)\n for i in eachindex(x)\n dx[i] = x[i]^2\n end\n return nothing\nend\n\nsol = taylorinteg(f!, [3, 3], 0.0, 0.3, 25, 1.0e-20, maxsteps=100 )\n\nsol = taylorinteg(f!, [3, 3], 0.0, 0.3, 25, 1.0e-20, maxsteps=100, dense=true )\n\n\n\n\n\n","category":"function"},{"location":"api/#TaylorIntegration.lyap_taylorinteg","page":"API","title":"TaylorIntegration.lyap_taylorinteg","text":"lyap_taylorinteg(f!, q0, t0, tmax, order, abstol[, jacobianfunc!=nothing];\n maxsteps::Int=500, parse_eqs::Bool=true)\nlyap_taylorinteg(f!, q0, trange, order, abstol[, jacobianfunc!=nothing];\n maxsteps::Int=500, parse_eqs::Bool=true)\n\nSimilar to taylorinteg for the calculation of the Lyapunov spectrum. Note that the number of TaylorN variables should be set previously by the user (e.g., by means of TaylorSeries.set_variables) and should be equal to the length of the vector of initial conditions q0. Otherwise, whenever length(q0) != TaylorSeries.get_numvars(), then lyap_taylorinteg throws an AssertionError. Optionally, the user may provide a Jacobian function jacobianfunc! to evaluate the current value of the Jacobian. Otherwise, the current value of the Jacobian is computed via automatic differentiation using TaylorSeries.jl.\n\n\n\n\n\n","category":"function"},{"location":"api/#TaylorIntegration.@taylorize","page":"API","title":"TaylorIntegration.@taylorize","text":"@taylorize expr\n\nThis macro evals the function given by expr and defines a new method of jetcoeffs! which is specialized on that function. Integrating via taylorinteg of lyap_taylorinteg after using the macro yields better performance.\n\nSee the documentation for more details and limitations.\n\nwarning: Warning\nThis macro is on an experimental stage; check the integration results carefully.\n\n\n\n\n\n","category":"macro"},{"location":"api/#Exported-types","page":"API","title":"Exported types","text":"","category":"section"},{"location":"api/","page":"API","title":"API","text":"TaylorSolution","category":"page"},{"location":"api/#TaylorIntegration.TaylorSolution","page":"API","title":"TaylorIntegration.TaylorSolution","text":"TaylorSolution{T, U, N, VT<:AbstractVector{T}, AX<:AbstractArray{U,N}, P<:Union{Nothing, AbstractArray{Taylor1{U}, N}}, VTE<:Union{Nothing, AbstractVector{U}}, AXE<:Union{Nothing, AbstractArray{U, N}}, VΛ<:Union{Nothing, AbstractArray{U,N}}} <: AbstractTaylorSolution{T, U}\n\nThis struct represents the return type for taylorinteg. Fields t and x represent, respectively, a vector with the values of time (independent variable), and a vector with the computed values of the dependent variable(s). When taylorinteg is called with dense=true, then field p stores the Taylor polynomial expansion computed at each time step. Fields tevents, xevents and gresids are related to root-finding methods of taylorinteg, while λ is related to the output of lyap_taylorinteg.\n\n\n\n\n\n","category":"type"},{"location":"api/#Internal","page":"API","title":"Internal","text":"","category":"section"},{"location":"api/","page":"API","title":"API","text":"Modules = [TaylorIntegration]\nPublic = false","category":"page"},{"location":"api/#TaylorIntegration.BookKeeping","page":"API","title":"TaylorIntegration.BookKeeping","text":"BookKeeping\n\nMutable struct that contains all the bookkeeping vectors/dictionaries used within _make_parsed_jetcoeffs: - d_indx : Dictionary mapping new variables (symbols) to old (perhaps indexed) symbols - d_assign : Dictionary with the numeric assignments (that are substituted) - d_decl : Dictionary declared arrays - v_newvars : Symbols of auxiliary indexed vars - v_arraydecl: Symbols which are explicitly declared as Array or Vector - v_array1 : Symbols which are explicitly declared as Array{Taylor1{T},1} - v_array2 : Symbols which are explicitly declared as Array{Taylor1{T},2} - v_array3 : Symbols which are explicitly declared as Array{Taylor1{T},3} - v_array4 : Symbols which are explicitly declared as Array{Taylor1{T},4} - v_preamb : Symbols or Expr used in the preamble (declarations, etc) - retvar : Guessed returned variable, which defines the LHS of the ODEs\n\n\n\n\n\n","category":"type"},{"location":"api/#TaylorIntegration.RetAlloc","page":"API","title":"TaylorIntegration.RetAlloc","text":"RetAlloc{T <: Number}\n\nStruct related to the returned variables that are pre-allocated when @taylorize is used. - v0 : Array{T,1} - v1 : Vector{Array{T,1}} - v2 : Vector{Array{T,2}} - v3 : Vector{Array{T,3}} - v4 : Vector{Array{T,4}}\n\n\n\n\n\n","category":"type"},{"location":"api/#TaylorIntegration.__jetcoeffs!-Union{Tuple{U}, Tuple{Val{false}, Any, Any, Taylor1{U}, Any, TaylorIntegration.RetAlloc{Taylor1{U}}}} where U","page":"API","title":"TaylorIntegration.__jetcoeffs!","text":"__jetcoeffs!(::Val{false}, f, t, x, params, rv)\n__jetcoeffs!(::Val{true}, f, t, x, params, rv)\n__jetcoeffs!(::Val{false}, f, t, x, dx, xaux, params, rv)\n__jetcoeffs!(::Val{true}, f, t, x, dx, xaux, params, rv)\n\nChooses a method of jetcoeffs! (hard-coded) or the generated by @taylorize) depending on Val{bool} (bool::Bool).\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._allocated_defs!-Tuple{Expr, TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._allocated_defs!","text":"_allocated_defs!(new_jetcoeffs, bkkeep)\n\nAdd allocated variable definitions to new_jetcoeffs, to make it more human readable.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._capture_fn_args_body!","page":"API","title":"TaylorIntegration._capture_fn_args_body!","text":"_capture_fn_args_body!(ex, dd::Dict{Symbol, Any})\n\nCaptures the name of a function, arguments, body and other properties, returning them as the values of the dictionary dd, which is updated in place.\n\n\n\n\n\n","category":"function"},{"location":"api/#TaylorIntegration._defs_allocs!","page":"API","title":"TaylorIntegration._defs_allocs!","text":"_defs_allocs!(preamble, fnargs, bkkeep, [inloop=false, ex_aux::Expr(:block,)])\n\nReturns a vector with expressions defining the auxiliary variables in the preamble, and the declaration of the arrays. This function may modify bkkeep.d_indx if new variables are introduced. bkkeep.v_preamb is for bookkeeping the introduced variables.\n\n\n\n\n\n","category":"function"},{"location":"api/#TaylorIntegration._determine_parsing!-Tuple{Bool, Vararg{Any, 4}}","page":"API","title":"TaylorIntegration._determine_parsing!","text":"_determine_parsing!(parse_eqs::Bool, f, t, x, params)\n_determine_parsing!(parse_eqs::Bool, f, t, x, dx, params)\n\nCheck if the parsed method of jetcoeffs! exists and check it runs without error.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._extract_parts-Tuple{Expr}","page":"API","title":"TaylorIntegration._extract_parts","text":"_extract_parts(ex::Expr)\n\nReturns the function name, the function arguments, and the body of a function passed as an Expr. The function may be provided as a one-line function, or in the long form (anonymous functions do not work).\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._make_parsed_jetcoeffs-Tuple{Expr}","page":"API","title":"TaylorIntegration._make_parsed_jetcoeffs","text":"_make_parsed_jetcoeffs( ex )\n\nThis function constructs the expressions of two new methods, the first equivalent to the differential equations (jetcoeffs!), which exploits the mutating functions of TaylorSeries.jl, and the second one (allocatejetcoeffs) preallocates any auxiliary Taylor1 or Vector{Taylor1{T}} needed.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._newfnbody!-Tuple{Any, Any, TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._newfnbody!","text":"_newfnbody!(fnbody, fnargs, bkkeep)\n\nReturns a new (modified) body of the function, a priori unfolding the expression graph (AST) as unary and binary calls, and updates the bookkeeping structure bkkeep.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._newhead-Tuple{Any, Any}","page":"API","title":"TaylorIntegration._newhead","text":"_newhead(fn, fnargs)\n\nCreates the head of the new method of jetcoeffs! and _allocate_jetcoeffs. fn is the name of the passed function and fnargs is a vector with its arguments defning the function (which are either three or four).\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._parse_newfnbody!-Tuple{Expr, Expr, Expr, TaylorIntegration.BookKeeping, Bool}","page":"API","title":"TaylorIntegration._parse_newfnbody!","text":"parsenewfnbody!(ex::Expr, preex::Expr, prealloc::Expr, bkkeep::BookKeeping, inloop::Bool)\n\nParses ex (the new body of the function) replacing the expressions to use the mutating functions of TaylorSeries, and building the preamble preex and prealloc expressions. This is done by traversing recursively (again) the args of ex, updating the bookkeeping struct bkkeep, in particular the fieldnames v_newvars and d_assign.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._preamble_body-Tuple{Any, Any}","page":"API","title":"TaylorIntegration._preamble_body","text":"_preamble_body(fnbody, fnargs)\n\nReturns expressions for the preamble, the declaration of arrays, the body and the bookkeeping struct, which will be used to build the new functions. fnbody is the expression with the body of the original function (already adapted), fnargs is a vector of symbols of the original diferential equations function.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._recursionloop-Tuple{Any, TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._recursionloop","text":"_recursionloop(fnargs, bkkeep)\n\nBuild the expression for the recursion-loop.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._rename_indexedvars-Tuple{Any}","page":"API","title":"TaylorIntegration._rename_indexedvars","text":"_rename_indexedvars(fnbody)\n\nRenames the indexed variables (using Espresso.genname()) that exists in fnbody. Returns fnbody with the renamed variables and a dictionary that links the new variables to the old indexed ones.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._replace_expr!-Tuple{Expr, Expr, Expr, Int64, Any, Any, TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._replace_expr!","text":"_replace_expr!(ex::Expr, preex::Expr, , prealloc::Expr, i::Int, aalhs, aarhs, bkkeep::BookKeeping)\n\nReplaces the calls in ex.args[i], and updates preex and prealloc with the appropriate expressions, based on the the LHS (aalhs) and RHS (aarhs) of the base assignment. The bookkeeping struct is updated (v_newvars) within _replacecalls!. d_indx is used to bring back the indexed variables.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._replacecalls!-Tuple{TaylorIntegration.BookKeeping, Expr, Symbol}","page":"API","title":"TaylorIntegration._replacecalls!","text":"_replacecalls!(bkkeep, fnold, newvar)\n\nReplaces the symbols of unary and binary calls of the expression fnold, which defines newvar, by the mutating functions in TaylorSeries.jl. The vector bkkeep.v_vars is updated if new auxiliary variables are introduced (bookkeeping).\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._returned_expr-Tuple{TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._returned_expr","text":"_returned_expr(bkkeep)\n\nConstructs the expression to be returned by TaylorIntegration._allocate_jetcoeffs!\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._second_stepsize-Union{Tuple{U}, Tuple{T}, Tuple{Taylor1{U}, T}} where {T<:Real, U<:Number}","page":"API","title":"TaylorIntegration._second_stepsize","text":"_second_stepsize(x, epsilon)\n\nCorresponds to the \"second stepsize control\" in Jorba and Zou (2005) paper. We use it if stepsize returns Inf.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._split_arraydecl!-Tuple{TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration._split_arraydecl!","text":"_split_arraydecl!(bkkeep)\n\nSplit bkkeep.varraydecl in the vector (bkkeep.varray1), matrix (bkkeep.v_array2), etc, to properly construct the RetAlloc variable.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration._stepsize-Union{Tuple{U}, Tuple{T}, Tuple{U, T, Int64}} where {T<:Real, U<:Number}","page":"API","title":"TaylorIntegration._stepsize","text":"_stepsize(aux1, epsilon, k)\n\nHelper function to avoid code repetition. Returns (epsilon/aux1)^(1/k).\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.build_lyap_solution-Union{Tuple{U}, Tuple{T}, Tuple{AbstractVector{T}, Matrix{U}, Matrix{U}, Int64}} where {T, U}","page":"API","title":"TaylorIntegration.build_lyap_solution","text":"build_lyap_solution(t, x, λ, nsteps)\nbuild_lyap_solution(t, x, λ)\n\nHelper function to build a TaylorSolution from a call to lyap_taylorinteg.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.build_solution-Union{Tuple{P}, Tuple{U}, Tuple{T}, Tuple{AbstractVector{T}, Matrix{U}, P, AbstractVector{U}, Matrix{U}, AbstractVector{U}, Int64, Int64}} where {T, U, P<:Union{Nothing, Array{Taylor1{U}, 2}}}","page":"API","title":"TaylorIntegration.build_solution","text":"build_solution(t, x, p, tevents, xevents, gresids, nsteps, nevents)\nbuild_solution(t, x, tevents, xevents, gresids, nsteps, nevents)\n\nHelper function to build a TaylorSolution from a call to a root-finding method of taylorinteg.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.build_solution-Union{Tuple{U}, Tuple{T}, Tuple{AbstractVector{T}, Vector{U}, Nothing, Int64}} where {T, U}","page":"API","title":"TaylorIntegration.build_solution","text":"build_solution(t, x, p, nsteps)\nbuild_solution(t, x)\n\nHelper function to build a TaylorSolution from a call to taylorinteg.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.findroot!-NTuple{18, Any}","page":"API","title":"TaylorIntegration.findroot!","text":"findroot!(t, x, dx, g_tupl_old, g_tupl, eventorder, tvS, xvS, gvS,\n t0, δt_old, x_dx, x_dx_val, g_dg, g_dg_val, nrabstol,\n newtoniter, nevents) -> nevents\n\nInternal root-finding subroutine, based on Newton-Raphson process. If there is a crossing, then the crossing data is stored in tvS, xvS and gvS and nevents, the number of events/crossings, is updated. Here t is a Taylor1 polynomial which represents the independent variable; x is an array of Taylor1 variables which represent the vector of dependent variables; dx is an array of Taylor1 variables which represent the LHS of the ODE; g_tupl_old is the last-before-current value returned by event function g and g_tupl is the current one; eventorder is the order of the derivative of g whose roots the user is interested in finding; tvS stores the surface-crossing instants; xvS stores the value of the solution at each of the crossings; gvS stores the values of the event function g (or its eventorder-th derivative) at each of the crossings; t0 is the current time; δt_old is the last time-step size; x_dx, x_dx_val, g_dg, g_dg_val are auxiliary variables; nrabstol is the Newton-Raphson process tolerance; newtoniter is the maximum allowed number of Newton-Raphson iteration; nevents is the current number of detected events/crossings.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.inbookkeeping-Tuple{Any, TaylorIntegration.BookKeeping}","page":"API","title":"TaylorIntegration.inbookkeeping","text":"inbookkeeping(v, bkkeep::BookKeeping)\n\nChecks if v is declared in bkkeep, considering the d_indx, v_newvars and v_arraydecl fields.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.init_psol-Union{Tuple{U}, Tuple{Val{true}, Vector{U}, Taylor1{U}}} where U<:Number","page":"API","title":"TaylorIntegration.init_psol","text":"init_psol(::Val{true}, xv::Array{U,1}, x::Taylor1{U}) where {U<:Number}\ninit_psol(::Val{true}, xv::Array{U,2}, x::Array{Taylor1{U},1}) where {U<:Number}\ninit_psol(::Val{false}, ::Array{U,1}, ::Taylor1{U}) where {U<:Number}\ninit_psol(::Val{false}, ::Array{U,2}, ::Array{Taylor1{U},1}) where {U<:Number}\n\nAuxiliary function to initialize psol during a call to taylorinteg. When the first argument in the call signature is Val(false) this function simply returns nothing. Otherwise, when the first argument in the call signature is Val(true), then the appropriate array is allocated and returned; this array is where the Taylor polynomials associated to the solution will be stored, corresponding to field :p in TaylorSolution.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.jetcoeffs!-Union{Tuple{N}, Tuple{U}, Tuple{T}, Tuple{Function, Taylor1{T}, AbstractArray{Taylor1{U}, N}, AbstractArray{Taylor1{U}, N}, AbstractArray{Taylor1{U}, N}, Any}} where {T<:Real, U<:Number, N}","page":"API","title":"TaylorIntegration.jetcoeffs!","text":"jetcoeffs!(eqsdiff!::Function, t, x, dx, xaux, params)\n\nMutates x in-place using the recursion relation of the derivatives obtained from the differential equations dotx=dxdt=f(x p t).\n\neqsdiff! is the function defining the RHS of the ODE, x contains the Taylor1 expansion of the dependent variables and t is the independent variable, and params are the parameters appearing on the function defining the differential equation. See taylorinteg for examples and convention for eqsdiff. Note that x is of type Vector{Taylor1{U}} where U<:Number; t is of type Taylor1{T} where T<:Real. In this case, two auxiliary containers dx and xaux (both of the same type as x) are needed to avoid allocations.\n\nInitially, x contains only the 0-th order Taylor coefficient of the current system state (the initial conditions), and jetcoeffs! computes recursively the high-order derivates back into x.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.jetcoeffs!-Union{Tuple{U}, Tuple{T}, Tuple{Function, Taylor1{T}, Taylor1{U}, Any}} where {T<:Real, U<:Number}","page":"API","title":"TaylorIntegration.jetcoeffs!","text":"jetcoeffs!(eqsdiff::Function, t, x, params)\n\nReturns an updated x using the recursion relation of the derivatives obtained from the differential equations dotx=dxdt=f(x p t).\n\neqsdiff is the function defining the RHS of the ODE, x contains the Taylor1 expansion of the dependent variable(s) and t is the independent variable, and params are the parameters appearing on the function defining the differential equation. See taylorinteg for examples and convention for eqsdiff. Note that x is of type Taylor1{U} where U<:Number; t is of type Taylor1{T} where T<:Real.\n\nInitially, x contains only the 0-th order Taylor coefficient of the current system state (the initial conditions), and jetcoeffs! computes recursively the high-order derivates back into x.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.lyap_jetcoeffs!-Union{Tuple{S}, Tuple{T}, Tuple{Taylor1{T}, AbstractArray{Taylor1{S}, 1}, AbstractArray{Taylor1{S}, 1}, Array{Taylor1{S}, 2}, Array{Taylor1{S}, 3}}} where {T<:Real, S<:Number}","page":"API","title":"TaylorIntegration.lyap_jetcoeffs!","text":"lyap_jetcoeffs!(t, x, dx, jac, varsaux)\n\nSimilar to jetcoeffs! for the calculation of the Lyapunov spectrum. Updates only the elements of x which correspond to the solution of the 1st-order variational equations dotxi=J cdot xi, where J is the Jacobian matrix, i.e., the linearization of the equations of motion. jac is the Taylor expansion of J wrt the independent variable, around the current initial condition. varsaux is an auxiliary array of type Array{eltype(jac),3} to avoid allocations. Calling this method assumes that jac has been computed previously using stabilitymatrix!.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.nrconvergencecriterion-Union{Tuple{T}, Tuple{U}, Tuple{U, T, Int64, Int64}} where {U<:Number, T<:Real}","page":"API","title":"TaylorIntegration.nrconvergencecriterion","text":"nrconvergencecriterion(g_val, nrabstol::T, nriter::Int, newtoniter::Int) where {T<:Real}\n\nA rudimentary convergence criterion for the Newton-Raphson root-finding process. g_val may be either a Real, Taylor1{T} or a TaylorN{T}, where T<:Real. Returns true if: 1) the absolute value of g_val, the value of the event function g evaluated at the current estimated root by the Newton-Raphson process, is less than the nrabstol tolerance; and 2) the number of iterations nriter of the Newton-Raphson process is less than the maximum allowed number of iterations, newtoniter; otherwise, returns false.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.set_psol!-Union{Tuple{U}, Tuple{Val{true}, Array{Taylor1{U}, 1}, Int64, Taylor1{U}}} where U<:Number","page":"API","title":"TaylorIntegration.set_psol!","text":"set_psol!(::Val{true}, psol::Array{Taylor1{U},1}, nsteps::Int, x::Taylor1{U}) where {U<:Number}\nset_psol!(::Val{true}, psol::Array{Taylor1{U},2}, nsteps::Int, x::Vector{Taylor1{U}}) where {U<:Number}\nset_psol!(::Val{false}, args...)\n\nAuxiliary function to save Taylor polynomials in a call to taylorinteg. When the first argument in the call signature is Val(true), sets appropriate elements of argument psol. Otherwise, when the first argument in the call signature is Val(false), this function simply returns nothing. Argument psol is the array where the Taylor polynomials associated to the solution will be stored, corresponding to field :p in TaylorSolution. See also init_psol.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.stabilitymatrix!-Union{Tuple{U}, Tuple{T}, Tuple{Any, Taylor1{T}, Array{Taylor1{U}, 1}, Array{TaylorN{Taylor1{U}}, 1}, Array{TaylorN{Taylor1{U}}, 1}, Array{Taylor1{U}, 2}, Array{TaylorN{Taylor1{U}}, 1}, Any, Nothing}} where {T<:Real, U<:Number}","page":"API","title":"TaylorIntegration.stabilitymatrix!","text":"stabilitymatrix!(eqsdiff!, t, x, δx, dδx, jac, _δv, params[, jacobianfunc!=nothing])\n\nUpdates the matrix jac::Matrix{Taylor1{U}} (linearized equations of motion) computed from the equations of motion (eqsdiff!), at time t at x; x is of type Vector{Taylor1{U}}, where U<:Number. δx, dδx and _δv are auxiliary arrays of type Vector{TaylorN{Taylor1{U}}} to avoid allocations. Optionally, the user may provide a Jacobian function jacobianfunc! to compute jac. Otherwise, jac is computed via automatic differentiation using TaylorSeries.jl.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.stepsize-Union{Tuple{U}, Tuple{T}, Tuple{Taylor1{U}, T}} where {T<:Real, U<:Number}","page":"API","title":"TaylorIntegration.stepsize","text":"stepsize(x, epsilon) -> h\n\nReturns a maximum time-step for a the Taylor expansion x using a prescribed absolute tolerance epsilon and the last two Taylor coefficients of (each component of) x.\n\nNote that x is of type Taylor1{U} or Vector{Taylor1{U}}, including also the cases Taylor1{TaylorN{U}} and Vector{Taylor1{TaylorN{U}}}.\n\nDepending of eltype(x), i.e., U<:Number, it may be necessary to overload stepsize, specializing it on the type U, to avoid type instabilities.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.surfacecrossing-Union{Tuple{T}, Tuple{Tuple{Bool, Taylor1{T}}, Tuple{Bool, Taylor1{T}}, Int64}} where T<:Number","page":"API","title":"TaylorIntegration.surfacecrossing","text":"surfacecrossing(g_old, g_now, eventorder::Int)\n\nDetect if the solution crossed a root of event function g. g_old represents the last-before-current value of event function g, and g_now represents the current one; these are Tuple{Bool,Taylor1{T}}s. eventorder is the order of the derivative of the event function g whose root we are trying to find. Returns true if the constant terms of g_old[2] and g_now[2] have different signs (i.e., if one is positive and the other one is negative). Otherwise, if g_old[2] and g_now[2] have the same sign or if the first component of either of them is false, then it returns false.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.taylorstep!-Union{Tuple{V}, Tuple{U}, Tuple{T}, Tuple{Val{V}, Any, Taylor1{T}, Taylor1{U}, T, Any, TaylorIntegration.RetAlloc{Taylor1{U}}}} where {T<:Real, U<:Number, V}","page":"API","title":"TaylorIntegration.taylorstep!","text":"taylorstep!(::Val{false}, f, t, x, abstol, params, rv, parse_eqs=true) -> δt\ntaylorstep!(::Val{true}, f, t, x, abstol, params, rv, parse_eqs=true) -> δt\ntaylorstep!(::Val{false}, f!, t, x, dx, xaux, abstol, params, rv, parse_eqs=true) -> δt\ntaylorstep!(::Val{true}, f!, t, x, dx, xaux, abstol, params, rv, parse_eqs=true) -> δt\n\nOne-step Taylor integration for the one-dependent variable ODE dotx=dxdt=f(x p t) with initial conditions x(t_0)=x_0. Returns the time-step δt of the actual integration carried out (δt is positive).\n\nHere, f represents the function defining the RHS of the ODE (see taylorinteg), t is the independent variable, x contains the Taylor expansion of the dependent variable, order is the degree used for the Taylor1 polynomials during the integration abstol is the absolute tolerance used to determine the time step of the integration, and params are the parameters entering the ODE functions. For several variables, dx and xaux, both of the same type as x, are needed to save allocations. Finally, parse_eqs is a switch to force not using (parse_eqs=false) the specialized method of jetcoeffs! created with @taylorize; the default is true (parse the equations). Finally, parse_eqs is a switch to force not using (parse_eqs=false) the specialized method of jetcoeffs! created with @taylorize; the default is true (parse the equations). The first argument in the function call Val{bool} (bool::Bool) controls whether a specialized `jetcoeffs! method is being used or not.\n\n\n\n\n\n","category":"method"},{"location":"api/#TaylorIntegration.timeindex-Union{Tuple{TT}, Tuple{TaylorSolution, TT}} where TT","page":"API","title":"TaylorIntegration.timeindex","text":"timeindex(sol::TaylorSolution, t::TT) where TT\n\nReturn the index of sol.t corresponding to t and the time elapsed from sol.t0 to t.\n\n\n\n\n\n","category":"method"},{"location":"api/#Index","page":"API","title":"Index","text":"","category":"section"},{"location":"api/","page":"API","title":"API","text":"Pages = [\"api.md\"]\nModule = [\"TaylorIntegration\"]\nOrder = [:function]\nPublic = true","category":"page"},{"location":"common/#diffeqinterface","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"","category":"section"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Here, we show an example of interoperability between TaylorIntegration.jl and DifferentialEquations.jl, i.e., how to use TaylorIntegration.jl from the DifferentialEquations ecosystem. The basic requirement is to load OrdinaryDiffEq.jl together with TaylorIntegration.jl, which sets-up the common interface. Below, we shall also use OrdinaryDiffEq.jl to compare the accuracy of TaylorIntegration.jl with respect to high-accuracy methods for non-stiff problems (Vern9 method). While DifferentialEquations offers many macros to simplify certain aspects, we do not rely on them simply because using properly @taylorize improves the performance.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"note: Note\nCurrently, the only keyword arguments supported by DiffEqBase.solve that are implemented in TaylorIntegration.jl are :saveat and :tstops. There is also experimental support for :callback, both discrete and continuous; some examples may be found in test/common.jl. The keyword argument :parse_eqs is available in order to control the use of methods defined via @taylorize.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"The problem we will integrate in this example is the planar circular restricted three-body problem (PCR3BP, also capitalized as PCRTBP). The PCR3BP describes the motion of a body with negligible mass m_3 under the gravitational influence of two bodies with masses m_1 and m_2, such that m_1 ge m_2. It is assumed that m_3 is much smaller than the other two masses so it does not influence their motion, and therefore it is simply considered as a massless test particle. The body with the greater mass m_1 is referred as the primary, and m_2 as the secondary. These bodies are together called the primaries and are assumed to describe Keplerian circular orbits about their center of mass, which is placed at the origin of the reference frame. It is further assumed that the orbit of the third body takes place in the orbital plane of the primaries. A full treatment of the PCR3BP may be found in [1].","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"The ratio mu = m_2(m_1+m_2) is known as the mass parameter. Using mass units such that m_1+m_2=1, we have m_1=1-mu and m_2=mu. In this example, we assume the mass parameter to have a value mu=001.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"using Plots\n\nconst μ = 0.01\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"The Hamiltonian for the PCR3BP in the synodic frame (i.e., a frame which rotates such that the primaries are at rest on the x axis) is","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"H(x y p_x p_y) = frac12(p_x^2+p_y^2) - (x p_y - y p_x) + V(x y) tag1","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"where","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"V(x y) = - frac1-musqrt(x-mu)^2+y^2 - fracmusqrt(x+1-mu)^2+y^2tag2","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"is the gravitational potential associated to the primaries. The RHS of Eq. (1) is also known as the Jacobi constant, since it is a preserved quantity of motion in the PCR3BP. We will use this property to check the accuracy of the solutions computed.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"V(x, y) = - (1-μ)/sqrt((x-μ)^2+y^2) - μ/sqrt((x+1-μ)^2+y^2)\nH(x, y, px, py) = (px^2+py^2)/2 - (x*py-y*px) + V(x, y)\nH(x) = H(x...)\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"The equations of motion for the PCR3BP are","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"beginaligned\n dotx = p_x + y\n doty = p_y - x\n dotp_x = - frac(1-mu)(x-mu)((x-mu)^2+y^2)^32 - fracmu(x+1-mu)((x+1-mu)^2+y^2)^32 + p_y\n dotp_y = - frac(1-mu)y ((x-mu)^2+y^2)^32 - fracmu y ((x+1-mu)^2+y^2)^32 - p_x\nendaligned","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We define this system of ODEs in a way that allows the use of the @taylorize macro from TaylorIntegration.jl, which for the present example allows important speed-ups. For more details about the specifics of the use of @taylorize, see this section.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"using TaylorIntegration\n@taylorize function pcr3bp!(dq, q, param, t)\n local μ = param[1]\n local onemμ = 1 - μ\n x1 = q[1]-μ\n x1sq = x1^2\n y = q[2]\n ysq = y^2\n r1_1p5 = (x1sq+ysq)^1.5\n x2 = q[1]+onemμ\n x2sq = x2^2\n r2_1p5 = (x2sq+ysq)^1.5\n dq[1] = q[3] + q[2]\n dq[2] = q[4] - q[1]\n dq[3] = (-((onemμ*x1)/r1_1p5) - ((μ*x2)/r2_1p5)) + q[4]\n dq[4] = (-((onemμ*y )/r1_1p5) - ((μ*y )/r2_1p5)) - q[3]\n return nothing\nend\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We shall define the initial conditions q_0 = (x_0 y_0 p_x0 p_y0) such that H(q_0) = J_0, where J_0 is a prescribed value. In order to do this, we select y_0 = p_x0 = 0 and compute the value of p_y0 for which H(q_0) = J_0 holds.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We consider a value for J_0 such that the test particle is able to display close encounters with both primaries, but cannot escape to infinity. We may obtain a first approximation to the desired value of J_0 if we plot the projection of the zero-velocity curves on the x-axis.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"ZVC(x) = -x^2/2 + V(x, zero(x)) # projection of the zero-velocity curves on the x-axis\n\nplot(ZVC, -2:0.001:2, label=\"zero-vel. curve\", legend=:topleft, fmt = :png)\nplot!([-2, 2], [-1.58, -1.58], label=\"J0 = -1.58\")\nylims!(-1.7, -1.45)\nxlabel!(\"x\")\nylabel!(\"J\")\ntitle!(\"Zero-velocity curves (x-axis projection)\")","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Notice that the maxima in the plot correspond to the Lagrangian points L_1, L_2 and L_3; below we shall concentrate in the value J_0 = -158.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"J0 = -1.58\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We define a function py!, which depends on the initial condition q_0 = (x_0 0 0 p_y0) and the Jacobi constant value J_0, such that it computes an adequate value p_y0 for which we have H(q_0)=J_0 and updates (in-place) the initial condition accordingly.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"function py!(q0, J0)\n @assert iszero(q0[2]) && iszero(q0[3]) # q0[2] and q0[3] have to be equal to zero\n q0[4] = q0[1] + sqrt( q0[1]^2-2( V(q0[1], q0[2])-J0 ) )\n nothing\nend\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We are now ready to generate an appropriate initial condition.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"q0 = [-0.8, 0.0, 0.0, 0.0]\npy!(q0, J0)\nq0","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We note that the value of q0 has been updated. We can check that the value of the Hamiltonian evaluated at the initial condition is indeed equal to J0.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"H(q0) == J0","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Following the DifferentialEquations.jl tutorial, we define an ODEProblem for the integration; TaylorIntegration can be used via its common interface bindings with OrdinaryDiffEq.jl; both packages need to be loaded explicitly.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"tspan = (0.0, 2000.0)\np = [μ]\n\nusing OrdinaryDiffEq\nprob = ODEProblem(pcr3bp!, q0, tspan, p)","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We solve prob using a 25-th order Taylor method, with a local absolute tolerance epsilon_mathrmtol = 10^-15.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"solT = solve(prob, TaylorMethod(25), abstol=1e-15);","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"As mentioned above, we will now solve the same problem prob with the Vern9 method from OrdinaryDiffEq, which the DifferentialEquations documentation recommends for high-accuracy (i.e., very low tolerance) integrations of non-stiff problems. Note that, besides setting an absolute tolerance abstol=1e-15, we're setting a relative tolerance reltol=1e-15 [2]. We have found that for the current problem this is a good balance between speed and accuracy for the Vern9 method, i.e., the Vern9 integration becomes noticeably slower (although more accurate) if either abstol or reltol are set to lower values.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"using OrdinaryDiffEq\n\nsolV = solve(prob, Vern9(), abstol=1e-15, reltol=1e-15); #solve `prob` with the `Vern9` method","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We plot in the x-y synodic plane the solution obtained with TaylorIntegration:","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"plot(solT, vars=(1, 2), linewidth=1, fmt = :png)\nscatter!([μ, -1+μ], [0,0], leg=false) # positions of the primaries\nxlims!(-1+μ-0.2, 1+μ+0.2)\nylims!(-0.8, 0.8)\nxlabel!(\"x\")\nylabel!(\"y\")","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Note that the orbit obtained displays the expected dynamics: the test particle explores the regions surrounding both primaries, located at the red dots, without escaping to infinity. For comparison, we now plot the orbit corresponding to the solution obtained with the Vern9() integration; note that the scales are identical.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"plot(solV, vars=(1, 2), linewidth=1, fmt = :png)\nscatter!([μ, -1+μ], [0,0], leg=false) # positions of the primaries\nxlims!(-1+μ-0.2, 1+μ+0.2)\nylims!(-0.8, 0.8)\nxlabel!(\"x\")\nylabel!(\"y\")","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We note that both orbits display the same qualitative features, and also some differences. For instance, the TaylorMethod(25) solution gets closer to the primary than that the Vern9(). We can obtain a quantitative comparison of the validity of both integrations through the preservation of the Jacobi constant:","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"ET = H.(solT.u)\nEV = H.(solV.u)\nδET = ET .- J0\nδEV = EV .- J0\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We plot first the value of the Jacobi constant as function of time.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"plot(solT.t, H.(solT.u), label=\"TaylorMethod(25)\", fmt = :png, yformatter = :plain)\nplot!(solV.t, H.(solV.u), label=\"Vern9()\")\nxlabel!(\"t\")\nylabel!(\"H\")","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"In the scale shown we observe that, while both solutions display a preservation of the Jacobi constant to a certain degree, the Vern9() solution suffers sudden jumps during the integration.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We now plot, in log scale, the abs of the absolute error in the Jacobi constant as a function of time, for both solutions:","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"plot(solT.t, abs.(δET), yscale=:log10, label=\"TaylorMethod(25)\", legend=:topleft, fmt = :png, yformatter = :plain)\nplot!(solV.t, abs.(δEV), label=\"Vern9()\")\nylims!(10^-16, 10^-10)\nxlabel!(\"t\")\nylabel!(\"dE\")","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We notice that the Jacobi constant absolute error for the TaylorMethod(25) solution remains bounded below 10^-13 throughout the integration. While the Vern9() solution at the end of the integration time has reached a similar value, it displays a larger Jacobi constant error earlier in time.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Finally, we comment on the time spent by each integration.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"using BenchmarkTools\nbT = @benchmark solve($prob, $(TaylorMethod(25)), abstol=1e-15)\nbV = @benchmark solve($prob, $(Vern9()), abstol=1e-15, reltol=1e-15)\nnothing # hide","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"bT # TaylorMethod(25) benchmark","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"bV # Vern9 benchmark","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We notice in this setup, where the TaylorMethod(25) and the Vern9() integrations perform similarly in terms of accuracy, the former performs better in terms of runtime.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"We can tune the abstol and reltol for the Vern9() method we so that performance is similar. Such situation has an accuracy cost, which then makes TaylorIntegration a sensible alternative for high-accuracy integrations of non-stiff ODEs in some cases; see [2].","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"Finally, as mentioned above, a crucial way in which TaylorIntegration provides high accuracy at competitive speeds is through the use of the @taylorize macro; see this section for details. Currently, TaylorIntegration supports the use of @taylorize via the common interface with DifferentialEquations only for in-place ODEProblem.","category":"page"},{"location":"common/#refsPCR3BP","page":"Interoperability with DifferentialEquations.jl","title":"References and notes","text":"","category":"section"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"[1] Murray, Carl D., Stanley F. Dermott. Solar System dynamics. Cambridge University Press, 1999.","category":"page"},{"location":"common/","page":"Interoperability with DifferentialEquations.jl","title":"Interoperability with DifferentialEquations.jl","text":"[2] SciMLBenchmarks.jl/DynamicalODE","category":"page"},{"location":"simple_example/#example1","page":"Infinity in finite time","title":"Infinity in finite time","text":"","category":"section"},{"location":"simple_example/#Illustration-of-the-method","page":"Infinity in finite time","title":"Illustration of the method","text":"","category":"section"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We shall illustrate first with a simple example how the method explicitly constructs the solution, and how to use the package to obtain it.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We consider the differential equation given by","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"dotx = x^2tag1","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"with the initial condition x(0)=x_0, whose exact solution reads","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"x(t) = fracx_01-x_0ttag2","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We shall implement the construction of this example explicitly, which illustrates the way TaylorIntegration.jl is conceived.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"The initial condition defines the 0-th order approximation, i.e., x(t) = x_0 + mathcalO(t^1). We now write the solution as x(t) = x_0 + x_1t + mathcalO(t^2), and we want to determine x_1. Substituting this solution into the RHS of (1), yields","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"x^2 = x_0^2 + 2 x_0 x_1 t + x_1^2 t^2 =\n x_0^2 + mathcalO(t^1)","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"where in the last equality we have kept all terms up to order 0, since we want to determine x_1, and the recursion formula requires for that the 0-th order term of the Taylor expansion of the RHS of the equation of motion. Hence, we have f_0=x_0^2, which using the recursion relation x_k+1 = f_k(k+1) yields x_1 = x_0^2.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Following the same procedure, we write x(t) = x_0 + x_1 t + x_2 t^2 + mathcalO(t^3), and","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"x^2 = x_0^2 + 2 x_0 x_1 t + mathcalO(t^2)","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"where we kept all terms up to order 1. We thus have f_1=2 x_0 x_1 = 2 x_0^3, which then yields x_2 = x_0^3. Repeating this calculation, we obtain","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"x(t) = x_0 + x_0^2 t + x_0^3 t^2 + cdots + x_0^k+1 t^k + cdotstag3","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"The solution given by Eq. (3) is a geometrical series, which is identical to the exact solution, Eq. (2). Yet, it is not obvious from the solution that it is only defined for t1x_0. To see this, we obtain the step size, as described previously, for the series truncated to order k. The Taylor coefficient of order k is x_k=x_0^k+1, so the time step is","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"h Big(fracepsilon_textrmtolx_0^k+1Big)^1k =\nfracepsilon_textrmtol^1kx_0^1+1k","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"In the limit ktoinfty we obtain h h_textrmmax=1x_0, which is the domain of existence of the exact solution.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Below, we shall fix a maximum order for the expansion. This entails a truncation error which is somewhat controlled through the absolute tolerance epsilon_textrmtol. The key to a correct use of Taylor's method is to impose a quite small value of epsilon_textrmtol together with a large enough order of the expansion.","category":"page"},{"location":"simple_example/#implementation_ex1","page":"Infinity in finite time","title":"Implementation","text":"","category":"section"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We shall illustrate how to use TaylorIntegration.jl to integrate Eq. (1) for the initial condition x(0)=3. Notice that according to the exact solution Eq. (2), the solution only exists for tt_mathrmmax =13; in addition, we note that this number can not be represented exactly as a floating-point number.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We first load the required packages and define a function which represents the equation of motion.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"using TaylorIntegration, Plots\ndiffeq(x, p, t) = x^2;","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"note: Note\nIn TaylorIntegration.jl we use the same convention of DifferentialEquations.jl when writing the function representing the equations of motion.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We now integrate the equations of motion using taylorinteg; note that, despite of the fact that the solution only exists for tt_textrmmax, below we shall try to compute it up to t_textrmend=034; as we shall see, Taylor's method takes care of this. For the integration presented below, we use a 25-th series expansion, with epsilon_textrmtol = 10^-20, and compute up to 150 integration steps. The type of the solution returned by taylorinteg is TaylorSolution.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"sol = taylorinteg(diffeq, 3.0, 0.0, 0.34, 25, 1e-20, maxsteps=150);","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"We first note that the last point of the calculation does not exceed t_textrmmax.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"sol.t[end]","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Increasing the maxsteps parameter pushes sol.t[end] closer to t_textrmmax but it actually does not reach this value.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Figure 1 displays the computed solution as a function of time, in log scale.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"plot(sol.t, log10.(sol.x), shape=:circle)\nxlabel!(\"t\")\nylabel!(\"log10(x(t))\")\nxlims!(0,0.34)\ntitle!(\"Fig. 1\")","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Clearly, the solution diverges without bound when tto t_textrmmax = 13, i.e., x(t) approaches infinity in finite time.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Figure 2 shows the relative difference between the numerical and the analytical solution in terms of time.","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"exactsol(t, x0) = x0 / (1 - x0 * t)\nδxT = abs.(sol.x .- exactsol.(sol.t, 3.0)) ./ exactsol.(sol.t, 3.0);\nplot(sol.t[6:end], log10.(sol.x[6:end]), shape=:circle)\nxlabel!(\"t\")\nylabel!(\"log10(dx(t))\")\nxlims!(0, 0.4)\ntitle!(\"Fig. 2\")","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"To put in perspective how good is the constructed solution, we impose (arbitrarily) a relative accuracy of 10^-13; the time until such accuracy is satisfied is given by:","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"indx = findfirst(δxT .> 1.0e-13);\nesol = exactsol(sol.t[indx-1],3.0);\nsol.t[indx-1], esol, eps(esol)","category":"page"},{"location":"simple_example/","page":"Infinity in finite time","title":"Infinity in finite time","text":"Note that, the accuracy imposed in terms of the actual value of the exact solution means that the difference of the computed and the exact solution is essentially due to the eps of the computed value.","category":"page"},{"location":"taylor_method/#taylormethod","page":"Taylor's method","title":"Taylor's method","text":"","category":"section"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Taylor's integration method is a quite powerful method to integrate ODEs which are smooth enough, allowing to reach a precision comparable to round-off errors per time-step. A high-order Taylor approximation of the solution (dependent variable) is constructed such that the error is quite small. A time-step is constructed which guarantees the validity of the series; this is used to sum up the Taylor expansion to obtain an approximation of the solution at a later time.","category":"page"},{"location":"taylor_method/#rec_rel","page":"Taylor's method","title":"The recurrence relation","text":"","category":"section"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Let us consider the following","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"dotx = f(t x)tag1","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"and define the initial value problem with the initial condition x(t_0) = x(0).","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"We write the solution of this equation as","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"x = x_0 + x_1 (t-t_0) + x_2 (t-t_0)^2 + cdots +\nx_k (t-t_0)^k + cdotstag2","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"where the initial condition imposes that x_0 = x(0). Below, we show how to obtain the coefficients x_k of the Taylor expansion of the solution.","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"We assume that the Taylor expansion around t_0 of f(t x(t)) is known, which we write as","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"f(t x(t)) = f_0 + f_1 (t-t_0) + f_2 (t-t_0)^2 + cdots\n+ f_k (t-t_0)^k + cdotstag3","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Here, f_0=f(t_0x_0), and the Taylor coefficients f_k = f_k(t_0) are the k-th normalized derivatives at t_0 given by","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"f_k = frac1k fracrm d^k f rm d t^k(t_0)tag4","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Then, we are assuming that we know how to obtain f_k; these coefficients are obtained using TaylorSeries.jl.","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Substituting Eq. (2) in (1), and equating powers of t-t_0, we obtain","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"x_k+1 = fracf_k(t_0)k+1 quad k=01dotstag5","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Therefore, the coefficients of the Taylor expansion (2) are obtained recursively using Eq. (5).","category":"page"},{"location":"taylor_method/#time-step","page":"Taylor's method","title":"Time step","text":"","category":"section"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"In the computer, the expansion (2) has to be computed to a finite order. We shall denote by K the order of the series. In principle, the larger the order K, the more accurate the obtained solution is.","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"The theorem of existence and uniqueness of the solution of Eq.~(1) ensures that the Taylor expansion converges. Then, assuming that K is large enough to be within the convergent tail, we introduce the parameter epsilon_textrmtol 0 to control how large is the last term. The idea is to set this parameter to a small value, usually smaller than the machine-epsilon. Denoting by h = t_1-t_0 the time step, then imposing x_K h^K le epsilon_textrmtol we obtain","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"h le Big(fracepsilon_textrmtol x_K Big)^1Ktag6","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Equation (6) represents the maximum time-step which is consistent with epsilon_textrmtol, K and the assumption of being within the convergence tail. Notice that the arguments exposed above simply ensure that h is a maximum time-step, but any other smaller than h can be used since the series is convergent in the open interval tin(t_0-ht_0+h).","category":"page"},{"location":"taylor_method/","page":"Taylor's method","title":"Taylor's method","text":"Finally, from Eq. (2) with (6) we obtain x(t_1) = x(t_0+h), which is again an initial value problem.","category":"page"},{"location":"taylorize/#taylorize","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"","category":"section"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Here, we describe the use of the macro @taylorize, which parses the functions containing the ODEs to be integrated, allowing taylorinteg and lyap_taylorinteg to be sped up.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"warning: Warning\nThe macro @taylorize is still in an experimental state; be cautious of the resulting integration, which has to be tested carefully.","category":"page"},{"location":"taylorize/#idea","page":"Optimizing: @taylorize","title":"Some context and the idea","text":"","category":"section"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The way in which taylorinteg works by default is repeatedly calling the function where the ODEs of the problem are defined, in order to compute the recurrence relations that are used to construct the Taylor expansion of the solution. This is done for each order of the series in TaylorIntegration.jetcoeffs!. These computations are not optimized: they waste memory due to repeated allocations of some temporary arrays, and perform some operations whose result has already been previously computed.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Here we describe one way to optimize this: The idea is to replace the default method of TaylorIntegration.jetcoeffs! by another method (same function name) which is called by dispatch, and that in principle performs better. The new method is constructed specifically for the function defining the equations of motion by parsing its expression. This new method performs in principle exactly the same operations, but avoids repeating some operations and the extra allocations. To achieve the latter, the macro also creates an internal function TaylorIntegration._allocate_jetcoeffs!, which allocates all temporary Taylor1 objects as well as the declared Array{Taylor1,N}s, which are stored in a TaylorIntegration.RetAlloc struct for efficiency, and include arrays (of Taylor1{T} objects) with up-to-three indices.","category":"page"},{"location":"taylorize/#An-example","page":"Optimizing: @taylorize","title":"An example","text":"","category":"section"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"In order to explain how the macro works, we shall use as an example the mathematical pendulum. First, we carry out the integration using the default method, as described before.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"using TaylorIntegration\n\nfunction pendulumNP!(dx, x, p, t) # `pendulum!` ODEs, not parsed\n dx[1] = x[2]\n dx[2] = -sin(x[1])\n return dx\nend\n\n# Initial time (t0), final time (tf) and initial condition (q0)\nt0 = 0.0\ntf = 10000.0\nq0 = [1.3, 0.0]\n\n# The actual integration\nsol1 = taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000); # warm-up run\ne1 = @elapsed taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000);\nall1 = @allocated taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000);\ne1, all1","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The initial number of methods defined for TaylorIntegration.jetcoeffs! is 2; yet, since @taylorize was used in an example previously, the current number of methods is 3, as explained below.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"println(methods(TaylorIntegration.jetcoeffs!)) # default methods","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Similarly, the number of methods for TaylorIntegration._allocate_jetcoeffs! originally is 2, and for the same reasons it is currently 3.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"println(methods(TaylorIntegration._allocate_jetcoeffs!)) # default methods","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Using @taylorize will increase this number by creating a new method for these functions.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The macro @taylorize is intended to be used in front of the function that implements the equations of motion. The macro does the following: it first parses the function as it is, so the integration can still be computed using taylorinteg as above, by explicitly using the keyword argument parse_eqs=false; this also declares the function of the ODEs, whose name is used for parsing. It then creates and evaluates a new method of TaylorIntegration.jetcoeffs!, which is the specialized method (through Val) on the specific function passed to the macro as well as a specialized TaylorIntegration._allocate_jetcoeffs!.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"@taylorize function pendulum!(dx, x, p, t)\n dx[1] = x[2]\n dx[2] = -sin(x[1])\n return dx\nend\n\nprintln(methods(pendulum!))","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"println(methods(TaylorIntegration.jetcoeffs!)) # result should be 4","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"We see that there is only one method of pendulum!, and there is a new method (four in total) of TaylorIntegration.jetcoeffs!, whose signature appears in this documentation as Val{Main.pendulum!}. It is a specialized version for the function pendulum! (with some extra information about the module where the function was created). This method is selected internally if it exists (default), exploiting dispatch, when calling taylorinteg or lyap_taylorinteg. In order to integrate using the hard-coded standard (default) method of TaylorIntegration.jetcoeffs! of the integration above, the keyword argument parse_eqs has to be set to false. Similarly, one can check that there exists a new method of TaylorIntegration._allocate_jetcoeffs!.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Now we carry out the integration using the specialized method; note that we use the same instruction as above; the default value for the keyword argument parse_eqs is true, so we may omit it.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"sol2 = taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000); # warm-up run\ne2 = @elapsed taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000);\nall2 = @allocated taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000);\ne2, all2","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"We note the difference in the performance and allocations:","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"e1/e2, all1/all2","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"We can check that both integrations yield the same results.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"sol1.t == sol2.t && sol1.x == sol2.x","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"As stated above, in order to allow opting out of using the specialized method created by @taylorize, taylorinteg and lyap_taylorinteg recognize the keyword argument parse_eqs; setting it to false causes the standard method to be used.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false); # warm-up run\n\ne3 = @elapsed taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false);\nall3 = @allocated taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false);\ne1/e3, all1/all3","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"We now illustrate the possibility of exploiting the macro when using TaylorIntegration.jl from DifferentialEquations.jl.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"using OrdinaryDiffEq\n\nprob = ODEProblem(pendulum!, q0, (t0, tf), nothing) # no parameters\nsolT = solve(prob, TaylorMethod(25), abstol=1e-20, parse_eqs=true); # warm-up run\ne4 = @elapsed solve(prob, TaylorMethod(25), abstol=1e-20, parse_eqs=true);\n\ne1/e4","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Note that there is an additional cost to using solve in comparison with taylorinteg, but still @taylorize yields improved running times.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The speed-up obtained comes from the design of the new (specialized) method of TaylorIntegration.jetcoeffs! as described above: it avoids some allocations and some repeated computations. This is achieved by knowing the specific AST of the function of the ODEs integrated, which is walked through and translated into the actual implementation, where some required auxiliary arrays are created and reused, and the low-level functions defined in TaylorSeries.jl are used. For this, we heavily rely on Espresso.jl and some metaprogramming; we thank Andrei Zhabinski for his help and comments.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The new TaylorIntegration.jetcoeffs! and TaylorIntegration._allocate_jetcoeffs! methods can be inspected by constructing the expression corresponding to the function, and using TaylorIntegration._make_parsed_jetcoeffs:","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"ex = :(function pendulum!(dx, x, p, t)\n dx[1] = x[2]\n dx[2] = -sin(x[1])\n return dx\nend)\n\nnew_ex1, new_ex2 = TaylorIntegration._make_parsed_jetcoeffs(ex)","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The first function has a similar structure as the hard-coded method of TaylorIntegration.jetcoeffs!, but uses low-level functions in TaylorSeries (e.g., sincos! above). Temporary Taylor1 objects as well as declared arrays are allocated once by TaylorIntegration._allocate_jetcoeffs!. More complex functions quickly become very difficult to read. Note that, if necessary, one can further optimize new_ex manually.","category":"page"},{"location":"taylorize/#Limitations-and-some-advice","page":"Optimizing: @taylorize","title":"Limitations and some advice","text":"","category":"section"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"The construction of the internal function obtained by using @taylorize is somewhat complicated and limited. Here we list some limitations and provide some advice.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Expressions must involve two arguments at most, which requires using parentheses appropriately: For example, res = a+b+c should be written as res = (a+b)+c. This may lead to more parentheses used in compound expressions than would be typical outside of the @taylorize context. It also means the sequence of operations will be explicit for a compound expression rather than implicit.\nUpdating operators such as +=, *=, etc., are not supported. For example, the expression x += y is not recognized by @taylorize. Likewise, expressions such as x = x+y are not supported by @taylorize and should be replaced by equivalent expressions in which variables appear only on one side of the assignment; e.g. z = x+y; x = z. The introduction of such temporary variables z is left to the user.\nThe macro allows the use of array declarations through Array or Vector, but other ways (e.g. similar) are not yet implemented. Note that certain temporary arrays may be introduced to avoid re-computating certain expressions; only up-to-three indices expressions are currently handled.\nAvoid using variables prefixed by an underscore, in particular _T, _S, _N and __idx, as well as ord; using them may lead to name collisions with some internal variables used in the constructed expressions.\nBroadcasting is not recognized by @taylorize.\nThe macro may be used in combination with the common interface with DifferentialEquations.jl, for functions using the (du, u, p, t) in-place form, as we showed above. Other extensions allowed by DifferentialEquations may not be able to exploit it.\nif-else blocks are recognized in their long form, but short-circuit conditional operators (&& and ||) are not. When comparing to a Taylor expansion, use operators such as iszero for if-else tests rather than comparing against numeric literals.\nInput and output lengths should be determined at the time of @taylorize application (parse time), not at runtime. Avoid using the length of the input as an implicit indicator of whether to write all elements of the output. If conditional output of auxiliary equations is desired use explicit methods, such as through parameters or by setting auxiliary vector elements to zero, and assigning unwanted auxiliary outputs zero.\nExpressions which correspond to function calls (so the head field is :call) which are not recognized by the parser are simply copied. The heuristics used, especially for vectors, may not work for all cases.\nUse local for internal parameters, e.g., simple constant values; this improves performance. Do not use it if the variable is needed to be Taylor expanded during the integration step.\nTo examine the code generated for jetcoeffs! and _allocate_jetcoeffs! for a specific ODE function, follow the pendulum example above; create an expression by wrapping the ODE function (without @taylorize prefix) in a :()-block, and supply the expression to TaylorIntegration._make_parsed_jetcoeffs. This can help in debugging issues with either function generated by @taylorize.\n@taylorize supports multi-threading via Threads.@threads. WARNING: this feature is experimental. Since thread-safety depends on the definition of each ODE, we cannot guarantee the resulting code to be thread-safe in advance. The user should check the resulting code to ensure that it is indeed thread-safe. For more information about multi-threading, the reader is referred to the Julia documentation.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"We recommend to skim test/taylorize.jl, which implements different cases and highlights examples where the macro does not work, and how to solve the problem; read the information that is in the comments.","category":"page"},{"location":"taylorize/","page":"Optimizing: @taylorize","title":"Optimizing: @taylorize","text":"Please report any problems you may encounter.","category":"page"},{"location":"lyapunov_spectrum/#lyap","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"","category":"section"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"Here we describe the background of the Lyapunov spectra computations in TaylorIntegration.jl. Our implementation follows the numerical method of Benettin et al. [1], [2], which itself is based on Oseledet's multiplicative ergodic theorem [3]. Namely, simultaneously to the integration of the equations of motion, we integrate the 1st-order variational equations associated to them.","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"In general, given a dynamical system defined by the equations of motion","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"dotx = f(t x)tag1","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"along with the initial condition x(t_0) = x_0, then the first-order variational equations associated to this system are","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"dotxi = (operatornameDf)(x(t))cdot xitag2","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"where (operatornameDf)(x(t)) is the Jacobian of the function f with respect to the dependent variable x, evaluated at time t, for a given solution x(t) to the equations of motion. The variable xi denotes a matrix, whose initial condition is xi(t_0) = mathbb1_n, the ntimes n identity matrix, where n is the degrees of freedom or number of dependent variables x.","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"For the actual computation of the Lyapunov spectrum, we proceed as follows. During the simultaneous numerical integration of the equations of motion and the variational equations, at fixed time intervals t_k = kcdot Delta t, k = 1 2 ldots we perform a QR decomposition over xi(t_k), the solution of the variational equations at time t_k. That is, we factorize xi(t_k) as xi(t_k)=Q_kcdot R_k, where Q_k is an orthogonal ntimes n matrix and R_k is an upper triangular ntimes n matrix with positive diagonal elements. The diagonal elements R_iik are the growth factors from which the l-th Lyapunov exponent is computed at time t_k","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"lambda_l = sum_m=1^k fraclog (R_llm)kcdot Delta ttag3","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"In turn, the matrix Q is substituted into xi(t_k) as the new (scaled) initial condition.","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"The equations of motion together with the variational equations are integrated up to time t_k+1 using Taylor's method. We note that each time step of the integration is determined using the normalized derivatives of x and the tolerance epsilon_textrmtol. This process is repeated until a prescribed t_textrmmax is reached.","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"This example illustrates the computation of the Lyapunov spectrum for the Lorenz system.","category":"page"},{"location":"lyapunov_spectrum/#refsL","page":"Lyapunov spectrum","title":"References","text":"","category":"section"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"[1] Benettin G., Galgani L., Giorgilli A., Strelcyn J.M., 1980, Meccanica, 15, 9","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"[2] Benettin G., Galgani L., Giorgilli A., Strelcyn J.M., 1980, Meccanica, 15, 21","category":"page"},{"location":"lyapunov_spectrum/","page":"Lyapunov spectrum","title":"Lyapunov spectrum","text":"[3] Oseledets V. I., 1968, Trudy Moskovskogo Matematicheskogo Obshchestva, 19, 179","category":"page"},{"location":"#TaylorIntegration.jl","page":"Home","title":"TaylorIntegration.jl","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"ODE integration using Taylor's method, and more, in Julia.","category":"page"},{"location":"","page":"Home","title":"Home","text":"","category":"page"},{"location":"#Authors","page":"Home","title":"Authors","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"Jorge A. Pérez, Instituto de Ciencias Físicas, Universidad Nacional Autónoma de México (UNAM)\nLuis Benet, Instituto de Ciencias Físicas, Universidad Nacional Autónoma de México (UNAM)","category":"page"},{"location":"#License","page":"Home","title":"License","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"TaylorIntegration is licensed under the MIT \"Expat\" license.","category":"page"},{"location":"#Installation","page":"Home","title":"Installation","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"TaylorIntegration.jl is a registered package, and is simply installed by running","category":"page"},{"location":"","page":"Home","title":"Home","text":"pkg> add TaylorIntegration","category":"page"},{"location":"#Supporting-and-citing","page":"Home","title":"Supporting and citing","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"This package is developed as part of academic research. If you would like to help supporting it, please star the repository as such metrics may help us secure funding. If you use this software, we would be grateful if you could cite our work as follows (Bibtex entry can be found here):","category":"page"},{"location":"","page":"Home","title":"Home","text":"J.A. Pérez-Hernández and L. Benet\nTaylorIntegration.jl: Taylor Integration in Julia\nhttps://github.com/PerezHz/TaylorIntegration.jl\nDOI:[10.5281/zenodo.2562352](https://doi.org/10.5281/zenodo.2562352)","category":"page"},{"location":"#Acknowledgments","page":"Home","title":"Acknowledgments","text":"","category":"section"},{"location":"","page":"Home","title":"Home","text":"We acknowledge financial support from the DGAPA-PAPIIT (UNAM) grant IG-100616. LB acknowledges support through a Cátedra Marcos Moshinsky (2013).","category":"page"},{"location":"kepler/#kepler_problem","page":"The Kepler problem","title":"The Kepler problem","text":"","category":"section"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"The Kepler problem corresponds to the study of the motion of two bodies which are influenced by their mutual gravitational attraction. In the center of mass and relative coordinates, the problem is reduced to the motion of one body of mass m = m_1 m_2 M, which we shall refer as particle below, attracted gravitationally by another located at rest at the origin of mass M=m_1+m_2.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"In cartesian coordinates, the equations of motion can be written as","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"beginaligned\ndotx = v_x\ndoty = v_y\ndotv_x = - fracG M x(x^2 + y^2)^32\ndotv_y = - fracG M y(x^2 + y^2)^32\nendaligned","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"For concreteness, we fix mu = G M = 1. The coordinates x and y are the relative coordinates (to the center of mass) of the particle, and v_x and v_y its velocity. The function kepler_eqs! mutates the vectors corresponding to the LHS of the equations of motion.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"function kepler_eqs!(dq, q, params, t)\n dq[1] = q[3]\n dq[2] = q[4]\n rr = ( q[1]^2 + q[2]^2 )^(3/2)\n dq[3] = - q[1] / rr\n dq[4] = - q[2] / rr\nend;","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"For suitable initial conditions (such that the total energy is negative) the solutions are ellipses with one focus at the origin, which can be parameterized in terms of its semi-major axis a and its eccentricity e. We set the initial conditions for the particle at periapse, which we locate on the positive x-axis. Using the semimajor axis and the eccentricity, we write them as","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"beginaligned\nx_0 = a (1-e)\ny_0 = 0\nv_x_0 = 0\nv_y_0 = fracl_zx_0 = m fracsqrtmu a (1-e^2)x_0\nendaligned","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"where l_z is the angular momentum. We set the mass of the particle m=1, the semi-major axis a=1 and the eccentricity e=08. Kepler's third law defines the period of the motion as T= 2pi a^32.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"const mu = 1.0\nconst mass = 1.0\nconst aKep = 1.0\nconst eKep = 0.8;","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"The initial conditions are then set using ini_cond","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"function ini_cond(a, e)\n x0 = a*(one(e)-e)\n vy0 = mass * sqrt( mu * a * (1-e^2) ) / x0\n y0 = zero(vy0)\n vx0 = zero(vy0)\n return [x0, y0, vx0, vy0]\nend\nq0 = ini_cond(aKep, eKep)","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"We now perform the integration, using a 25 order expansion and absolute tolerance of 10^-20.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"using TaylorIntegration, Plots\nsol = taylorinteg(kepler_eqs!, q0, 0.0, 10000*2pi, 25, 1.0e-20, maxsteps=700_000);\nt, q = sol.t, sol.x;\nt[end], q[end,:]","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"We first plot the orbit. (For performance reasons only the first 10000 points are considered.)","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"x = view(q, :, 1)\ny = view(q, :, 2)\nvx = view(q, :, 3)\nvy = view(q, :, 4)\nplot(x[1:10_000], y[1:10_000], legend=false)\nscatter!([0], [0], shape=:circle, ms=5)\nxaxis!(\"x\", (-2.0, 0.5))\nyaxis!(\"y\", (-1.0, 1.0))\ntitle!(\"Fig. 1\")","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"The following functions allow us to calculate the energy and angular momentum using cartesian coordinates.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"function energy( x, y, vx, vy )\n kinetic = 0.5 * (vx*vx + vy*vy)\n r = sqrt( x*x + y*y)\n potential = - mu * mass / r\n return kinetic + potential\nend\nlz( x, y, vx, vy ) = mass * ( x*vy - y*vx ) ;","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"We use the change in energy and angular momentum of the orbit with respect to the initial value of the corresponding quantity as a function of time. These quantities are expressed in units of the local epsilon of the initial energy or angular momentum, respectively. This serves to illustrate the accuracy of the calculation, shown in Figure 2 and 3.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"e0 = energy(q0...)\nδE = (energy.(x,y,vx,vy) .- e0) ./ eps(e0)\nplot(t[1:3:end], δE[1:3:end])\nxlabel!(\"t\")\nylabel!(\"dE\")\ntitle!(\"Fig. 2\")","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"lz0 = lz(q0...)\nδlz = (lz.(x,y,vx,vy) .- lz0) ./ eps(lz0)\nplot(t[1:3:end], δlz[1:3:end])\nxlabel!(\"t\")\nylabel!(\"dlz\")\ntitle!(\"Fig. 3\")","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"These errors are reminiscent of random walks.","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"The maximum absolute errors of the energy and angular momentum are","category":"page"},{"location":"kepler/","page":"The Kepler problem","title":"The Kepler problem","text":"maximum( abs.(energy.(x,y,vx,vy) .- e0) ), maximum( abs.(lz.(x,y,vx,vy) .- lz0) )","category":"page"}] +} diff --git a/v0.16.1/simple_example/47ad181b.svg b/v0.16.1/simple_example/47ad181b.svg new file mode 100644 index 000000000..dd6644793 --- /dev/null +++ b/v0.16.1/simple_example/47ad181b.svg @@ -0,0 +1,197 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/simple_example/529b4583.svg b/v0.16.1/simple_example/529b4583.svg new file mode 100644 index 000000000..5bb8de2f8 --- /dev/null +++ b/v0.16.1/simple_example/529b4583.svg @@ -0,0 +1,200 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/v0.16.1/simple_example/index.html b/v0.16.1/simple_example/index.html new file mode 100644 index 000000000..b593600b5 --- /dev/null +++ b/v0.16.1/simple_example/index.html @@ -0,0 +1,17 @@ + +Infinity in finite time · TaylorIntegration.jl

    Infinity in finite time

    Illustration of the method

    We shall illustrate first with a simple example how the method explicitly constructs the solution, and how to use the package to obtain it.

    We consider the differential equation given by

    \[\dot{x} = x^2,\tag{1}\]

    with the initial condition $x(0)=x_0$, whose exact solution reads

    \[x(t) = \frac{x_0}{1-x_0t}.\tag{2}\]

    We shall implement the construction of this example explicitly, which illustrates the way TaylorIntegration.jl is conceived.

    The initial condition defines the 0-th order approximation, i.e., $x(t) = x_0 + \mathcal{O}(t^1)$. We now write the solution as $x(t) = x_0 + x_{[1]}t + \mathcal{O}(t^2)$, and we want to determine $x_{[1]}$. Substituting this solution into the RHS of (1), yields

    \[x^2 = x_0^2 + 2 x_0 x_{[1]} t + x_{[1]}^2 t^2 = + x_0^2 + \mathcal{O}(t^1),\]

    where in the last equality we have kept all terms up to order 0, since we want to determine $x_{[1]}$, and the recursion formula requires for that the 0-th order term of the Taylor expansion of the RHS of the equation of motion. Hence, we have $f_{[0]}=x_0^2$, which using the recursion relation $x_{[k+1]} = f_{[k]}/(k+1)$ yields $x_{[1]} = x_0^2$.

    Following the same procedure, we write $x(t) = x_0 + x_{[1]} t + x_{[2]} t^2 + \mathcal{O}(t^3)$, and

    \[x^2 = x_0^2 + 2 x_0 x_{[1]} t + \mathcal{O}(t^2),\]

    where we kept all terms up to order 1. We thus have $f_{[1]}=2 x_0 x_{[1]} = 2 x_0^3$, which then yields $x_{[2]} = x_0^3$. Repeating this calculation, we obtain

    \[x(t) = x_0 + x_0^2 t + x_0^3 t^2 + \cdots + x_0^{k+1} t^k + \cdots.\tag{3}\]

    The solution given by Eq. (3) is a geometrical series, which is identical to the exact solution, Eq. (2). Yet, it is not obvious from the solution that it is only defined for $t<1/x_0$. To see this, we obtain the step size, as described previously, for the series truncated to order $k$. The Taylor coefficient of order $k$ is $x_{[k]}=x_0^{k+1}$, so the time step is

    \[h < \Big(\frac{\epsilon_\textrm{tol}}{|x_0^{k+1}|}\Big)^{1/k} = +\frac{\epsilon_\textrm{tol}^{1/k}}{|x_0|^{1+1/k}}.\]

    In the limit $k\to\infty$ we obtain $h < h_\textrm{max}=1/x_0$, which is the domain of existence of the exact solution.

    Below, we shall fix a maximum order for the expansion. This entails a truncation error which is somewhat controlled through the absolute tolerance $\epsilon_\textrm{tol}$. The key to a correct use of Taylor's method is to impose a quite small value of $\epsilon_\textrm{tol}$ together with a large enough order of the expansion.

    Implementation

    We shall illustrate how to use TaylorIntegration.jl to integrate Eq. (1) for the initial condition $x(0)=3$. Notice that according to the exact solution Eq. (2), the solution only exists for $t<t_\mathrm{max} =1/3$; in addition, we note that this number can not be represented exactly as a floating-point number.

    We first load the required packages and define a function which represents the equation of motion.

    using TaylorIntegration, Plots
    +diffeq(x, p, t) = x^2;
    diffeq (generic function with 1 method)
    Note

    In TaylorIntegration.jl we use the same convention of DifferentialEquations.jl when writing the function representing the equations of motion.

    We now integrate the equations of motion using taylorinteg; note that, despite of the fact that the solution only exists for $t<t_\textrm{max}$, below we shall try to compute it up to $t_\textrm{end}=0.34$; as we shall see, Taylor's method takes care of this. For the integration presented below, we use a 25-th series expansion, with $\epsilon_\textrm{tol} = 10^{-20}$, and compute up to 150 integration steps. The type of the solution returned by taylorinteg is TaylorSolution.

    sol = taylorinteg(diffeq, 3.0, 0.0, 0.34, 25, 1e-20, maxsteps=150);
    tspan: (0.0, 0.33333328367608234), x: 1 Float64 variable

    We first note that the last point of the calculation does not exceed $t_\textrm{max}$.

    sol.t[end]
    0.33333328367608234

    Increasing the maxsteps parameter pushes sol.t[end] closer to $t_\textrm{max}$ but it actually does not reach this value.

    Figure 1 displays the computed solution as a function of time, in log scale.

    plot(sol.t, log10.(sol.x), shape=:circle)
    +xlabel!("t")
    +ylabel!("log10(x(t))")
    +xlims!(0,0.34)
    +title!("Fig. 1")
    Example block output

    Clearly, the solution diverges without bound when $t\to t_\textrm{max} = 1/3$, i.e., $x(t)$ approaches infinity in finite time.

    Figure 2 shows the relative difference between the numerical and the analytical solution in terms of time.

    exactsol(t, x0) = x0 / (1 - x0 * t)
    +δxT = abs.(sol.x .- exactsol.(sol.t, 3.0)) ./ exactsol.(sol.t, 3.0);
    +plot(sol.t[6:end], log10.(sol.x[6:end]), shape=:circle)
    +xlabel!("t")
    +ylabel!("log10(dx(t))")
    +xlims!(0, 0.4)
    +title!("Fig. 2")
    Example block output

    To put in perspective how good is the constructed solution, we impose (arbitrarily) a relative accuracy of $10^{-13}$; the time until such accuracy is satisfied is given by:

    indx = findfirst(δxT .> 1.0e-13);
    +esol = exactsol(sol.t[indx-1],3.0);
    +sol.t[indx-1], esol, eps(esol)
    (0.3323590833381362, 1026.4305926915836, 2.2737367544323206e-13)

    Note that, the accuracy imposed in terms of the actual value of the exact solution means that the difference of the computed and the exact solution is essentially due to the eps of the computed value.

    diff --git a/v0.16.1/siteinfo.js b/v0.16.1/siteinfo.js new file mode 100644 index 000000000..afd23cc7e --- /dev/null +++ b/v0.16.1/siteinfo.js @@ -0,0 +1 @@ +var DOCUMENTER_CURRENT_VERSION = "v0.16.1"; diff --git a/v0.16.1/taylor_method/index.html b/v0.16.1/taylor_method/index.html new file mode 100644 index 000000000..eb842294c --- /dev/null +++ b/v0.16.1/taylor_method/index.html @@ -0,0 +1,4 @@ + +Taylor's method · TaylorIntegration.jl

    Taylor's method

    Taylor's integration method is a quite powerful method to integrate ODEs which are smooth enough, allowing to reach a precision comparable to round-off errors per time-step. A high-order Taylor approximation of the solution (dependent variable) is constructed such that the error is quite small. A time-step is constructed which guarantees the validity of the series; this is used to sum up the Taylor expansion to obtain an approximation of the solution at a later time.

    The recurrence relation

    Let us consider the following

    \[\dot{x} = f(t, x),\tag{1}\]

    and define the initial value problem with the initial condition $x(t_0) = x(0)$.

    We write the solution of this equation as

    \[x = x_{[0]} + x_{[1]} (t-t_0) + x_{[2]} (t-t_0)^2 + \cdots + +x_{[k]} (t-t_0)^k + \cdots,\tag{2}\]

    where the initial condition imposes that $x_{[0]} = x(0)$. Below, we show how to obtain the coefficients $x_{[k]}$ of the Taylor expansion of the solution.

    We assume that the Taylor expansion around $t_0$ of $f(t, x(t))$ is known, which we write as

    \[f(t, x(t)) = f_{[0]} + f_{[1]} (t-t_0) + f_{[2]} (t-t_0)^2 + \cdots ++ f_{[k]} (t-t_0)^k + \cdots.\tag{3}\]

    Here, $f_{[0]}=f(t_0,x_0)$, and the Taylor coefficients $f_{[k]} = f_{[k]}(t_0)$ are the $k$-th normalized derivatives at $t_0$ given by

    \[f_{[k]} = \frac{1}{k!} \frac{{\rm d}^k f} {{\rm d} t^k}(t_0).\tag{4}\]

    Then, we are assuming that we know how to obtain $f_{[k]}$; these coefficients are obtained using TaylorSeries.jl.

    Substituting Eq. (2) in (1), and equating powers of $t-t_0$, we obtain

    \[x_{[k+1]} = \frac{f_{[k]}(t_0)}{k+1}, \quad k=0,1,\dots.\tag{5}\]

    Therefore, the coefficients of the Taylor expansion (2) are obtained recursively using Eq. (5).

    Time step

    In the computer, the expansion (2) has to be computed to a finite order. We shall denote by $K$ the order of the series. In principle, the larger the order $K$, the more accurate the obtained solution is.

    The theorem of existence and uniqueness of the solution of Eq.~(1) ensures that the Taylor expansion converges. Then, assuming that $K$ is large enough to be within the convergent tail, we introduce the parameter $\epsilon_\textrm{tol} > 0$ to control how large is the last term. The idea is to set this parameter to a small value, usually smaller than the machine-epsilon. Denoting by $h = t_1-t_0$ the time step, then imposing $| x_{[K]} | h^K \le \epsilon_\textrm{tol}$ we obtain

    \[h \le \Big(\frac{\epsilon_\textrm{tol}}{| x_{[K]} |}\Big)^{1/K}.\tag{6}\]

    Equation (6) represents the maximum time-step which is consistent with $\epsilon_\textrm{tol}$, $K$ and the assumption of being within the convergence tail. Notice that the arguments exposed above simply ensure that $h$ is a maximum time-step, but any other smaller than $h$ can be used since the series is convergent in the open interval $t\in(t_0-h,t_0+h)$.

    Finally, from Eq. (2) with (6) we obtain $x(t_1) = x(t_0+h)$, which is again an initial value problem.

    diff --git a/v0.16.1/taylorize/index.html b/v0.16.1/taylorize/index.html new file mode 100644 index 000000000..360d57692 --- /dev/null +++ b/v0.16.1/taylorize/index.html @@ -0,0 +1,87 @@ + +Optimizing: @taylorize · TaylorIntegration.jl

    Optimizing: @taylorize

    Here, we describe the use of the macro @taylorize, which parses the functions containing the ODEs to be integrated, allowing taylorinteg and lyap_taylorinteg to be sped up.

    Warning

    The macro @taylorize is still in an experimental state; be cautious of the resulting integration, which has to be tested carefully.

    Some context and the idea

    The way in which taylorinteg works by default is repeatedly calling the function where the ODEs of the problem are defined, in order to compute the recurrence relations that are used to construct the Taylor expansion of the solution. This is done for each order of the series in TaylorIntegration.jetcoeffs!. These computations are not optimized: they waste memory due to repeated allocations of some temporary arrays, and perform some operations whose result has already been previously computed.

    Here we describe one way to optimize this: The idea is to replace the default method of TaylorIntegration.jetcoeffs! by another method (same function name) which is called by dispatch, and that in principle performs better. The new method is constructed specifically for the function defining the equations of motion by parsing its expression. This new method performs in principle exactly the same operations, but avoids repeating some operations and the extra allocations. To achieve the latter, the macro also creates an internal function TaylorIntegration._allocate_jetcoeffs!, which allocates all temporary Taylor1 objects as well as the declared Array{Taylor1,N}s, which are stored in a TaylorIntegration.RetAlloc struct for efficiency, and include arrays (of Taylor1{T} objects) with up-to-three indices.

    An example

    In order to explain how the macro works, we shall use as an example the mathematical pendulum. First, we carry out the integration using the default method, as described before.

    using TaylorIntegration
    +
    +function pendulumNP!(dx, x, p, t) # `pendulum!` ODEs, not parsed
    +    dx[1] = x[2]
    +    dx[2] = -sin(x[1])
    +    return dx
    +end
    +
    +# Initial time (t0), final time (tf) and initial condition (q0)
    +t0 = 0.0
    +tf = 10000.0
    +q0 = [1.3, 0.0]
    +
    +# The actual integration
    +sol1 = taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000); # warm-up run
    +e1 = @elapsed taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000);
    +all1 = @allocated taylorinteg(pendulumNP!, q0, t0, tf, 25, 1e-20, maxsteps=50000);
    +e1, all1
    (1.058779165, 812244848)

    The initial number of methods defined for TaylorIntegration.jetcoeffs! is 2; yet, since @taylorize was used in an example previously, the current number of methods is 3, as explained below.

    println(methods(TaylorIntegration.jetcoeffs!)) # default methods
    # 3 methods for generic function "jetcoeffs!" from TaylorIntegration:
    + [1] jetcoeffs!(::Val{Main.__atexample__named__common.pcr3bp!}, t::Taylor1{_T}, q::AbstractArray{Taylor1{_S}, _N}, dq::AbstractArray{Taylor1{_S}, _N}, param, __ralloc::TaylorIntegration.RetAlloc{Taylor1{_S}}) where {_T<:Real, _S<:Number, _N}
    +     @ Main.__atexample__named__common none:0
    + [2] jetcoeffs!(eqsdiff!::Function, t::Taylor1{T}, x::AbstractArray{Taylor1{U}, N}, dx::AbstractArray{Taylor1{U}, N}, xaux::AbstractArray{Taylor1{U}, N}, params) where {T<:Real, U<:Number, N}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:62
    + [3] jetcoeffs!(eqsdiff::Function, t::Taylor1{T}, x::Taylor1{U}, params) where {T<:Real, U<:Number}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:23

    Similarly, the number of methods for TaylorIntegration._allocate_jetcoeffs! originally is 2, and for the same reasons it is currently 3.

    println(methods(TaylorIntegration._allocate_jetcoeffs!)) # default methods
    # 3 methods for generic function "_allocate_jetcoeffs!" from TaylorIntegration:
    + [1] _allocate_jetcoeffs!(::Val{Main.__atexample__named__common.pcr3bp!}, t::Taylor1{_T}, q::AbstractArray{Taylor1{_S}, _N}, dq::AbstractArray{Taylor1{_S}, _N}, param) where {_T<:Real, _S<:Number, _N}
    +     @ Main.__atexample__named__common none:0
    + [2] _allocate_jetcoeffs!(::Taylor1{T}, x::AbstractArray{Taylor1{S}, N}, ::AbstractArray{Taylor1{S}, N}, params) where {T, S, N}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:109
    + [3] _allocate_jetcoeffs!(::Taylor1{T}, x::Taylor1{S}, params) where {T, S}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:108

    Using @taylorize will increase this number by creating a new method for these functions.

    The macro @taylorize is intended to be used in front of the function that implements the equations of motion. The macro does the following: it first parses the function as it is, so the integration can still be computed using taylorinteg as above, by explicitly using the keyword argument parse_eqs=false; this also declares the function of the ODEs, whose name is used for parsing. It then creates and evaluates a new method of TaylorIntegration.jetcoeffs!, which is the specialized method (through Val) on the specific function passed to the macro as well as a specialized TaylorIntegration._allocate_jetcoeffs!.

    @taylorize function pendulum!(dx, x, p, t)
    +    dx[1] = x[2]
    +    dx[2] = -sin(x[1])
    +    return dx
    +end
    +
    +println(methods(pendulum!))
    # 1 method for generic function "pendulum!" from Main:
    + [1] pendulum!(dx, x, p, t)
    +     @ none:0
    println(methods(TaylorIntegration.jetcoeffs!)) # result should be 4
    # 4 methods for generic function "jetcoeffs!" from TaylorIntegration:
    + [1] jetcoeffs!(::Val{Main.pendulum!}, t::Taylor1{_T}, x::AbstractArray{Taylor1{_S}, _N}, dx::AbstractArray{Taylor1{_S}, _N}, p, __ralloc::TaylorIntegration.RetAlloc{Taylor1{_S}}) where {_T<:Real, _S<:Number, _N}
    +     @ Main none:0
    + [2] jetcoeffs!(::Val{Main.__atexample__named__common.pcr3bp!}, t::Taylor1{_T}, q::AbstractArray{Taylor1{_S}, _N}, dq::AbstractArray{Taylor1{_S}, _N}, param, __ralloc::TaylorIntegration.RetAlloc{Taylor1{_S}}) where {_T<:Real, _S<:Number, _N}
    +     @ Main.__atexample__named__common none:0
    + [3] jetcoeffs!(eqsdiff!::Function, t::Taylor1{T}, x::AbstractArray{Taylor1{U}, N}, dx::AbstractArray{Taylor1{U}, N}, xaux::AbstractArray{Taylor1{U}, N}, params) where {T<:Real, U<:Number, N}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:62
    + [4] jetcoeffs!(eqsdiff::Function, t::Taylor1{T}, x::Taylor1{U}, params) where {T<:Real, U<:Number}
    +     @ ~/work/TaylorIntegration.jl/TaylorIntegration.jl/src/integrator/jetcoeffs.jl:23

    We see that there is only one method of pendulum!, and there is a new method (four in total) of TaylorIntegration.jetcoeffs!, whose signature appears in this documentation as Val{Main.pendulum!}. It is a specialized version for the function pendulum! (with some extra information about the module where the function was created). This method is selected internally if it exists (default), exploiting dispatch, when calling taylorinteg or lyap_taylorinteg. In order to integrate using the hard-coded standard (default) method of TaylorIntegration.jetcoeffs! of the integration above, the keyword argument parse_eqs has to be set to false. Similarly, one can check that there exists a new method of TaylorIntegration._allocate_jetcoeffs!.

    Now we carry out the integration using the specialized method; note that we use the same instruction as above; the default value for the keyword argument parse_eqs is true, so we may omit it.

    sol2 = taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000); # warm-up run
    +e2 = @elapsed taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000);
    +all2 = @allocated taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000);
    +e2, all2
    (0.117495775, 51763216)

    We note the difference in the performance and allocations:

    e1/e2, all1/all2
    (9.01121053076164, 15.69154528574886)

    We can check that both integrations yield the same results.

    sol1.t == sol2.t && sol1.x == sol2.x
    true

    As stated above, in order to allow opting out of using the specialized method created by @taylorize, taylorinteg and lyap_taylorinteg recognize the keyword argument parse_eqs; setting it to false causes the standard method to be used.

    taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false); # warm-up run
    +
    +e3 = @elapsed taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false);
    +all3 = @allocated taylorinteg(pendulum!, q0, t0, tf, 25, 1e-20, maxsteps=50000, parse_eqs=false);
    +e1/e3, all1/all3
    (1.0013556719726204, 1.0000024229205924)

    We now illustrate the possibility of exploiting the macro when using TaylorIntegration.jl from DifferentialEquations.jl.

    using OrdinaryDiffEq
    +
    +prob = ODEProblem(pendulum!, q0, (t0, tf), nothing) # no parameters
    +solT = solve(prob, TaylorMethod(25), abstol=1e-20, parse_eqs=true); # warm-up run
    +e4 = @elapsed solve(prob, TaylorMethod(25), abstol=1e-20, parse_eqs=true);
    +
    +e1/e4
    16.428707409855935

    Note that there is an additional cost to using solve in comparison with taylorinteg, but still @taylorize yields improved running times.

    The speed-up obtained comes from the design of the new (specialized) method of TaylorIntegration.jetcoeffs! as described above: it avoids some allocations and some repeated computations. This is achieved by knowing the specific AST of the function of the ODEs integrated, which is walked through and translated into the actual implementation, where some required auxiliary arrays are created and reused, and the low-level functions defined in TaylorSeries.jl are used. For this, we heavily rely on Espresso.jl and some metaprogramming; we thank Andrei Zhabinski for his help and comments.

    The new TaylorIntegration.jetcoeffs! and TaylorIntegration._allocate_jetcoeffs! methods can be inspected by constructing the expression corresponding to the function, and using TaylorIntegration._make_parsed_jetcoeffs:

    ex = :(function pendulum!(dx, x, p, t)
    +    dx[1] = x[2]
    +    dx[2] = -sin(x[1])
    +    return dx
    +end)
    +
    +new_ex1, new_ex2 = TaylorIntegration._make_parsed_jetcoeffs(ex)
    (:(function TaylorIntegration.jetcoeffs!(::Val{pendulum!}, t::Taylor1{_T}, x::AbstractArray{Taylor1{_S}, _N}, dx::AbstractArray{Taylor1{_S}, _N}, p, __ralloc::TaylorIntegration.RetAlloc{Taylor1{_S}}) where {_T <: Real, _S <: Number, _N}
    +      order = t.order
    +      tmp381 = __ralloc.v0[1]
    +      tmp383 = __ralloc.v0[2]
    +      for ord = 0:order - 1
    +          ordnext = ord + 1
    +          TaylorSeries.identity!(dx[1], x[2], ord)
    +          TaylorSeries.sincos!(tmp381, tmp383, x[1], ord)
    +          TaylorSeries.subst!(dx[2], tmp381, ord)
    +          for __idx = eachindex(x)
    +              TaylorIntegration.solcoeff!(x[__idx], dx[__idx], ordnext)
    +          end
    +      end
    +      return nothing
    +  end), :(function TaylorIntegration._allocate_jetcoeffs!(::Val{pendulum!}, t::Taylor1{_T}, x::AbstractArray{Taylor1{_S}, _N}, dx::AbstractArray{Taylor1{_S}, _N}, p) where {_T <: Real, _S <: Number, _N}
    +      order = t.order
    +      dx[1] = Taylor1(identity(constant_term(x[2])), order)
    +      tmp381 = Taylor1(sin(constant_term(x[1])), order)
    +      tmp383 = Taylor1(cos(constant_term(x[1])), order)
    +      dx[2] = Taylor1(-(constant_term(tmp381)), order)
    +      return TaylorIntegration.RetAlloc{Taylor1{_S}}([tmp381, tmp383], [Array{Taylor1{_S}, 1}(undef, 0)], [Array{Taylor1{_S}, 2}(undef, 0, 0)], [Array{Taylor1{_S}, 3}(undef, 0, 0, 0)], [Array{Taylor1{_S}, 4}(undef, 0, 0, 0, 0)])
    +  end))

    The first function has a similar structure as the hard-coded method of TaylorIntegration.jetcoeffs!, but uses low-level functions in TaylorSeries (e.g., sincos! above). Temporary Taylor1 objects as well as declared arrays are allocated once by TaylorIntegration._allocate_jetcoeffs!. More complex functions quickly become very difficult to read. Note that, if necessary, one can further optimize new_ex manually.

    Limitations and some advice

    The construction of the internal function obtained by using @taylorize is somewhat complicated and limited. Here we list some limitations and provide some advice.

    • Expressions must involve two arguments at most, which requires using parentheses appropriately: For example, res = a+b+c should be written as res = (a+b)+c. This may lead to more parentheses used in compound expressions than would be typical outside of the @taylorize context. It also means the sequence of operations will be explicit for a compound expression rather than implicit.

    • Updating operators such as +=, *=, etc., are not supported. For example, the expression x += y is not recognized by @taylorize. Likewise, expressions such as x = x+y are not supported by @taylorize and should be replaced by equivalent expressions in which variables appear only on one side of the assignment; e.g. z = x+y; x = z. The introduction of such temporary variables z is left to the user.

    • The macro allows the use of array declarations through Array or Vector, but other ways (e.g. similar) are not yet implemented. Note that certain temporary arrays may be introduced to avoid re-computating certain expressions; only up-to-three indices expressions are currently handled.

    • Avoid using variables prefixed by an underscore, in particular _T, _S, _N and __idx, as well as ord; using them may lead to name collisions with some internal variables used in the constructed expressions.

    • Broadcasting is not recognized by @taylorize.

    • The macro may be used in combination with the common interface with DifferentialEquations.jl, for functions using the (du, u, p, t) in-place form, as we showed above. Other extensions allowed by DifferentialEquations may not be able to exploit it.

    • if-else blocks are recognized in their long form, but short-circuit conditional operators (&& and ||) are not. When comparing to a Taylor expansion, use operators such as iszero for if-else tests rather than comparing against numeric literals.

    • Input and output lengths should be determined at the time of @taylorize application (parse time), not at runtime. Avoid using the length of the input as an implicit indicator of whether to write all elements of the output. If conditional output of auxiliary equations is desired use explicit methods, such as through parameters or by setting auxiliary vector elements to zero, and assigning unwanted auxiliary outputs zero.

    • Expressions which correspond to function calls (so the head field is :call) which are not recognized by the parser are simply copied. The heuristics used, especially for vectors, may not work for all cases.

    • Use local for internal parameters, e.g., simple constant values; this improves performance. Do not use it if the variable is needed to be Taylor expanded during the integration step.

    • To examine the code generated for jetcoeffs! and _allocate_jetcoeffs! for a specific ODE function, follow the pendulum example above; create an expression by wrapping the ODE function (without @taylorize prefix) in a :()-block, and supply the expression to TaylorIntegration._make_parsed_jetcoeffs. This can help in debugging issues with either function generated by @taylorize.

    • @taylorize supports multi-threading via Threads.@threads. WARNING: this feature is experimental. Since thread-safety depends on the definition of each ODE, we cannot guarantee the resulting code to be thread-safe in advance. The user should check the resulting code to ensure that it is indeed thread-safe. For more information about multi-threading, the reader is referred to the Julia documentation.

    We recommend to skim test/taylorize.jl, which implements different cases and highlights examples where the macro does not work, and how to solve the problem; read the information that is in the comments.

    Please report any problems you may encounter.

    diff --git a/versions.js b/versions.js index 69f51fc08..dc79edf5a 100644 --- a/versions.js +++ b/versions.js @@ -15,5 +15,5 @@ var DOC_VERSIONS = [ "v0.4", "dev", ]; -var DOCUMENTER_NEWEST = "v0.16.0"; +var DOCUMENTER_NEWEST = "v0.16.1"; var DOCUMENTER_STABLE = "stable";