From 9e28dcec889a7b55a3597671800d562b151fc9cd Mon Sep 17 00:00:00 2001 From: "Documenter.jl" Date: Tue, 26 Nov 2024 02:03:25 +0000 Subject: [PATCH] build based on 8875e6c --- previews/PR184/.documenter-siteinfo.json | 1 + previews/PR184/API/index.html | 40 + previews/PR184/assets/bmwk_logo_en.svg | 1 + previews/PR184/assets/documenter.js | 1082 +++++++++++++++++ previews/PR184/assets/makelatexfigs | 21 + previews/PR184/assets/mathmodel.svg | 543 +++++++++ previews/PR184/assets/mathmodel.tex | 65 + .../PR184/assets/themes/catppuccin-frappe.css | 1 + .../PR184/assets/themes/catppuccin-latte.css | 1 + .../assets/themes/catppuccin-macchiato.css | 1 + .../PR184/assets/themes/catppuccin-mocha.css | 1 + .../PR184/assets/themes/documenter-dark.css | 7 + .../PR184/assets/themes/documenter-light.css | 9 + previews/PR184/assets/themeswap.js | 84 ++ previews/PR184/assets/warner.js | 52 + previews/PR184/generated/StochasticSystem.jl | 128 ++ previews/PR184/generated/cascading_failure.jl | 152 +++ .../generated/cascading_failure/d235e48e.svg | 62 + .../generated/cascading_failure/index.html | 73 ++ .../generated/directed_and_weighted_graphs.jl | 121 ++ .../directed_and_weighted_graphs/e002d24b.svg | 132 ++ .../directed_and_weighted_graphs/index.html | 48 + previews/PR184/generated/gas_network.jl | 379 ++++++ .../PR184/generated/gas_network/43f744c5.svg | 1008 +++++++++++++++ .../PR184/generated/gas_network/c1087a40.svg | 922 ++++++++++++++ .../PR184/generated/gas_network/fc4b8144.svg | 529 ++++++++ .../PR184/generated/gas_network/index.html | 224 ++++ .../getting_started_with_network_dynamics.jl | 157 +++ .../190ecac8.svg | 88 ++ .../6b3a5417.svg | 60 + .../7d053527.svg | 82 ++ .../index.html | 43 + .../PR184/generated/heterogeneous_system.jl | 149 +++ .../heterogeneous_system/022b6041.svg | 62 + .../heterogeneous_system/5a435ac8.svg | 62 + .../heterogeneous_system/68c01707.svg | 66 + .../generated/heterogeneous_system/index.html | 95 ++ previews/PR184/generated/stress_on_truss.jl | 199 +++ .../generated/stress_on_truss/index.html | 132 ++ previews/PR184/generated/truss.mp4 | Bin 0 -> 1579479 bytes previews/PR184/index.html | 527 ++++++++ previews/PR184/initialization/index.html | 40 + previews/PR184/mathematical_model/index.html | 48 + previews/PR184/metadata/index.html | 2 + previews/PR184/mtk_integration/6aeb76f8.png | Bin 0 -> 48818 bytes previews/PR184/mtk_integration/index.html | 84 ++ .../PR184/network_construction/index.html | 61 + previews/PR184/objects.inv | Bin 0 -> 2695 bytes previews/PR184/search_index.js | 3 + previews/PR184/siteinfo.js | 1 + previews/PR184/symbolic_indexing/2131439f.svg | 52 + previews/PR184/symbolic_indexing/74fa3e98.svg | 58 + previews/PR184/symbolic_indexing/d1c7b351.svg | 48 + previews/PR184/symbolic_indexing/index.html | 51 + 54 files changed, 7857 insertions(+) create mode 100644 previews/PR184/.documenter-siteinfo.json create mode 100644 previews/PR184/API/index.html create mode 100644 previews/PR184/assets/bmwk_logo_en.svg create mode 100644 previews/PR184/assets/documenter.js create mode 100755 previews/PR184/assets/makelatexfigs create mode 100644 previews/PR184/assets/mathmodel.svg create mode 100644 previews/PR184/assets/mathmodel.tex create mode 100644 previews/PR184/assets/themes/catppuccin-frappe.css create mode 100644 previews/PR184/assets/themes/catppuccin-latte.css create mode 100644 previews/PR184/assets/themes/catppuccin-macchiato.css create mode 100644 previews/PR184/assets/themes/catppuccin-mocha.css create mode 100644 previews/PR184/assets/themes/documenter-dark.css create mode 100644 previews/PR184/assets/themes/documenter-light.css create mode 100644 previews/PR184/assets/themeswap.js create mode 100644 previews/PR184/assets/warner.js create mode 100644 previews/PR184/generated/StochasticSystem.jl create mode 100644 previews/PR184/generated/cascading_failure.jl create mode 100644 previews/PR184/generated/cascading_failure/d235e48e.svg create mode 100644 previews/PR184/generated/cascading_failure/index.html create mode 100644 previews/PR184/generated/directed_and_weighted_graphs.jl create mode 100644 previews/PR184/generated/directed_and_weighted_graphs/e002d24b.svg create mode 100644 previews/PR184/generated/directed_and_weighted_graphs/index.html create mode 100644 previews/PR184/generated/gas_network.jl create mode 100644 previews/PR184/generated/gas_network/43f744c5.svg create mode 100644 previews/PR184/generated/gas_network/c1087a40.svg create mode 100644 previews/PR184/generated/gas_network/fc4b8144.svg create mode 100644 previews/PR184/generated/gas_network/index.html create mode 100644 previews/PR184/generated/getting_started_with_network_dynamics.jl create mode 100644 previews/PR184/generated/getting_started_with_network_dynamics/190ecac8.svg create mode 100644 previews/PR184/generated/getting_started_with_network_dynamics/6b3a5417.svg create mode 100644 previews/PR184/generated/getting_started_with_network_dynamics/7d053527.svg create mode 100644 previews/PR184/generated/getting_started_with_network_dynamics/index.html create mode 100644 previews/PR184/generated/heterogeneous_system.jl create mode 100644 previews/PR184/generated/heterogeneous_system/022b6041.svg create mode 100644 previews/PR184/generated/heterogeneous_system/5a435ac8.svg create mode 100644 previews/PR184/generated/heterogeneous_system/68c01707.svg create mode 100644 previews/PR184/generated/heterogeneous_system/index.html create mode 100644 previews/PR184/generated/stress_on_truss.jl create mode 100644 previews/PR184/generated/stress_on_truss/index.html create mode 100644 previews/PR184/generated/truss.mp4 create mode 100644 previews/PR184/index.html create mode 100644 previews/PR184/initialization/index.html create mode 100644 previews/PR184/mathematical_model/index.html create mode 100644 previews/PR184/metadata/index.html create mode 100644 previews/PR184/mtk_integration/6aeb76f8.png create mode 100644 previews/PR184/mtk_integration/index.html create mode 100644 previews/PR184/network_construction/index.html create mode 100644 previews/PR184/objects.inv create mode 100644 previews/PR184/search_index.js create mode 100644 previews/PR184/siteinfo.js create mode 100644 previews/PR184/symbolic_indexing/2131439f.svg create mode 100644 previews/PR184/symbolic_indexing/74fa3e98.svg create mode 100644 previews/PR184/symbolic_indexing/d1c7b351.svg create mode 100644 previews/PR184/symbolic_indexing/index.html diff --git a/previews/PR184/.documenter-siteinfo.json b/previews/PR184/.documenter-siteinfo.json new file mode 100644 index 00000000..132b23a0 --- /dev/null +++ b/previews/PR184/.documenter-siteinfo.json @@ -0,0 +1 @@ +{"documenter":{"julia_version":"1.11.1","generation_timestamp":"2024-11-26T02:03:17","documenter_version":"1.8.0"}} \ No newline at end of file diff --git a/previews/PR184/API/index.html b/previews/PR184/API/index.html new file mode 100644 index 00000000..19ce2530 --- /dev/null +++ b/previews/PR184/API/index.html @@ -0,0 +1,40 @@ + +API · NetworkDynamics

API

The following functions are designed for public use.

Network Construction API

NetworkDynamics.NetworkType
Network([g,] vertexf, edgef; kwarg...)

Construct a Network object from a graph g and edge and component models vertexf and edgef.

Arguments:

  • g::AbstractGraph: The graph on which the network is defined. Optional, can be ommittet if all component models have a defined graphelement. See vidx and src/dst keywors for VertexModel and EdgeModel constructors respectively.

  • vertexm: A single VertexModel or a vector of VertexModel objects. The order of the vertex models must mirror the order of the vertices(g) iterator.

  • edgem: A single EdgeModel or a vector of EdgeModel objects. The order of the edge models must mirror the order of the edges(g) iterator.

Optional keyword arguments:

  • execution=SequentialExecution{true}(): Execution model of the network. E.g. SequentialExecution, KAExecution, PolyesterExecution or ThreadedExecution.
  • aggregator=execution isa SequentialExecution ? SequentialAggregator(+) : PolyesterAggregator(+): Aggregation function applied to the edge models. E.g. SequentialAggregator, PolyesterAggregator, ThreadedAggregator, SparseAggregator.
  • check_graphelement=true: Check if the graphelement metadata is consistent with the graph.
  • dealias=false Check if the components alias eachother and create copies if necessary. This is necessary if the same component model is referenced in multiple places in the Network but you want to dynamicially asign metadata, such as initialization information to specific instances.
  • verbose=false: Show additional information during construction.
source
Network(nw::Network; g, vertexm, edgem, kwargs...)

Rebuild the Network with same graph and vertex/edge models but possibly different kwargs.

source
NetworkDynamics.dimMethod
dim(nw::Network)

Returns the number of dynamic states in the network, corresponts to the length of the flat state vector.

source
NetworkDynamics.pdimMethod
pdim(nw::Network)

Returns the number of parameters in the network, corresponts to the length of the flat parameter vector.

source

Component Models

NetworkDynamics.VertexModelMethod
VertexModel(; kwargs...)

Build a VertexModel according to the keyword arguments.

Main Arguments:

  • f=nothing: Dynamic function of the component. Can be nothing if dim is 0.
  • g: Output function of the component. Usefull helpers: StateMask
  • sym/dim: Symbolic names of the states. If dim is provided, sym is set automaticially.
  • outsym/outdim: Symbolic names of the outputs. If outdim is provided, outsym is set automaticially. Can be infered automaticially if g isa StateMask.
  • psym/pdim=0: Symbolic names of the parameters. Ifpdimis provided,psym` is set automaticially.
  • mass_matrix=I: Mass matrix of component. Can be a vector v and is then interpreted as Diagonal(v).
  • name=dim>0 ? :VertexM : :StaticVertexM: Name of the component.

Optional Arguments:

  • insym/indim: Symbolic names of the inputs. If indim is provided, insym is set automaticially.
  • vidx: Index of the vertex in the graph, enables graphless constructor.
  • ff: FeedForwardType of component. Will be typically infered from g automaticially.
  • obssym/obsf: Define additional "observable" states.
  • symmetadata/metadata: Provide prefilled metadata dictionaries.

All Symbol arguments can be used to set default values, i.e. psym=[:K=>1, :p].

source
NetworkDynamics.EdgeModelMethod
EdgeModel(; kwargs...)

Build a EdgeModel according to the keyword arguments.

Main Arguments:

  • f=nothing: Dynamic function of the component. Can be nothing if dim is 0.
  • g: Output function of the component. Usefull helpers: AntiSymmetric, Symmetric, Fiducial, Directed and StateMask.
  • sym/dim: Symbolic names of the states. If dim is provided, sym is set automaticially.
  • outsym/outdim: Symbolic names of the outputs. If outdim is provided, outsym is set automaticially. In general, outsym for edges isa named tuple (; src, dst). However, depending on the g function, it might be enough to provide a single vector or even nothing (e.g. AntiSymmetric(StateMask(1:2))). See Building EdgeModels for examples.
  • psym/pdim=0: Symbolic names of the parameters. Ifpdimis provided,psym` is set automaticially.
  • mass_matrix=I: Mass matrix of component. Can be a vector v and is then interpreted as Diagonal(v).
  • name=dim>0 ? :EdgeM : :StaticEdgeM: Name of the component.

Optional Arguments:

  • insym/indim: Symbolic names of the inputs. If indim is provided, insym is set automaticially. For edges, insym is a named tuple (; src, dst). If give as vector tuple is created automaticially.
  • src/dst: Index or name of the vertices at src and dst end. Enables graphless constructor.
  • ff: FeedForwardType of component. Will be typically infered from g automaticially.
  • obssym/obsf: Define additional "observable" states.
  • symmetadata/metadata: Provide prefilled metadata dictionaries.

All Symbol arguments can be used to set default values, i.e. psym=[:K=>1, :p].

source

Component Models with MTK

NetworkDynamics.VertexModelMethod
VertexModel(sys::ODESystem, inputs, outputs; ff_to_constraint=true, kwargs...)

Create a VertexModel object from a given ODESystem created with ModelingToolkit. You need to provide 2 lists of symbolic names (Symbol or Vector{Symbols}):

  • inputs: names of variables in you equation representing the aggregated edge states
  • outputs: names of variables in you equation representing the node output

ff_to_constraint controlls, whether output transformations g which depend on inputs should be

source
NetworkDynamics.EdgeModelMethod
EdgeModel(sys::ODESystem, srcin, srcout, dstin, dstout; ff_to_constraint=false, kwargs...)

Create a EdgeModel object from a given ODESystem created with ModelingToolkit. You need to provide 4 lists of symbolic names (Symbol or Vector{Symbols}):

  • srcin: names of variables in you equation representing the node state at the source
  • dstin: names of variables in you equation representing the node state at the destination
  • srcout: names of variables in you equation representing the output at the source
  • dstout: names of variables in you equation representing the output at the destination

ff_to_constraint controlls, whether output transformations g which depend on inputs should be transformed into constraints.

source
NetworkDynamics.EdgeModelMethod
EdgeModel(sys::ODESystem, srcin, dstin, AntiSymmetric(dstout); ff_to_constraint=false, kwargs...)

Create a EdgeModel object from a given ODESystem created with ModelingToolkit.

Here you only need to provide one list of output symbols: dstout. To make it clear how to handle the single-sided output definiton, you musst wrap the symbol vector in

  • AntiSymmetric(dstout),
  • Symmetric(dstout), or
  • Directed(dstout).

ff_to_constraint controlls, whether output transformations g which depend on inputs should be transformed into constraints.

source

Output Function Helpers/Wrappers

NetworkDynamics.StateMaskType
StateMask(i::AbstractArray)
+StateMaks(i::Number)

A StateMask is a predefined output function. It can be used to define the output of a component model by picking from the internal state.

I.e. g=StateMask(2:3) in a vertex function will output the internal states 2 and 3. In many contexts, StateMasks can be constructed implicitly by just providing the indices, e.g. g=1:2.

For EdgeModel this needs to be combined with a Directed, Symmetric, AntiSymmetric or Fiducial coupling, e.g. g=Fiducial(1:2, 3:4) forwards states 1:2 to dst and states 3:4 to src.

source

Accessors for Component Properties

NetworkDynamics.outdimFunction
outdim(c::VertexModel)::Int
+outdim(c::EdgeModel)::@NamedTuple(src::Int, dst::Int)

Retrieve the output dimension of the component

source
NetworkDynamics.outsymFunction

outsym(c::VertexModel)::Vector{Symbol} outsym(c::EdgeModel)::@NamedTuple{src::Vector{Symbol}, dst::Vector{Symbol}}

Retrieve the output symbols of the component.

source
NetworkDynamics.insymFunction
insym(c::VertexModel)::Vector{Symbol}
+insym(c::EdgeModel)::@NamedTuple{src::Vector{Symbol}, dst::Vector{Symbol}}

Musst be called after hasinsym/hasindim returned true. Gives the insym vector(s). For vertex model just a single vector, for edges it returns a named tuple (; src, dst) with two symbol vectors.

source

FeedForwardType-Traits

Symbolic Indexing API

Network Parameter Object

NetworkDynamics.NWParameterType
NWParameter(nw_or_nw_wraper, pflat)

Indexable wrapper for flat parameter array pflat. Needs Network or wrapper of Network, e.g. ODEProblem.

p = NWParameter(nw)
+p.v[idx, :sym] # get parameter :sym of vertex idx
+p.e[idx, :sym] # get parameter :sym of edge idx
+p[s::Union{VPIndex, EPIndex}] # get parameter for specific index

Get flat array representation using pflat(p).

source
NetworkDynamics.NWParameterMethod
NWParameter(nw_or_nw_wraper;
+            ptype=Vector{Float64}, pfill=filltype(ptype), default=true)

Creates "empty" NWParameter object for the Network/Wrapper nw with flat type ptype. The array will be prefilled with pfill (defaults to NaN).

If default=true the default parameter values attached to the network components will be loaded.

source

Network State Object

NetworkDynamics.NWStateType
NWState(nw_or_nw_wrapper, uflat, [pflat], [t])

Indexable wrapper for flat state & parameter array. Needs Network or wrapper of Network, e.g. ODEProblem.

s = NWState(nw)
+s.v[idx, :sym] # get state :sym of vertex idx
+s.e[idx, :sym] # get state :sym of edge idx
+s.p.v[idx, :sym] # get parameter :sym of vertex idx
+s.p.e[idx, :sym] # get parameter :sym of edge idx
+s[s::Union{VIndex, EIndex, EPIndex, VPIndex}] # get parameter for specific index

Get flat array representation using uflat(s) and pflat(s).

source
NetworkDynamics.NWStateMethod
NWState(nw_or_nw_wrapper;
+        utype=Vector{Float64}, ufill=filltype(utype),
+        ptype=Vector{Float64}, pfill=filltype(ptype), default=true)

Creates "empty" NWState object for the Network/Wrapper nw with flat types utype & ptype. The arrays will be prefilled with ufill and pfill respectively (defaults to NaN).

If default=true the default state & parameter values attached to the network components will be loaded.

source
NetworkDynamics.NWStateMethod
NWState(p::NWState; utype=typeof(uflat(s)), ptype=typeof(pflat(s)))

Create NWState based on other state object, just convert types.

source
NetworkDynamics.NWStateMethod
NWState(p::NWParameter; utype=Vector{Float64}, ufill=filltype(utype), default=true)

Create NWState based on existing NWParameter object.

source
NetworkDynamics.pflatFunction
pflat(p::NWParameter)
+pflat(s::NWState)

Retrieve the wrapped flat array representation of the parameters.

source

Symbolic Indices

NetworkDynamics.VIndexType
VIndex{C,S} <: SymbolicStateIndex{C,S}
+idx = VIndex(comp, sub)

A symbolic index for a vertex state variable.

  • comp: the component index, either int or a collection of ints
  • sub: the subindex, either int, symbol or a collection of those.
VIndex(1, :P)      # vertex 1, variable :P
+VIndex(1:5, 1)     # first state of vertices 1 to 5
+VIndex(7, (:x,:y)) # states :x and :y of vertex 7

Can be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWState, NWParameter or ODESolution.

See also: EIndex, VPIndex, EPIndex

source
NetworkDynamics.EIndexType
EIndex{C,S} <: SymbolicStateIndex{C,S}
+idx = EIndex(comp, sub)

A symbolic index for an edge state variable.

  • comp: the component index, either int or a collection of ints
  • sub: the subindex, either int, symbol or a collection of those.
EIndex(1, :P)      # edge 1, variable :P
+EIndex(1:5, 1)     # first state of edges 1 to 5
+EIndex(7, (:x,:y)) # states :x and :y of edge 7

Can be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWState, NWParameter or ODESolution.

See also: VIndex, VPIndex, EPIndex

source
NetworkDynamics.VPIndexType
VPIndex{C,S} <: SymbolicStateIndex{C,S}
+idx = VPIndex(comp, sub)

A symbolic index into the parameter a vertex:

  • comp: the component index, either int or a collection of ints
  • sub: the subindex, either int, symbol or a collection of those.

Can be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWParameter or ODEProblem.

See also: EPIndex, VIndex, EIndex

source
NetworkDynamics.EPIndexType
EPIndex{C,S} <: SymbolicStateIndex{C,S}
+idx = VEIndex(comp, sub)

A symbolic index into the parameter a vertex:

  • comp: the component index, either int or a collection of ints
  • sub: the subindex, either int, symbol or a collection of those.

Can be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWParameter or ODEProblem.

See also: VPIndex, VIndex, EIndex

source

Index generators

NetworkDynamics.vidxsFunction
vidxs([inpr], components=:, variables=:) :: Vector{VIndex}

Generate vector of symbolic indexes for vertices.

  • inpr: Only needed for name matching or : access. Can be Network, sol, prob, ...
  • components: Number/Vector, :, Symbol (name matches), String/Regex (name contains)
  • variables: Symbol/Number/Vector, :, String/Regex (all sym containing)

Examples:

vidxs(nw)                 # all vertex state indices
+vidxs(1:2, :u)            # [VIndex(1, :u), VIndex(2, :u)]
+vidxs(nw, :, [:u, :v])    # [VIndex(i, :u), VIndex(i, :v) for i in 1:nv(nw)]
+vidxs(nw, "ODEVertex", :) # all symbols of all vertices with name containing "ODEVertex"
source
NetworkDynamics.eidxsFunction
vidxs([inpr], components=:, variables=:) :: Vector{EIndex}

Generate vector of symbolic indexes for edges.

  • inpr: Only needed for name matching or : access. Can be Network, sol, prob, ...
  • components: Number/Vector, :, Symbol (name matches), String/Regex (name contains)
  • variables: Symbol/Number/Vector, :, String/Regex (all sym containing)

Examples:

eidxs(nw)                # all edge state indices
+eidxs(1:2, :u)           # [EIndex(1, :u), EIndex(2, :u)]
+eidxs(nw, :, [:u, :v])   # [EIndex(i, :u), EIndex(i, :v) for i in 1:ne(nw)]
+eidxs(nw, "FlowEdge", :) # all symbols of all edges with name containing "FlowEdge"
source
NetworkDynamics.vpidxsFunction
vpidxs([inpr], components=:, variables=:) :: Vector{VPIndex}

Generate vector of symbolic indexes for parameters. See vidxs for more information.

source
NetworkDynamics.epidxsFunction
epidxs([inpr], components=:, variables=:) :: Vector{EPIndex}

Generate vector of symbolic indexes for parameters. See eidxs for more information.

source

Metadata API

Component Metadata API

NetworkDynamics.get_graphelementFunction
get_graphelement(c::EdgeModel)::@NamedTuple{src::T, dst::T}
+get_graphelement(c::VertexModel)::Int

Retrieves the graphelement metadata for the component model. For edges this returns a named tupe (;src, dst) where both are either integers (vertex index) or symbols (vertex name).

source
NetworkDynamics.set_graphelement!Function
set_graphelement!(c::EdgeModel, src, dst)
+set_graphelement!(c::VertexModel, vidx)

Sets the graphelement metadata for the edge model. For edges this takes two arguments src and dst which are either integer (vertex index) or symbol (vertex name). For vertices it takes a single integer vidx.

source

Per-Symbol Metadata API

NetworkDynamics.set_metadata!Method
set_metadata!(c::ComponentModel, sym::Symbol, key::Symbol, value)
+set_metadata!(c::ComponentModel, sym::Symbol, pair)

Sets the metadata key for symbol sym to value.

source

Initialization

NetworkDynamics.find_fixpointFunction
find_fixpoint(nw::Network, [x0::NWState=NWState(nw)], [p::NWParameter=x0.p]; kwargs...)
+find_fixpoint(nw::Network, x0::AbstractVector, p::AbstractVector; kwargs...)
+find_fixpoint(nw::Network, x0::AbstractVector; kwargs...)

Convenience wrapper around SteadyStateProblem from SciML-ecosystem. Constructs and solves the steady state problem, returns found value wrapped as NWState.

source
NetworkDynamics.initialize_component!Function
initialize_component!(cf::ComponentModel; verbose=true, kwargs...)

Initialize a ComponentModel by solving the corresponding NonlinearLeastSquaresProblem. During initialization, everyting which has a default value (see Metadata) is considered "fixed". All other variables are considered "free" and are solved for. The initial guess for each variable depends on the guess value in the Metadata.

The result is stored in the ComponentModel itself. The values of the free variables are stored in the metadata field init.

The kwargs are passed to the nonlinear solver.

source
NetworkDynamics.init_residualFunction
init_residual(cf::T; t=NaN, recalc=false)

Calculates the residual |du| for the given component model for the values provided via default and init Metadata.

If recalc=false just return the residual determined in the actual initialization process.

See also initialize_component!.

source

Execution Types

NetworkDynamics.ExecutionStyleType
abstract type ExecutionStyle{buffered::Bool} end

Abstract type for execution style. The coreloop dispatches based on the Execution style stored in the network object.

  • buffered=true means that the edge input es explicitly gathered, i.e. the vertex outputs in the output buffer will be copied into a dedicated input buffer for the edges.
  • buffered=false means, that the edge inputs are not explicitly gathered, but the corloop will perform a redirected lookup into the output buffer.
source

Aggregators

NetworkDynamics.AggregatorType
abstract type Aggregator end

Abstract sypertype for aggregators. Aggregators operate on the output buffer of all components and fill the aggregation buffer with the aggregatated edge values per vertex.

All aggregators have the constructor

Aggegator(aggfun)

for example

SequentialAggreator(+)
source

Utils

NetworkDynamics.save_parameters!Function
save_parameters!(integrator::SciMLBase.DEIntegrator)

Save the current parameter values in the integrator. Call this function inside callbacks if the parameter values have changed. This will store a timeseries of said parameters in the solution object, thus alowing us to recosntruct observables which depend on time-dependet variables.

source
NetworkDynamics.ff_to_constraintFunction
ff_to_constraint(v::VertexModel)

Takes VertexModel v with feed forward and turns all algebraic output states into internal states by defining algebraic constraints contraints 0 = out - g(...). The new output function is just a StateMask into the extended internal state vector.

Returns the transformed VertexModel.

source
Base.copyMethod
copy(c::NetworkDynamics.ComponentModel)

Shallow copy of the component model. Creates a deepcopy of metadata and symmetadata but references the same objects everywhere else.

source
diff --git a/previews/PR184/assets/bmwk_logo_en.svg b/previews/PR184/assets/bmwk_logo_en.svg new file mode 100644 index 00000000..5bed8c7c --- /dev/null +++ b/previews/PR184/assets/bmwk_logo_en.svg @@ -0,0 +1 @@ + \ No newline at end of file diff --git a/previews/PR184/assets/documenter.js b/previews/PR184/assets/documenter.js new file mode 100644 index 00000000..7d68cd80 --- /dev/null +++ b/previews/PR184/assets/documenter.js @@ -0,0 +1,1082 @@ +// 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 .docstring-article-toggle-button", + function () { + let articleToggleTitle = "Expand docstring"; + const parent = $(this).parent(); + + debounce(() => { + if (parent.siblings("section").is(":visible")) { + parent + .find("a.docstring-article-toggle-button") + .removeClass("fa-chevron-down") + .addClass("fa-chevron-right"); + } else { + parent + .find("a.docstring-article-toggle-button") + .removeClass("fa-chevron-right") + .addClass("fa-chevron-down"); + + articleToggleTitle = "Collapse docstring"; + } + + parent + .children(".docstring-article-toggle-button") + .prop("title", articleToggleTitle); + parent.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"); + $("a.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"); + $("a.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); + }; +} + +/////// SEARCH MAIN /////// + +function runSearchMainCode() { + // `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)); + + // 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} +
`; + } +} + +function waitUntilSearchIndexAvailable() { + // It is possible that the documenter.js script runs before the page + // has finished loading and documenterSearchIndex gets defined. + // So we need to wait until the search index actually loads before setting + // up all the search-related stuff. + if (typeof documenterSearchIndex !== "undefined") { + runSearchMainCode(); + } else { + console.warn("Search Index not available, waiting"); + setTimeout(waitUntilSearchIndexAvailable, 1000); + } +} + +// The actual entry point to the search code +waitUntilSearchIndexAvailable(); + +}) +//////////////////////////////////////////////////////////////////////////////// +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/previews/PR184/assets/makelatexfigs b/previews/PR184/assets/makelatexfigs new file mode 100755 index 00000000..de9feb1d --- /dev/null +++ b/previews/PR184/assets/makelatexfigs @@ -0,0 +1,21 @@ +#!/bin/bash + +# Function to check if a command is available +command_exists() { + command -v "$1" >/dev/null 2>&1 +} + +# Check for latexmk +if ! command_exists latexmk; then + echo "Error: 'latexmk' is not installed or not in your PATH." + exit 1 +fi + +# Check for pdf2svg +if ! command_exists pdf2svg; then + echo "Error: 'pdf2svg' is not installed or not in your PATH." + exit 1 +fi + +latexmk -pdflua -shell-escape mathmodel.tex +latexmk -C diff --git a/previews/PR184/assets/mathmodel.svg b/previews/PR184/assets/mathmodel.svg new file mode 100644 index 00000000..68e731b8 --- /dev/null +++ b/previews/PR184/assets/mathmodel.svg @@ -0,0 +1,543 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/assets/mathmodel.tex b/previews/PR184/assets/mathmodel.tex new file mode 100644 index 00000000..525421c7 --- /dev/null +++ b/previews/PR184/assets/mathmodel.tex @@ -0,0 +1,65 @@ +% \documentclass[tikz,convert={outfile=\jobname.svg}]{standalone} +\documentclass[tikz,convert=pdf2svg]{standalone} +%\usetikzlibrary{...}% tikz package already loaded by 'tikz' option +\usetikzlibrary{arrows, arrows.meta} +% \tikzset{ +% >=stealth', +% } +\usepackage{amsmath,amssymb} +\usepackage{tikz} +\usepackage{xcolor} + +\makeatletter +\def\mathcolor#1#{\@mathcolor{#1}} +\def\@mathcolor#1#2#3{% + \protect\leavevmode + \begingroup + \color#1{#2}#3% + \endgroup +} +\makeatother + +\definecolor{wblue}{HTML}{0072b2} +\definecolor{worange}{HTML}{e69f00} +\definecolor{wbblue}{HTML}{56b4e9} +\definecolor{wgreen}{HTML}{009e73} +\definecolor{wyellow}{HTML}{f0e442} + +\begin{document} +\begin{tikzpicture} + \node[draw, circle](n1){1}; + \node[draw, circle] at (10cm, 1cm)(n2){2}; + \node[draw, circle] at (2.5cm, -1.5cm)(n3){3}; + \path (n1)--(n2) coordinate[pos=.5](mid12); + \draw[-{Stealth[length=3mm, width=2mm]}] (n1)--(mid12); + \draw(mid12)--(n2); + \draw (n2)--(n3); + \draw (n3)--(n1); + \draw[] (n3) --++(-2,-1); + \draw[] (n3) --++(1,-1); + \draw[] (n1) --++(-1,-2.5); + \draw[] (n2) --++(-2,-3.5); + + \node[text width=5cm, xshift=-0.5cm, yshift=1.25cm] at (n1){% + \small\begin{align*} + M\,\dot{x} &= f^{\mathrm{v}}_{1}\left(x, \sum_{k} \mathcolor{worange}{e_{k1}}, p, t\right)\\ + \mathcolor{worange}{v_{1}} &= g^{\mathrm{v}}_{1}\left(x, p, t\right)\\ + \end{align*}% + }; + \node[text width=5cm, xshift=0.5cm, yshift=1.25cm] at (n2)(block){% + \small\begin{align*} + M\,\dot{x} &= f^{\mathrm{v}}_{2}\left(x, \sum_{k} \mathcolor{wblue}{e_{k2}}, p_{\mathrm{v},2}, t\right)\\ + \mathcolor{wblue}{v_{2}} &= g^{\mathrm{v}}_{2}\left(x, p_{\mathrm{v},2}, t\right)\\ + \end{align*}% + }; + + \path (n1)--(n2) node[pos=.5,text width=5cm, xshift=0cm, yshift=1.25cm]{% + \small\begin{align*} + M\,\dot{x} &= f^{\mathrm{e}}_{12}\left(x, \mathcolor{worange}{v_{\mathrm{src}}}, \mathcolor{wblue}{v_{\mathrm{dst}}}, p, t\right)\\ + \mathcolor{worange}{e_{21}} &= g^{\mathrm{e}}_{\mathrm{src}}\left(x, \mathcolor{worange}{v_{\mathrm{src}}}, \mathcolor{wblue}{v_{\mathrm{dst}}}, p, t\right)\\ + \mathcolor{wblue}{e_{12}} &= g^{\mathrm{e}}_{\mathrm{dst}}\left(x, \mathcolor{worange}{v_{\mathrm{src}}}, \mathcolor{wblue}{v_{\mathrm{dst}}}, p, t\right)\\ + \end{align*}% + }; + +\end{tikzpicture} +\end{document} diff --git a/previews/PR184/assets/themes/catppuccin-frappe.css b/previews/PR184/assets/themes/catppuccin-frappe.css new file mode 100644 index 00000000..32e3f008 --- /dev/null +++ b/previews/PR184/assets/themes/catppuccin-frappe.css @@ -0,0 +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,html.theme--catppuccin-frappe .file-cta,html.theme--catppuccin-frappe .file-name,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,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.is-todo{background-color:#292c3c;border-color:#ca9ee6}html.theme--catppuccin-frappe .admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#ca9ee6}html.theme--catppuccin-frappe .admonition.is-todo>.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/previews/PR184/assets/themes/catppuccin-latte.css b/previews/PR184/assets/themes/catppuccin-latte.css new file mode 100644 index 00000000..63160d34 --- /dev/null +++ b/previews/PR184/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.is-todo{background-color:#e6e9ef;border-color:#8839ef}html.theme--catppuccin-latte .admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#8839ef}html.theme--catppuccin-latte .admonition.is-todo>.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/previews/PR184/assets/themes/catppuccin-macchiato.css b/previews/PR184/assets/themes/catppuccin-macchiato.css new file mode 100644 index 00000000..a9cf9c57 --- /dev/null +++ b/previews/PR184/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.is-todo{background-color:#1e2030;border-color:#c6a0f6}html.theme--catppuccin-macchiato .admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#c6a0f6}html.theme--catppuccin-macchiato .admonition.is-todo>.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/previews/PR184/assets/themes/catppuccin-mocha.css b/previews/PR184/assets/themes/catppuccin-mocha.css new file mode 100644 index 00000000..8b826525 --- /dev/null +++ b/previews/PR184/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.is-todo{background-color:#181825;border-color:#cba6f7}html.theme--catppuccin-mocha .admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#cba6f7}html.theme--catppuccin-mocha .admonition.is-todo>.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/previews/PR184/assets/themes/documenter-dark.css b/previews/PR184/assets/themes/documenter-dark.css new file mode 100644 index 00000000..c41c82f2 --- /dev/null +++ b/previews/PR184/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.is-todo{background-color:#282f2f;border-color:#9558b2}html.theme--documenter-dark .admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#9558b2}html.theme--documenter-dark .admonition.is-todo>.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/previews/PR184/assets/themes/documenter-light.css b/previews/PR184/assets/themes/documenter-light.css new file mode 100644 index 00000000..e000447e --- /dev/null +++ b/previews/PR184/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.is-todo{background-color:#f5f5f5;border-color:#9558b2}.admonition.is-todo>.admonition-header{background-color:rgba(0,0,0,0);color:#9558b2}.admonition.is-todo>.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/previews/PR184/assets/themeswap.js b/previews/PR184/assets/themeswap.js new file mode 100644 index 00000000..9f5eebe6 --- /dev/null +++ b/previews/PR184/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/previews/PR184/assets/warner.js b/previews/PR184/assets/warner.js new file mode 100644 index 00000000..3f6f5d00 --- /dev/null +++ b/previews/PR184/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/previews/PR184/generated/StochasticSystem.jl b/previews/PR184/generated/StochasticSystem.jl new file mode 100644 index 00000000..4edbe34b --- /dev/null +++ b/previews/PR184/generated/StochasticSystem.jl @@ -0,0 +1,128 @@ +# # SDE Tutorial +# +# +# #### Topics covered in this tutorial include: +# +# - the swing equation +# - fixpoint search of ODE systems +# - constructing an SDE problem with NetworkDynamics.jl +# +# ## Example: Fluctuations in Power Grids +# +# This tutorial explains the use of stochastic differential equations (SDE's) in NetworkDynamics.jl. As an example system we will simulate fluctuations in a simple power grid model. +# +# The phase and frequency dynamics in power grids can be modeled by the swing equation. In the complex systems community this is also known as the Kuramoto model with inertia. +# +# ```math +# \begin{aligned} +# \dot \theta_i &= \omega_i \\ +# M_i \dot \omega_i &= P_i(t) - D_i \omega_i - \sum_{i=1}^N K_{ij} \sin(\theta_i - \theta_j) +# \end{aligned} +# ``` +# +# Here, $M_i$ and $D_i$ are inertia and damping parameters, $K_{ij}$ is the power capacitiy of the line and $P_i(t)$ is the power infeed at the node. We assume that this power can be separated into a constant power setpoint $P^\circ_i$ and a stochastic fluctuation. +# +# ```math +# \begin{aligned} +# P_i(t) = P^\circ_i + \sigma_i \cdot \xi_i(t) +# \end{aligned} +# ``` +# +# In this tutorial we assume the fluctuations $\xi_i(t)$ to be white Gaussian noise. Separating the deterministic and stochastic part, we can write this problem as a stochastic differential equation. +# +# ```math +# \begin{aligned} +# d\omega_i = \left[P_i - D_i \omega_i - \sum_{i=1}^N K_{ij} \sin(\theta_i - \theta_j)\right] dt + \sigma_i dW_i +# \end{aligned} +# ``` +# +# Here, $dW_i = \xi_i dt$ is the infinitesimal increment of the Wiener process. Problems of this type can be numerically solved in Julia as described in the [SDE Tutorial](https://diffeq.sciml.ai/stable/tutorials/sde_example/) of `DifferentialEquations`. +# +# ## Implementing the Swing Equation +# +# First we will implement the node and edge models for the deterministic case +# without the fluctuations. We set the defaults for the inertia and damping +# parameters to be $M_i = 1.0$ and $D_i = 0.1$. The default coupling strength is $K=6$. + +using NetworkDynamics, Graphs +using StochasticDiffEq, OrdinaryDiffEqTsit5 +using Plots, LaTeXStrings + +function swing_equation!(dv, v, esum, (M, P, D), t) + dv[1] = v[2] + dv[2] = 1/M *(P - D * v[2] + esum[1]) + nothing +end +swing_vertex = VertexModel(f=swing_equation!, g=1, sym=[:θ, :ω], psym=[:M=>1, :P, :D=>0.1]) + +function powerflow!(e, v_s, v_d, (K,), t) + e[1] = K * sin(v_s[1] - v_d[1]) +end +powerflow_edge = EdgeModel(g=AntiSymmetric(powerflow!), outdim=1, psym=[:K=>6]) + +# ## Contructing the Deterministic Dynamics +# +# For the graph structure we will use a simple 4 node ring network. + +g = watts_strogatz(4, 2, 0.0) + +# Then we can construct the `Network` of the deterministic system. + +nd = Network(g, swing_vertex, powerflow_edge) + +# ## Fixpoint Search +# +# Now we need to define the dynamic parameters of vertices and edges. +# For that, we start by creating the `NWParameter` object, pre filling it with the default values: + +p = NWParameter(nd) + +# Most of the parameters are allready set +# For the nodes we assume half of them to be net producers ($P = 1.0$) and half of them to be net consumers ($P = -1.0$) of power. + +p.v[1:4, :P] = [1, -1, 1, -1] + +# We want to simulate fluctuations around an equilibrium state of our model +# system. Therefore, we need to find a fixpoint of the determinitic system which +# can be done by using the utility function `find_fixpoint()`. As an initial guess +# we take all variables equal to zero. + +u0 = find_fixpoint(nd, p) + +ode_prob = ODEProblem(nd, uflat(u0), (0.0, 500.0), pflat(p)) +ode_sol = solve(ode_prob, Tsit5()) + +plot(ode_sol; idxs=vidxs(nd,:,:ω), ylims=(-1.0, 1.0), ylabel=L"\omega", legend=false, fmt=:png) + +# We see that this is in fact a fixpoint solution. We will later use this as an initial condition for the numerical integration of the SDE system. +# +# ## Adding a Stochastic Layer +# +# For adding the stochastic part of the dynamics we have to define a second graph layer. In our example, the fluctuations at different nodes are independent of each other. Therefore, we define a second graph with the same number of vertices but without any edges. + +h = SimpleGraph(4, 0) + +# The dynamics at the nodes has to have the same dimension as in the deterministic case. In our example we only have fluctuations in the second variable. +# FIXME: stochastic system should be simulated using symbolic indexing, this is jsut wrong in current ND! + +# function fluctuation!(dx, x, edges, p, t) +# dx[1] = 0.0 +# dx[2] = 0.05 +# end + +# Now we can construct the dynamics of the second layer by using `network_dynamics()`. Since the graph structure of the stochastic layer has no edges we can take the edge model of the deterministic case as a placeholder. + +# fluctuation_vertex = VertexModel(f=fluctuation!, g=1:2, dim=2) +# nd_noise = Network(h, fluctuation_vertex, NetworkDynamics.EdgeModel[]) + +# ## Simulating the SDE +# +# Finally, we can create an `SDEProblem` and solve it with `DifferentialEquations`. + +# sde_prob = SDEProblem(nd, nd_noise, uflat(u0), (0.0, 500.0), pflat(p)) +# sde_sol = solve(sde_prob, SOSRA()) +# plot(sde_sol; idxs=vidxs(nd,:,:ω), ylims=(-1.0, 1.0), ylabel=L"\omega", legend=false, fmt=:png) + +# More details on SDE problems, e.g. how to include correlations or how to define an `EnsembleProblem`, can be found in the [documentation](https://diffeq.sciml.ai/stable/types/sde_types/) of `DifferentialEquations`. + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/cascading_failure.jl b/previews/PR184/generated/cascading_failure.jl new file mode 100644 index 00000000..2e3f3162 --- /dev/null +++ b/previews/PR184/generated/cascading_failure.jl @@ -0,0 +1,152 @@ +# # Cascading Failure +# This script reimplements the minimal example of a dynamic cascading failure +# described in Schäfer et al. (2018) [1]. +# In is an example how to use callback functions to change network parameters. In +# this case to disable certain lines. +# +# > [1] Schäfer, B., Witthaut, D., Timme, M., & Latora, V. (2018). Dynamically induced cascading failures in power grids. Nature communications, 9(1), 1-13. https://www.nature.com/articles/s41467-018-04287-5 +# +# The system is modeled using swing equation and active power edges. The nodes are +# characterized by the voltage angle `δ`, the active power on each line is symmetric +# and a function of the difference between source and destination angle `δ_src - δ_dst`. + +using NetworkDynamics +using Graphs +using OrdinaryDiffEqTsit5 +using DiffEqCallbacks +using Plots +using Test #hide +import SymbolicIndexingInterface as SII + +# For the nodes we define the swing equation. State `v[1] = δ`, `v[2] = ω`. +# The swing equation has three parameters: `p = (P_ref, I, γ)` where `P_ref` +# is the power setpopint, `I` is the inertia and `γ` is the droop or damping coeficcient. +# +# The output of the node is just the first state. `g=1` is a shorthand for `g=StateMask(1:1)` +# which implements a trivial output function `g` which just takes the first element of the +# state vector. + +function swing_equation(dv, v, esum, p,t) + P, I, γ = p + dv[1] = v[2] + dv[2] = P - γ * v[2] .+ esum[1] + dv[2] = dv[2] / I + nothing +end +vertex = VertexModel(f=swing_equation, g=1, sym=[:δ, :ω], psym=[:P_ref, :I=>1, :γ=>0.1]) + +# Lets define a simple purely active power line whose active power flow is +# completlye determined by the connected voltage angles and the coupling constant +# `K`. +# We give an additonal parameter, the line limit, which we'll use later in the callback. + +function simple_edge(e, v_s, v_d, (K,), t) + e[1] = K * sin(v_s[1] - v_d[1]) +end +edge = EdgeModel(;g=AntiSymmetric(simple_edge), outsym=:P, psym=[:K=>1.63, :limit=>1]) + +# With the definition of the graph topology we can build the `Network` object: + +g = SimpleGraph([0 1 1 0 1; + 1 0 1 1 0; + 1 1 0 1 0; + 0 1 1 0 1; + 1 0 0 1 0]) +swing_network = Network(g, vertex, edge) + +# For the parameters, we create the `NWParameter` object prefilled with default p values + +p = NWParameter(swing_network) +# vertices 1, 3 and 4 act as loads +p.v[(1,3,4), :P_ref] .= -1 +# vertices 2 and 5 act as generators +p.v[(2,5), :P_ref] .= 1.5 + +# We can use `find_fixpoint` to find a valid initial condition of the network + +u0 = find_fixpoint(swing_network, p) + +# In order to implement the line failures, we need to create a `VectorContinousCallback`. +# In the callback, we compare the current flow on the line with the limit. If the limit is reached, +# the coupling `K` is set to 0. +# +# First we can define the affect function: + +function affect!(integrator, idx) + println("Line $idx tripped at t=$(integrator.t)") + p = NWParameter(integrator) # get indexable parameter object + p.e[idx, :K] = 0 + auto_dt_reset!(integrator) + save_parameters!(integrator) + nothing +end + +# There is one important aspect to this function: the `save_parameters!` call. +# In the callback, we change the parameters of the network, making the parameters time +# dependent. The flow on the line is a function `P(t) = f(u(t), p(t))`. Thus we need to +# inform the integrator, that a discrete change in parameters happend. With this, the +# solution object not only tracks `u(t)` but also `p(t)` and we may extract the observable `P(t)` +# directly. +# +# The callback trigger condition is a bit more complicated. The straight forward version looks like this: + +function naive_condition(out, u, t, integrator) + # careful, u != integrator.u + # therefore construct nwstate with Network info from integrator but u + s = NWState(integrator, u, integrator.p, t) + for i in eachindex(out) + out[i] = abs(s.e[i,:P]) - s.p.e[1,:limit] # compare flow with limit for line + end + nothing +end + +# However, from a performacne perspectiv there are problems with this solution: on +# every call, we need to perform symbolic indexing into the `NWState` object. +# Symbolic indexing is not cheap, as it requires to gather meta data about the network. +# Luckily, the `SymbolicIndexingInterface` package which powers the symbolic indexing +# provides the lower level functions `getp` and `getu` which can be used to create and +# cache accessors to the internal states. +# +# This still isn't ideal beacuse both `getlim` and `getflow` getters will create arrays +# within the callback. But is far better then resolving the flat state indices every time. + +condition = let getlim = SII.getp(swing_network, epidxs(swing_network, :, :limit)), + getflow = SII.getu(swing_network, eidxs(swing_network, :, :P)) + function (out, u, t, integrator) + # careful, u != integrator.u + # therefore construct nwstate with Network info from integrator but u + s = NWState(integrator, u, integrator.p, t) + out .= getlim(s) .- abs.(getflow(s)) + nothing + end +end + +# We can combine affect and condition to form the callback. + +trip_cb = VectorContinuousCallback(condition, affect!, ne(g)); + +# However, there is another component missing. If we look at the powerflow on the +# lines in the initial steady state + +u0.e[:, :P] + +# We see that every flow is below the trip value 1.0. Therefor we need to add a distrubance +# to the network. We do this by manually disabeling line 5 at time 1. + +trip_first_cb = PresetTimeCallback(1.0, integrator->affect!(integrator, 5)); + +# With those components, we can create the problem and solve it. + +prob = ODEProblem(swing_network, uflat(u0), (0,6), copy(pflat(p)); + callback=CallbackSet(trip_cb, trip_first_cb)) +sol = solve(prob, Tsit5()); +# we want to test the reconstruction of the observables # hide +@test all(!iszero, sol(sol.t; idxs=eidxs(sol,:,:P))[begin]) # hide +@test all(iszero, sol(sol.t; idxs=eidxs(sol,:,:P))[end][[1:5...,7]]) # hide +nothing #hide + +# Through the magic of symbolic indexing we can plot the power flows on all lines: + +plot(sol; idxs=eidxs(sol,:,:P)) + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/cascading_failure/d235e48e.svg b/previews/PR184/generated/cascading_failure/d235e48e.svg new file mode 100644 index 00000000..2f1eec27 --- /dev/null +++ b/previews/PR184/generated/cascading_failure/d235e48e.svg @@ -0,0 +1,62 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/cascading_failure/index.html b/previews/PR184/generated/cascading_failure/index.html new file mode 100644 index 00000000..9b498821 --- /dev/null +++ b/previews/PR184/generated/cascading_failure/index.html @@ -0,0 +1,73 @@ + +Cascading Failure · NetworkDynamics

Cascading Failure

This script reimplements the minimal example of a dynamic cascading failure described in Schäfer et al. (2018) [1]. In is an example how to use callback functions to change network parameters. In this case to disable certain lines. This script can be dowloaded as a normal Julia script here.

[1] Schäfer, B., Witthaut, D., Timme, M., & Latora, V. (2018). Dynamically induced cascading failures in power grids. Nature communications, 9(1), 1-13. https://www.nature.com/articles/s41467-018-04287-5

The system is modeled using swing equation and active power edges. The nodes are characterized by the voltage angle δ, the active power on each line is symmetric and a function of the difference between source and destination angle δ_src - δ_dst.

using NetworkDynamics
+using Graphs
+using OrdinaryDiffEqTsit5
+using DiffEqCallbacks
+using Plots
+import SymbolicIndexingInterface as SII

For the nodes we define the swing equation. State v[1] = δ, v[2] = ω. The swing equation has three parameters: p = (P_ref, I, γ) where P_ref is the power setpopint, I is the inertia and γ is the droop or damping coeficcient.

The output of the node is just the first state. g=1 is a shorthand for g=StateMask(1:1) which implements a trivial output function g which just takes the first element of the state vector.

function swing_equation(dv, v, esum, p,t)
+    P, I, γ = p
+    dv[1] = v[2]
+    dv[2] = P - γ * v[2] .+ esum[1]
+    dv[2] = dv[2] / I
+    nothing
+end
+vertex = VertexModel(f=swing_equation, g=1, sym=[:δ, :ω], psym=[:P_ref, :I=>1, :γ=>0.1])
VertexModel :VertexM PureStateMap()
+ ├─ 2 states: [δ, ω]
+ ├─ 1 output: [δ]
+ └─ 3 params: [P_ref, I=1, γ=0.1]

Lets define a simple purely active power line whose active power flow is completlye determined by the connected voltage angles and the coupling constant K. We give an additonal parameter, the line limit, which we'll use later in the callback.

function simple_edge(e, v_s, v_d, (K,), t)
+    e[1] = K * sin(v_s[1] - v_d[1])
+end
+edge = EdgeModel(;g=AntiSymmetric(simple_edge), outsym=:P, psym=[:K=>1.63, :limit=>1])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[₋P] dst=[P]
+ └─   2 params:  [K=1.63, limit=1]

With the definition of the graph topology we can build the Network object:

g = SimpleGraph([0 1 1 0 1;
+                 1 0 1 1 0;
+                 1 1 0 1 0;
+                 0 1 1 0 1;
+                 1 0 0 1 0])
+swing_network = Network(g, vertex, edge)
Network with 10 states and 29 parameters
+ ├─ 5 vertices (1 unique type)
+ └─ 7 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

For the parameters, we create the NWParameter object prefilled with default p values

p = NWParameter(swing_network)
+# vertices 1, 3 and 4 act as loads
+p.v[(1,3,4), :P_ref] .= -1
+# vertices 2 and 5 act as generators
+p.v[(2,5), :P_ref] .= 1.5

We can use find_fixpoint to find a valid initial condition of the network

u0 = find_fixpoint(swing_network, p)

In order to implement the line failures, we need to create a VectorContinousCallback. In the callback, we compare the current flow on the line with the limit. If the limit is reached, the coupling K is set to 0.

First we can define the affect function:

function affect!(integrator, idx)
+    println("Line $idx tripped at t=$(integrator.t)")
+    p = NWParameter(integrator) # get indexable parameter object
+    p.e[idx, :K] = 0
+    auto_dt_reset!(integrator)
+    save_parameters!(integrator)
+    nothing
+end

There is one important aspect to this function: the save_parameters! call. In the callback, we change the parameters of the network, making the parameters time dependent. The flow on the line is a function P(t) = f(u(t), p(t)). Thus we need to inform the integrator, that a discrete change in parameters happend. With this, the solution object not only tracks u(t) but also p(t) and we may extract the observable P(t) directly.

The callback trigger condition is a bit more complicated. The straight forward version looks like this:

function naive_condition(out, u, t, integrator)
+    # careful,  u != integrator.u
+    # therefore construct nwstate with Network info from integrator but u
+    s = NWState(integrator, u, integrator.p, t)
+    for i in eachindex(out)
+        out[i] = abs(s.e[i,:P]) - s.p.e[1,:limit] # compare flow with limit for line
+    end
+    nothing
+end

However, from a performacne perspectiv there are problems with this solution: on every call, we need to perform symbolic indexing into the NWState object. Symbolic indexing is not cheap, as it requires to gather meta data about the network. Luckily, the SymbolicIndexingInterface package which powers the symbolic indexing provides the lower level functions getp and getu which can be used to create and cache accessors to the internal states.

This still isn't ideal beacuse both getlim and getflow getters will create arrays within the callback. But is far better then resolving the flat state indices every time.

condition = let getlim = SII.getp(swing_network, epidxs(swing_network, :, :limit)),
+                getflow = SII.getu(swing_network, eidxs(swing_network, :, :P))
+    function (out, u, t, integrator)
+        # careful,  u != integrator.u
+        # therefore construct nwstate with Network info from integrator but u
+        s = NWState(integrator, u, integrator.p, t)
+        out .= getlim(s) .- abs.(getflow(s))
+        nothing
+    end
+end

We can combine affect and condition to form the callback.

trip_cb = VectorContinuousCallback(condition, affect!, ne(g));

However, there is another component missing. If we look at the powerflow on the lines in the initial steady state

u0.e[:, :P]
7-element Vector{Float64}:
+ -0.44001353955110956
+  0.19001353955110994
+ -0.7500000000000001
+  0.6199729208977807
+  0.4400135395511094
+ -0.1900135395511101
+ -0.75

We see that every flow is below the trip value 1.0. Therefor we need to add a distrubance to the network. We do this by manually disabeling line 5 at time 1.

trip_first_cb = PresetTimeCallback(1.0, integrator->affect!(integrator, 5));

With those components, we can create the problem and solve it.

prob = ODEProblem(swing_network, uflat(u0), (0,6), copy(pflat(p));
+                  callback=CallbackSet(trip_cb, trip_first_cb))
+sol = solve(prob, Tsit5());
Line 5 tripped at t=1.0
+Line 7 tripped at t=2.247676397005474
+Line 4 tripped at t=2.502523192233235
+Line 1 tripped at t=3.1947647115093654
+Line 3 tripped at t=3.3380530127462587
+Line 2 tripped at t=3.4042696241577888

Through the magic of symbolic indexing we can plot the power flows on all lines:

plot(sol; idxs=eidxs(sol,:,:P))
Example block output

This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/directed_and_weighted_graphs.jl b/previews/PR184/generated/directed_and_weighted_graphs.jl new file mode 100644 index 00000000..1a989b8b --- /dev/null +++ b/previews/PR184/generated/directed_and_weighted_graphs.jl @@ -0,0 +1,121 @@ +# # Neurodynamic model of synchronization in the human brain +# +# +# #### Topics covered in this tutorial include: +# +# - constructing a directed, weighted graph from data +# - some useful macros +# - parameter handling +# - stiff equations +# +# ## The FitzHugh-Nagumo model +# +# Dynamics of spiking neurons have been described in a simplified manner by the [FitzHugh-Nagumo model](https://en.wikipedia.org/wiki/FitzHugh%E2%80%93Nagumo_model). +# +# ```math +# \begin{aligned} +# \varepsilon \dot u & = u - \frac{u^3}{3} - v \\ +# \dot v & = u + a +# \end{aligned} +# ``` +# +# Here $u$ is a fast, excitatory variable corresponding to the membrane potential and $v$ is a slower, inhibitory varibale. $\varepsilon$ is a parameter separating these time-scales, and $a$ is a control parameter. +# +# In simplified models of the brain, such *relaxation oscillators* may be used to model individual neurons, clusters of neurons or even larger areas in the brain. The FitzHugh-Nagumo model has been widely used for studying synchronization in neuronal activity, which in turn has been connected to physiological phenomena such as epileptic seizures. +# +# ## Coupling relaxation oscillators +# +# While different coupling schemes for FitzHugh-Nagumo oscillators have been proposed, in this tutorial we focus on coupling of the excitatory variables via electrical gap junctions, as described by the following system of equations. +# +# ```math +# \begin{aligned} +# \varepsilon \dot u_i & = u_i - \frac{u_i^3}{3} - v_i - \sigma \sum_{j=1}^N G_{ij}(u_i - u_j) \\ +# \dot v_i & = u_i + a +# \end{aligned} +# ``` +# +# This is a simple diffusive coupling mediated by the difference between activation potentials in pairs of neurons. A similar coupling term was introduced in the "getting started" tutorial. +# +# ## The network topology - a brain atlas +# +# In the following we will use a directed and weighted network encoding the strength and directionality of coupling between 90 different areas of the brain [Nathalie Tzourio-Mazoyer et al., 2002, Neuroimage]. +# +# The network weight matrix is given as a text file containing 90 lines with 90 numbers representing the coupling strength and separated by commas `,`. The data can be conveniently read into a matrix with the `DelimitedFiles` module. + +using DelimitedFiles +using SimpleWeightedGraphs, Graphs +using NetworkDynamics +using OrdinaryDiffEqTsit5 +using OrdinaryDiffEqSDIRK +using StableRNGs +using Plots + +# adjust the load path for your filesystem! +file = joinpath(pkgdir(NetworkDynamics), "docs", "examples", "Norm_G_DTI.txt") +G = readdlm(file, ',', Float64, '\n') + +# The data structure for directed, weighted graphs is provided by the package `SimpleWeightedGraphs.jl` which is based on `Graphs.jl`. + +# First we construct a weighted, directed graph +g_weighted = SimpleWeightedDiGraph(G) + +# For later use we extract the edge.weight attributes +# . is the broadcasting operator and gets the attribute :weight for every edge +edge_weights = getfield.(collect(edges(g_weighted)), :weight) + +# we promote the g_weighted graph as a directed graph (weights of the edges are included in parameters) +g_directed = SimpleDiGraph(g_weighted) + +# ## Setting up the ODEProblem +# +# Defining the `VertexModel` and `EdgeModel` is similar to the example before. The macro `Base.@propagate_inbounds` tells the compiler to inline the function and propagate the inbounds context. For more details see the julia [documentation](https://docs.julialang.org/en/v1/devdocs/boundscheck/). + +Base.@propagate_inbounds function fhn_electrical_vertex!(dv, v, esum, p, t) + (a, ϵ) = p + dv[1] = v[1] - v[1]^3 / 3 - v[2] + esum[1] + dv[2] = (v[1] - a) * ϵ + nothing +end +vertex = VertexModel(f=fhn_electrical_vertex!, g=1, sym=[:u, :v], psym=[:a=>0.5, :ϵ=>0.05]) + +Base.@propagate_inbounds function electrical_edge!(e, v_s, v_d, (w, σ), t) + e[1] = w * (v_s[1] - v_d[1]) * σ + nothing +end +electricaledge = EdgeModel(g=Directed(electrical_edge!), outdim=1, psym=[:weight, :σ=>0.5]) + +fhn_network! = Network(g_directed, vertex, electricaledge) + +# Since this system is a directed one with thus directed edges, the keyword argument `coupling` is used to set the coupling of the edges to `Directed()`. +# +# ## Parameter handling +# +# Some of the parameters have been declared with default values. +# Those default values will be used when creating the `NWParameter` object. +# We can use getindex on the parameter objects to set the missing weight values. + +p = NWParameter(fhn_network!) +p.e[1:ne(g_directed), :weight] = edge_weights + +# The initial conditions could be created similarly to the parameters as an indexable `NWState` obejct. +# Since we chose a random initial condition we initialize the flat array directly: + +x0 = randn(StableRNG(42), dim(fhn_network!)) * 5 + +# ## Solving the system +# +# Now we are ready to create an `ODEProblem`. Since for some choices of parameters the FitzHugh-Nagumo model is *stiff* (i.e. numerically unstable), we use a solver with automated stiffness detection. Such a solver switches to a more stable solver only when the solution enters a region of phase space where the problem is numerically unstable. In this case we use `Tsit5` and switch to `TRBDF2` when necessary. `AutoTsit5` is the switching version of the `Tsit5` algorithm. +# +# Not that we call `pflat` on the `NWParameter` object to get the flat array of parameters. + +tspan = (0.0, 200.0) +prob = ODEProblem(fhn_network!, x0, tspan, pflat(p)) +sol = solve(prob, AutoTsit5(TRBDF2())); + +# ## Plotting +# +# The plot of the excitatory variables shows that they synchronize for this choice of parameters. + +plot(sol; idxs=vidxs(fhn_network!, :, :u), legend=false, ylim=(-5, 5), fmt=:png) + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/directed_and_weighted_graphs/e002d24b.svg b/previews/PR184/generated/directed_and_weighted_graphs/e002d24b.svg new file mode 100644 index 00000000..5e035eea --- /dev/null +++ b/previews/PR184/generated/directed_and_weighted_graphs/e002d24b.svg @@ -0,0 +1,132 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/directed_and_weighted_graphs/index.html b/previews/PR184/generated/directed_and_weighted_graphs/index.html new file mode 100644 index 00000000..c06a5b52 --- /dev/null +++ b/previews/PR184/generated/directed_and_weighted_graphs/index.html @@ -0,0 +1,48 @@ + +Directed and Weighted Graphs · NetworkDynamics

Neurodynamic model of synchronization in the human brain

This example can be dowloaded as a normal Julia script here.

Topics covered in this tutorial include:

  • constructing a directed, weighted graph from data
  • some useful macros
  • parameter handling
  • stiff equations

The FitzHugh-Nagumo model

Dynamics of spiking neurons have been described in a simplified manner by the FitzHugh-Nagumo model.

\[\begin{aligned} +\varepsilon \dot u & = u - \frac{u^3}{3} - v \\ +\dot v & = u + a +\end{aligned}\]

Here $u$ is a fast, excitatory variable corresponding to the membrane potential and $v$ is a slower, inhibitory varibale. $\varepsilon$ is a parameter separating these time-scales, and $a$ is a control parameter.

In simplified models of the brain, such relaxation oscillators may be used to model individual neurons, clusters of neurons or even larger areas in the brain. The FitzHugh-Nagumo model has been widely used for studying synchronization in neuronal activity, which in turn has been connected to physiological phenomena such as epileptic seizures.

Coupling relaxation oscillators

While different coupling schemes for FitzHugh-Nagumo oscillators have been proposed, in this tutorial we focus on coupling of the excitatory variables via electrical gap junctions, as described by the following system of equations.

\[\begin{aligned} +\varepsilon \dot u_i & = u_i - \frac{u_i^3}{3} - v_i - \sigma \sum_{j=1}^N G_{ij}(u_i - u_j) \\ +\dot v_i & = u_i + a +\end{aligned}\]

This is a simple diffusive coupling mediated by the difference between activation potentials in pairs of neurons. A similar coupling term was introduced in the "getting started" tutorial.

The network topology - a brain atlas

In the following we will use a directed and weighted network encoding the strength and directionality of coupling between 90 different areas of the brain [Nathalie Tzourio-Mazoyer et al., 2002, Neuroimage].

The network weight matrix is given as a text file containing 90 lines with 90 numbers representing the coupling strength and separated by commas ,. The data can be conveniently read into a matrix with the DelimitedFiles module.

using DelimitedFiles
+using SimpleWeightedGraphs, Graphs
+using NetworkDynamics
+using OrdinaryDiffEqTsit5
+using OrdinaryDiffEqSDIRK
+using StableRNGs
+using Plots
+
+# adjust the load path for your filesystem!
+file = joinpath(pkgdir(NetworkDynamics), "docs", "examples", "Norm_G_DTI.txt")
+G = readdlm(file, ',', Float64, '\n')

The data structure for directed, weighted graphs is provided by the package SimpleWeightedGraphs.jl which is based on Graphs.jl.

# First we construct a weighted, directed graph
+g_weighted = SimpleWeightedDiGraph(G)
+
+# For later use we extract the edge.weight attributes
+# . is the broadcasting operator and gets the attribute :weight for every edge
+edge_weights = getfield.(collect(edges(g_weighted)), :weight)
+
+# we promote the g_weighted graph as a directed graph (weights of the edges are included in parameters)
+g_directed = SimpleDiGraph(g_weighted)

Setting up the ODEProblem

Defining the VertexModel and EdgeModel is similar to the example before. The macro Base.@propagate_inbounds tells the compiler to inline the function and propagate the inbounds context. For more details see the julia documentation.

Base.@propagate_inbounds function fhn_electrical_vertex!(dv, v, esum, p, t)
+    (a, ϵ) = p
+    dv[1] = v[1] - v[1]^3 / 3 - v[2] + esum[1]
+    dv[2] = (v[1] - a) * ϵ
+    nothing
+end
+vertex = VertexModel(f=fhn_electrical_vertex!, g=1, sym=[:u, :v], psym=[:a=>0.5, :ϵ=>0.05])
VertexModel :VertexM PureStateMap()
+ ├─ 2 states: [u, v]
+ ├─ 1 output: [u]
+ └─ 2 params: [a=0.5, ϵ=0.05]
Base.@propagate_inbounds function electrical_edge!(e, v_s, v_d, (w, σ), t)
+    e[1] = w * (v_s[1] - v_d[1]) * σ
+    nothing
+end
+electricaledge = EdgeModel(g=Directed(electrical_edge!), outdim=1, psym=[:weight, :σ=>0.5])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 0/1 outputs: src=[] dst=[o]
+ └─   2 params:  [weight, σ=0.5]
fhn_network! = Network(g_directed, vertex, electricaledge)
Network with 180 states and 15766 parameters
+ ├─ 90 vertices (1 unique type)
+ └─ 7793 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

Since this system is a directed one with thus directed edges, the keyword argument coupling is used to set the coupling of the edges to Directed().

Parameter handling

Some of the parameters have been declared with default values. Those default values will be used when creating the NWParameter object. We can use getindex on the parameter objects to set the missing weight values.

p = NWParameter(fhn_network!)
+p.e[1:ne(g_directed), :weight] = edge_weights

The initial conditions could be created similarly to the parameters as an indexable NWState obejct. Since we chose a random initial condition we initialize the flat array directly:

x0 = randn(StableRNG(42), dim(fhn_network!)) * 5

Solving the system

Now we are ready to create an ODEProblem. Since for some choices of parameters the FitzHugh-Nagumo model is stiff (i.e. numerically unstable), we use a solver with automated stiffness detection. Such a solver switches to a more stable solver only when the solution enters a region of phase space where the problem is numerically unstable. In this case we use Tsit5 and switch to TRBDF2 when necessary. AutoTsit5 is the switching version of the Tsit5 algorithm.

Not that we call pflat on the NWParameter object to get the flat array of parameters.

tspan = (0.0, 200.0)
+prob  = ODEProblem(fhn_network!, x0, tspan, pflat(p))
+sol = solve(prob, AutoTsit5(TRBDF2()));

Plotting

The plot of the excitatory variables shows that they synchronize for this choice of parameters.

plot(sol; idxs=vidxs(fhn_network!, :, :u), legend=false, ylim=(-5, 5), fmt=:png)
Example block output

This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/gas_network.jl b/previews/PR184/generated/gas_network.jl new file mode 100644 index 00000000..4385ea1d --- /dev/null +++ b/previews/PR184/generated/gas_network.jl @@ -0,0 +1,379 @@ +# # Dynamic Flow in simple Gas Network +# +# This Example is based on the paper +# +# > Albertus J. Malan, Lukas Rausche, Felix Strehle, Sören Hohmann, +# > Port-Hamiltonian Modelling for Analysis and Control of Gas Networks, +# > IFAC-PapersOnLine, Volume 56, Issue 2, 2023, https://doi.org/10.1016/j.ifacol.2023.10.193. +# +# and tries replicate a simple simulation of flow in a 3-node gas network. +# +# +# We start by importing the necessary packages: + +using NetworkDynamics +using ModelingToolkit +using DynamicQuantities +using ModelingToolkit: D as Dt, t as t +using Test +using StaticArrays +using LinearInterpolations +using OrdinaryDiffEqTsit5 +using CairoMakie +CairoMakie.activate!(type="svg") #hide + +# ## Node Models +# +# In this example, we use the equation based modeling using `ModelingToolkit.jl`. +# To verify the equations on a basic level we also provide units to eveything to +# perform dimensionality checks. +# +# There are 2 node models used in the paper. The first node type has a constant +# pressure. +# Additionally, we ad some "internal" state `q̃_inj` which we want to plot later (see also Observables). + +@mtkmodel ConstantPressureNode begin + @parameters begin + p_set, [description="Constant pressure setpoint", unit=u"Pa"] + end + @variables begin + p(t) = p_set, [description="Pressure", unit=u"Pa", output=true] + q̃_nw(t), [description="aggregated flow from pipes into node", unit=u"m^3/s", input=true] + q̃_inj(t), [description="internal state for introspection", unit=u"m^3/s"] + end + @equations begin + p ~ p_set + q̃_inj ~ -q̃_nw + end +end +nothing #hide + +# The second node model is a variable pressure node. It has one output state (the pressure) and one input state, +# the aggregated flows from the connected pipes. +# As an internal state we have the injected flow from our source/load. +# The source/load behaviour itself is provided via a time dependent function. + +@mtkmodel VariablePressureNode begin + @structural_parameters begin + load_profile # time dependent load profile + end + @parameters begin + C, [description="Lumped capacitance of connected pipes", unit=u"m^4 * s^2 / kg"] + end + @variables begin + p(t)=5e6, [description="Pressure", unit=u"Pa", output=true] + q̃_inj(t), [description="external injection into node", unit=u"m^3/s"] + q̃_nw(t), [description="aggregated flow from pipes into node", unit=u"m^3/s", input=true] + end + @equations begin + q̃_inj ~ load_profile(t) + C * Dt(p) ~ q̃_inj + q̃_nw # (30) + end +end +nothing #hide + +# ## Pipe Model +# +# The pipe is modeld as a first order ODE for the volumetric flow at the `dst` end. It has two inputs: +# the pressure at the source and and the pressure at the destination end. +# Later on, we'll specify the model to be antisymmetric, thus the flow is calculated explicitly for the +# destination end, but the source end will just recive just that times (-1). + +@mtkmodel Pipe begin + @parameters begin + L, [description="Length of pipe", unit=u"m"] + D, [description="Diameter of pipe", unit=u"m"] + A, [description="Cross-sectional area of pipe", unit=u"m^2"] + sinθ, [description="Angle of inclination" ] + γ, [description="Friction efficiency factor"] + η, [description="Dynamic viscosity", unit=u"kg/(m*s)"] + r, [description="Pipe roughness", unit=u"m"] + g, [description="Gravitational acceleration", unit=u"m/s^2"] + T, [description="simulation temperature", unit=u"K"] + Tc, [description="crictical temperature", unit=u"K"] + pc, [description="critical pressure", unit=us"Pa"] + Rs, [description="Specific gas constant for natural gas", unit=us"J/(kg*K)"] + c̃, [description="Speed of sound in fluid at standard conditions", unit=u"m/s"] + ρ̃, [description="standard density", unit=u"kg/m^3"] + p̃, [description="standard pressure", unit=us"Pa"] + end + @variables begin + p_src(t), [description="Pressure at source end", unit=us"Pa", input=true] + p_dst(t), [description="Pressure at destination end", unit=us"Pa", input=true] + q̃(t)=1, [description="Flow through pipe", unit=u"m^3/s", output=true] + Re(t), [description="Reynolds number"] + λ(t), [description="Friction factor"] + λe(t), [description="Effective friction factor"] + pM(t), [description="mean pressure", unit=us"Pa"] + Z(t), [description="compressibility factor"] + ρ(t), [description="density", unit=u"kg/m^3"] + c(t), [description="speed of sound", unit=u"m/s"] + end + @equations begin + Z ~ 1 - 3.52 * pM/pc * exp(-2.26*(T/Tc)) + 0.274 * (pM/pc)^2 * exp(-1.878*(T/Tc)) # (5) + ρ ~ pM / (Rs * T * Z) # (4) + + # TODO: Whats the correct speed of sound? + c ~ sqrt(T * Rs * Z) # (4) # pressure/temp dependent + # c ~ c̃ # "standard" speed of sound based on standard conditions + + # TODO: Whats the correct Reynolds number? + Re ~ (ρ * abs(q̃*p̃/pM) * D) / (η * A) # (6) # based "actual" conditions + # Re ~ (ρ̃ * abs(q̃) * D) / (η * A) # (6) # based on standard conditions + + λ ~ ifelse(Re < 2300, + 64/Re, # laminar (7) + (2*log10(4.518/Re * log10(Re/7) + r/(3.71*D)))^(-2) # turbulent (8) + ) + λe ~ λ/γ^2 # (10) + pM ~ 2/3*(p_src + p_dst - (p_src*p_dst)/(p_src + p_dst)) # (20) + + Dt(q̃) ~ A/(L*ρ̃)*(-(λe * ρ̃^2 * c^2 * L * abs(q̃))/(2 * D * A^2 * pM) * q̃ - (g * L * sinθ)/(c^2) * pM + (p_src - p_dst)) # (31) + end +end +nothing #hide + +# ## Parametrization +# +# The parameterization turned out to be a bit tricky. There might be errors in there. +# +# Some of them are quite cleare and explicitly given. + +g = 9.81u"m/s^2" # that we just know +Rs = 518.28u"J/(kg*K)" # Specific gas constant for natural gas +η = 1e-5u"kg/(m*s)" # Dynamic viscosity +pc = 46.5u"bar" # Critical pressure +p̃ = 1.01325u"bar" # standard pressure +Tc = 190.55u"K" # critical temperature +T̃ = 273.15u"K" # standard temperature +T = 278u"K" # simulation temperature +γ = 0.98 # friction efficiency factor +r = 0.012u"mm" # pipe roughness +D = 0.6u"m" # pipe diameter + +# TODO: here is switched the lenths l12 and l13. The results are better. Is this a mistake in the paper? +L₁₂ = 90u"km" +L₁₃ = 80u"km" +L₂₃ = 100u"km" +Δh₁ = 0u"km" # this value is different for different sims in the paper +p₁_set = 50u"bar" +nothing # hide + +# The geometric parameters for the pipes can be directly derived. + +A = π/4 * D^2 +sinθ₁₂ = ustrip(Δh₁ / L₁₂) +sinθ₁₃ = ustrip(Δh₁ / L₁₃) +sinθ₂₃ = 0.0 +nothing # hide + +# Lastly, we need to calculate the compressibility factor, the speed of sound and +# the density at standard conditions: + +Z̃ = 1 - 3.52 * p̃/pc * exp(-2.26*(T̃/Tc)) + 0.274 * (p̃/pc)^2 * exp(-1.878*(T̃/Tc)) # (5) +c̃ = sqrt(T̃ * Rs * Z̃) # (4) at standard conditions +ρ̃ = p̃ / (Rs * T̃ * Z̃) # (4) at standard conditions + +nothing # hide + +# The equivalent "pressure capacity" at the nodes is calculated as a sum of the connected +# pipe parameters according to (28). +# +# Here use defintions based on the speed and "standard" conditions. + +C₂ = L₁₂*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28) +C₃ = L₁₃*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28) +nothing #hide + +# Alternatively, we could calculate `Z2` and `Z3` based on the actuel pressure and simulation temperature. +# Then we could calculated the speed of sound for the "correct" conditions at the node. +# It seems to have very little effect on the actual results so I kept it simple. + +nothing #hide + +# ## Load Profile +# +# The paper specifies the load profile at two nodes. We use the package [`LinearInterpolations.jl`](https://github.com/jw3126/LinearInterpolations.jl) +# to get a callable object which represents this picewise linear interpolation. +# +# However, this function is not Symbolics.jl compatible, so we need to stop Symbolics.jl/ModelingToolkit.jl +# from tracing it. To do so, we use `@register_symbolic` to declare it as a symbolic function which is treated +# as a blackbox. +# +# Additionally, we need to tell ModelingToolkit about the units of this object. This is just used +# for the static unit check during construction of the model. Later one, when we generate the +# Julia code from the symbolic reepresentation all units will be stripped. +# +# > **Discontinuities in RHS** +# > +# > The picewise linear interpolated function creates discontinuities in the RHS of the system. +# > However since we know the times exactly, we can handle this by simply giving a list of explicit +# > tstops to the solve command, to make sure those are hit exactly. + +load2(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[20, 30, 10, 30, 20], extrapolate=LinearInterpolations.Constant(20))(t) +load3(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[40, 50, 30, 50, 40], extrapolate=LinearInterpolations.Constant(40))(t) +@register_symbolic load2(t) +@register_symbolic load3(t) +ModelingToolkit.get_unit(op::typeof(load2), _) = u"m^3/s" +ModelingToolkit.get_unit(op::typeof(load3), _) = u"m^3/s" +nothing #hide + +# ## Building the Network +# +# To bild the Network we first need to define the components. This is a two step process: +# +# - first create the symbolic `ODESystem` using ModelingToolkit +# - secondly build a NetworkDynamics component model (`VertexModel`/`EdgeModel`) based on the symbolic system. +# +# In the first step we can use the keyword arguments to pass "default" values for our parameters and states. +# Those values will be automaticially transfered to the metadata of the component model the second step. +# +# The second step requires to define the interface variables, i.e. what are the "input" states of your +# component model and what are the "output" states. +# For `VertexModel` the input state is the aggregated flow of all connected pipes. The output state is the pressure of the node. + +@named v1_mtk = ConstantPressureNode(p_set=p₁_set) +v1 = VertexModel(v1_mtk, [:q̃_nw], [:p]; name=:v1, vidx=1) + +@named v2_mtk = VariablePressureNode(C=C₂, load_profile=load2) +v2 = VertexModel(v2_mtk, [:q̃_nw], [:p]; name=:v2, vidx=2) + +@named v3_mtk = VariablePressureNode(C=C₃, load_profile=load3) +v3 = VertexModel(v3_mtk, [:q̃_nw], [:p]; name=:v3, vidx=3) + +# For the edge Model we have two inputs: the pressure on both source and destination end. +# There is a single output state: the volumetric flow. However we also need to tell +# NetworkDynamics about the coupling type. In this case we use `AntiSymmetric`, which +# meas that the source end will recieve the same flow, just inverted sign. + +@named e12_mtk = Pipe(; L=L₁₂, sinθ=sinθ₁₂, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃) +@named e13_mtk = Pipe(; L=L₁₃, sinθ=sinθ₁₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃) +@named e23_mtk = Pipe(; L=L₂₃, sinθ=sinθ₂₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃) + +e12 = EdgeModel(e12_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e12, src=1, dst=2) +e13 = EdgeModel(e13_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e13, src=1, dst=3) +e23 = EdgeModel(e23_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e23, src=2, dst=3) + +# To build the network object we just need to pass the vertices and edges to the constructor. +# +# Note that we've used the `vidx` and `src`/`dst` keywords in the constructors to define for +# each component to which "part" of the network it belongs. +# +# This means, the constructor can automaticially construct a graph based on those informations and +# we don't need to pass it explicitly. + +nw = Network([v1, v2, v3], [e12, e13, e23]) + +# As a result, we recive a network with 3 unique types (v2 and v3 are similar but +# structurally different, because both functions capure a unique loadprofile function). +# +# ## Finding a Steady State +# +# To simulate the systme, we first need to find a steadystate. As a "guess" for that +# we create a `NWState` object from the network. +# This will allocate flat arrays for states `u` and parameters `p` and fill them with the +# default values. + +uguess = NWState(nw) + +# This is not a steadystate of the system however. To find a true steadystate we want to ensure +# that the lhs of the system is zero. +# We can solve for a steady state numerically by defining a Nonlinear Rootfind problem. +# +# To do so, we need to wrap the Network object in a closure. + +nwwrap = (du, u, p) -> begin + nw(du, u, p, 0) + nothing +end +initprob = NonlinearProblem(nwwrap, uflat(uguess), pflat(uguess)) +initsol = solve(initprob) + +# We can create a new `NWState` object by wrapping the solution from the nonlinear problem and the +# original prameters in a new `NWState` object. + +u0 = NWState(nw, initsol.u, uguess.p) + +# ## Solving the ODE +# +# Using this as our initial state we can create the actual `ODEProblem`. +# Since the ode allways operates on flat state and aprameter arrays we use `uflat` and `pflat` to extract them. + +prob = ODEProblem(nw, uflat(u0), (0.0,24*3600), copy(pflat(u0))) +sol = solve(prob, Tsit5(), tstops=[0,4,12,20,24]*3600) +nothing #hide + +# ## Inspect the Solution +# +# Inspecting the solution is all which is left to do. + +xticks = ((0:4:24)*3600, string.(0:4:24)) # its nice to display hours +fig = begin + _fig = Figure() + row = 1 + ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="pressure [Pa]", title="Pressure at nodes", xticks) + xlims!(ax, sol.t[begin], sol.t[end]) + ylims!(ax, 47.9e5, 49.9e5) + for i in 1:3 + lines!(ax, sol, idxs=vidxs(nw, i, :p); label="v$i", color=Cycled(i)) + end + axislegend(ax) + row += 1 + + ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="flow [m³/s]", title="Flow through pipes", xticks) + xlims!(ax, sol.t[begin], sol.t[end]) + ylims!(ax, 16, 44) + for i in 1:2 + lines!(ax, sol, idxs=eidxs(nw, i, :q̃); label="e$i flow", color=Cycled(i)) + end + axislegend(ax, position=:rb) + row += 1 + _fig +end + +# Notably, the "internal" states defined in the symbolic models are not "states" in the sense of the ODE. +# For example, we captured the load profile in the `q̃_inj` state of the `VariablePressureNode`. +# The only dynamic state of the model however is `p`. +# Using the "observables" mechanism from SciML, which is implemented by NetworkDynamics, we can reconstruct +# those "optimized" states which have been removed symbolicially. +# Here we plot the reconstructed load profile of nodes 2 and 3. Also, we know that node 1 is infinetly stiff, +# acting as an infinite source of volumetric flow. We can reconstruct this flow too. + +fig = begin + _fig = Figure() + row = 1 + ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="flow [m³/s]", title="Flow at nodes", xticks) + xlims!(ax, sol.t[begin], sol.t[end]) + lines!(ax, sol, idxs=vidxs(nw, 1, :q̃_inj); label="v1 compensation", color=Cycled(1)) + for i in 2:3 + lines!(ax, sol, idxs=vidxs(nw, i, :q̃_inj); label="v$i load profile", color=Cycled(i)) + end + axislegend(ax, position=:rc) + _fig +end + +# Lastly we want to observe two internal states of the pipes: the Reynolds number and the mean pressure. +# We see, that we're purely in the turbulent flow regime. + +fig = begin + _fig = Figure() + row = 1 + ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="Reynolds number", title="Reynolds number", xticks) + xlims!(ax, sol.t[begin], sol.t[end]) + for i in 1:3 + lines!(ax, sol, idxs=eidxs(nw, i, :Re); label="e $i", color=Cycled(i)) + end + hlines!(ax, 2300, color=:black, linestyle=:dash, label="L/T transition") + axislegend(ax, position=:rb) + row += 1 + + ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="Mean pressure [Pa]", title="Mean pressure in pipes", xticks) + xlims!(ax, sol.t[begin], sol.t[end]) + for i in 1:3 + lines!(ax, sol, idxs=eidxs(nw, i, :pM); label="e $i", color=Cycled(i)) + end + axislegend(ax, position=:rb) + _fig +end + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/gas_network/43f744c5.svg b/previews/PR184/generated/gas_network/43f744c5.svg new file mode 100644 index 00000000..fc1b195b --- /dev/null +++ b/previews/PR184/generated/gas_network/43f744c5.svg @@ -0,0 +1,1008 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/gas_network/c1087a40.svg b/previews/PR184/generated/gas_network/c1087a40.svg new file mode 100644 index 00000000..bc7ff1b2 --- /dev/null +++ b/previews/PR184/generated/gas_network/c1087a40.svg @@ -0,0 +1,922 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/gas_network/fc4b8144.svg b/previews/PR184/generated/gas_network/fc4b8144.svg new file mode 100644 index 00000000..dfd41905 --- /dev/null +++ b/previews/PR184/generated/gas_network/fc4b8144.svg @@ -0,0 +1,529 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/gas_network/index.html b/previews/PR184/generated/gas_network/index.html new file mode 100644 index 00000000..7adad3b7 --- /dev/null +++ b/previews/PR184/generated/gas_network/index.html @@ -0,0 +1,224 @@ + +Gas Network · NetworkDynamics

Dynamic Flow in simple Gas Network

This Example is based on the paper

Albertus J. Malan, Lukas Rausche, Felix Strehle, Sören Hohmann, Port-Hamiltonian Modelling for Analysis and Control of Gas Networks, IFAC-PapersOnLine, Volume 56, Issue 2, 2023, https://doi.org/10.1016/j.ifacol.2023.10.193.

and tries replicate a simple simulation of flow in a 3-node gas network.

This example can be dowloaded as a normal Julia script here.

We start by importing the necessary packages:

using NetworkDynamics
+using ModelingToolkit
+using DynamicQuantities
+using ModelingToolkit: D as Dt, t as t
+using Test
+using StaticArrays
+using LinearInterpolations
+using OrdinaryDiffEqTsit5
+using CairoMakie

Node Models

In this example, we use the equation based modeling using ModelingToolkit.jl. To verify the equations on a basic level we also provide units to eveything to perform dimensionality checks.

There are 2 node models used in the paper. The first node type has a constant pressure. Additionally, we ad some "internal" state q̃_inj which we want to plot later (see also Observables).

@mtkmodel ConstantPressureNode begin
+    @parameters begin
+        p_set, [description="Constant pressure setpoint", unit=u"Pa"]
+    end
+    @variables begin
+        p(t) = p_set, [description="Pressure", unit=u"Pa", output=true]
+        q̃_nw(t), [description="aggregated flow from pipes into node", unit=u"m^3/s", input=true]
+        q̃_inj(t), [description="internal state for introspection", unit=u"m^3/s"]
+    end
+    @equations begin
+        p ~ p_set
+        q̃_inj ~ -q̃_nw
+    end
+end

The second node model is a variable pressure node. It has one output state (the pressure) and one input state, the aggregated flows from the connected pipes. As an internal state we have the injected flow from our source/load. The source/load behaviour itself is provided via a time dependent function.

@mtkmodel VariablePressureNode begin
+    @structural_parameters begin
+        load_profile # time dependent load profile
+    end
+    @parameters begin
+        C, [description="Lumped capacitance of connected pipes", unit=u"m^4 * s^2 / kg"]
+    end
+    @variables begin
+        p(t)=5e6, [description="Pressure", unit=u"Pa", output=true]
+        q̃_inj(t), [description="external injection into node", unit=u"m^3/s"]
+        q̃_nw(t), [description="aggregated flow from pipes into node", unit=u"m^3/s", input=true]
+    end
+    @equations begin
+        q̃_inj ~ load_profile(t)
+        C * Dt(p) ~ q̃_inj + q̃_nw # (30)
+    end
+end

Pipe Model

The pipe is modeld as a first order ODE for the volumetric flow at the dst end. It has two inputs: the pressure at the source and and the pressure at the destination end. Later on, we'll specify the model to be antisymmetric, thus the flow is calculated explicitly for the destination end, but the source end will just recive just that times (-1).

@mtkmodel Pipe begin
+    @parameters begin
+        L, [description="Length of pipe", unit=u"m"]
+        D, [description="Diameter of pipe", unit=u"m"]
+        A, [description="Cross-sectional area of pipe", unit=u"m^2"]
+        sinθ, [description="Angle of inclination" ]
+        γ, [description="Friction efficiency factor"]
+        η, [description="Dynamic viscosity", unit=u"kg/(m*s)"]
+        r, [description="Pipe roughness", unit=u"m"]
+        g, [description="Gravitational acceleration", unit=u"m/s^2"]
+        T, [description="simulation temperature", unit=u"K"]
+        Tc, [description="crictical temperature", unit=u"K"]
+        pc, [description="critical pressure", unit=us"Pa"]
+        Rs, [description="Specific gas constant for natural gas", unit=us"J/(kg*K)"]
+        c̃, [description="Speed of sound in fluid at standard conditions", unit=u"m/s"]
+        ρ̃, [description="standard density", unit=u"kg/m^3"]
+        p̃, [description="standard pressure", unit=us"Pa"]
+    end
+    @variables begin
+        p_src(t), [description="Pressure at source end", unit=us"Pa", input=true]
+        p_dst(t), [description="Pressure at destination end", unit=us"Pa", input=true]
+        q̃(t)=1, [description="Flow through pipe", unit=u"m^3/s", output=true]
+        Re(t), [description="Reynolds number"]
+        λ(t), [description="Friction factor"]
+        λe(t), [description="Effective friction factor"]
+        pM(t), [description="mean pressure", unit=us"Pa"]
+        Z(t), [description="compressibility factor"]
+        ρ(t), [description="density", unit=u"kg/m^3"]
+        c(t), [description="speed of sound", unit=u"m/s"]
+    end
+    @equations begin
+        Z ~ 1 - 3.52 * pM/pc * exp(-2.26*(T/Tc)) + 0.274 * (pM/pc)^2 * exp(-1.878*(T/Tc)) # (5)
+        ρ ~ pM / (Rs * T * Z) # (4)
+
+        # TODO: Whats the correct speed of sound?
+        c ~ sqrt(T * Rs * Z) # (4) # pressure/temp dependent
+        # c ~ c̃                   # "standard" speed of sound based on standard conditions
+
+        # TODO: Whats the correct Reynolds number?
+        Re ~ (ρ * abs(q̃*p̃/pM) * D) / (η * A) # (6) # based "actual" conditions
+        # Re ~ (ρ̃ * abs(q̃) * D) / (η * A) # (6)   # based on standard conditions
+
+        λ ~ ifelse(Re < 2300,
+            64/Re, # laminar (7)
+            (2*log10(4.518/Re * log10(Re/7) + r/(3.71*D)))^(-2) # turbulent (8)
+        )
+        λe ~ λ/γ^2 # (10)
+        pM ~ 2/3*(p_src + p_dst - (p_src*p_dst)/(p_src + p_dst)) # (20)
+
+        Dt(q̃) ~ A/(L*ρ̃)*(-(λe * ρ̃^2 * c^2 * L * abs(q̃))/(2 * D * A^2 * pM) * q̃ - (g * L * sinθ)/(c^2) * pM + (p_src - p_dst)) # (31)
+    end
+end

Parametrization

The parameterization turned out to be a bit tricky. There might be errors in there.

Some of them are quite cleare and explicitly given.

g = 9.81u"m/s^2"       # that we just know
+Rs = 518.28u"J/(kg*K)" # Specific gas constant for natural gas
+η  = 1e-5u"kg/(m*s)"   # Dynamic viscosity
+pc = 46.5u"bar"        # Critical pressure
+p̃  = 1.01325u"bar"     # standard pressure
+Tc = 190.55u"K"        # critical temperature
+T̃  = 273.15u"K"        # standard temperature
+T  = 278u"K"           # simulation temperature
+γ  = 0.98              # friction efficiency factor
+r  = 0.012u"mm"        # pipe roughness
+D  = 0.6u"m"           # pipe diameter
+
+# TODO: here is switched the lenths l12 and l13. The results are better. Is this a mistake in the paper?
+L₁₂ = 90u"km"
+L₁₃ = 80u"km"
+L₂₃ = 100u"km"
+Δh₁ = 0u"km"           # this value is different for different sims in the paper
+p₁_set = 50u"bar"

The geometric parameters for the pipes can be directly derived.

A = π/4 * D^2
+sinθ₁₂ = ustrip(Δh₁ / L₁₂)
+sinθ₁₃ = ustrip(Δh₁ / L₁₃)
+sinθ₂₃ = 0.0

Lastly, we need to calculate the compressibility factor, the speed of sound and the density at standard conditions:

Z̃ = 1 - 3.52 * p̃/pc * exp(-2.26*(T̃/Tc)) + 0.274 * (p̃/pc)^2 * exp(-1.878*(T̃/Tc)) # (5)
+c̃ = sqrt(T̃ * Rs * Z̃) # (4) at standard conditions
+ρ̃ = p̃ / (Rs * T̃ * Z̃) # (4) at standard conditions

The equivalent "pressure capacity" at the nodes is calculated as a sum of the connected pipe parameters according to (28).

Here use defintions based on the speed and "standard" conditions.

C₂ = L₁₂*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28)
+C₃ = L₁₃*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28)

Alternatively, we could calculate Z2 and Z3 based on the actuel pressure and simulation temperature. Then we could calculated the speed of sound for the "correct" conditions at the node. It seems to have very little effect on the actual results so I kept it simple.

Load Profile

The paper specifies the load profile at two nodes. We use the package LinearInterpolations.jl to get a callable object which represents this picewise linear interpolation.

However, this function is not Symbolics.jl compatible, so we need to stop Symbolics.jl/ModelingToolkit.jl from tracing it. To do so, we use @register_symbolic to declare it as a symbolic function which is treated as a blackbox.

Additionally, we need to tell ModelingToolkit about the units of this object. This is just used for the static unit check during construction of the model. Later one, when we generate the Julia code from the symbolic reepresentation all units will be stripped.

Discontinuities in RHS

The picewise linear interpolated function creates discontinuities in the RHS of the system. However since we know the times exactly, we can handle this by simply giving a list of explicit tstops to the solve command, to make sure those are hit exactly.

load2(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[20, 30, 10, 30, 20], extrapolate=LinearInterpolations.Constant(20))(t)
+load3(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[40, 50, 30, 50, 40], extrapolate=LinearInterpolations.Constant(40))(t)
+@register_symbolic load2(t)
+@register_symbolic load3(t)
+ModelingToolkit.get_unit(op::typeof(load2), _) = u"m^3/s"
+ModelingToolkit.get_unit(op::typeof(load3), _) = u"m^3/s"

Building the Network

To bild the Network we first need to define the components. This is a two step process:

  • first create the symbolic ODESystem using ModelingToolkit
  • secondly build a NetworkDynamics component model (VertexModel/EdgeModel) based on the symbolic system.

In the first step we can use the keyword arguments to pass "default" values for our parameters and states. Those values will be automaticially transfered to the metadata of the component model the second step.

The second step requires to define the interface variables, i.e. what are the "input" states of your component model and what are the "output" states. For VertexModel the input state is the aggregated flow of all connected pipes. The output state is the pressure of the node.

@named v1_mtk = ConstantPressureNode(p_set=p₁_set)
+v1 = VertexModel(v1_mtk, [:q̃_nw], [:p]; name=:v1, vidx=1)
VertexModel :v1 NoFeedForward() @ Vertex 1
+ ├─ 1 input:  [q̃_nw]
+ ├─ 0 states: []
+ ├─ 1 output: [p=5e6]
+ └─ 1 param:  [p_set=5e6]
@named v2_mtk = VariablePressureNode(C=C₂, load_profile=load2)
+v2 = VertexModel(v2_mtk, [:q̃_nw], [:p]; name=:v2, vidx=2)
VertexModel :v2 PureStateMap() @ Vertex 2
+ ├─ 1 input:  [q̃_nw]
+ ├─ 1 state:  [p=5e6]
+ ├─ 1 output: [p=5e6]
+ └─ 1 param:  [C=0.26509]
@named v3_mtk = VariablePressureNode(C=C₃, load_profile=load3)
+v3 = VertexModel(v3_mtk, [:q̃_nw], [:p]; name=:v3, vidx=3)
VertexModel :v3 PureStateMap() @ Vertex 3
+ ├─ 1 input:  [q̃_nw]
+ ├─ 1 state:  [p=5e6]
+ ├─ 1 output: [p=5e6]
+ └─ 1 param:  [C=0.25114]

For the edge Model we have two inputs: the pressure on both source and destination end. There is a single output state: the volumetric flow. However we also need to tell NetworkDynamics about the coupling type. In this case we use AntiSymmetric, which meas that the source end will recieve the same flow, just inverted sign.

@named e12_mtk = Pipe(; L=L₁₂, sinθ=sinθ₁₂, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)
+@named e13_mtk = Pipe(; L=L₁₃, sinθ=sinθ₁₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)
+@named e23_mtk = Pipe(; L=L₂₃, sinθ=sinθ₂₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)
+
+e12 = EdgeModel(e12_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e12, src=1, dst=2)
+e13 = EdgeModel(e13_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e13, src=1, dst=3)
+e23 = EdgeModel(e23_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e23, src=2, dst=3)
EdgeModel :e23 PureStateMap() @ Edge 2=>3
+ ├─ 1/1 inputs:  src=[p_src] dst=[p_dst]
+ ├─   1 state:   [q̃=1]
+ ├─ 1/1 outputs: src=[₋q̃] dst=[q̃=1]
+ └─  14 params:  [ρ̃=0.71788, T=278, Rs=518.28, L=1e5, γ=0.98, D=0.6, p̃=1.0132e5, pc=4.65e6, η=1e-5, sinθ=0, Tc=190.55, A=0.28274, r=1.2e-5, g=9.81]

To build the network object we just need to pass the vertices and edges to the constructor.

Note that we've used the vidx and src/dst keywords in the constructors to define for each component to which "part" of the network it belongs.

This means, the constructor can automaticially construct a graph based on those informations and we don't need to pass it explicitly.

nw = Network([v1, v2, v3], [e12, e13, e23])
Network with 5 states and 45 parameters
+ ├─ 3 vertices (3 unique types)
+ └─ 3 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

As a result, we recive a network with 3 unique types (v2 and v3 are similar but structurally different, because both functions capure a unique loadprofile function).

Finding a Steady State

To simulate the systme, we first need to find a steadystate. As a "guess" for that we create a NWState object from the network. This will allocate flat arrays for states u and parameters p and fill them with the default values.

uguess = NWState(nw)
NWState{Vector{Float64}} of Network (3 vertices, 3 edges)
+  ├─ VIndex(2, :p)  => 5.0e6
+  ├─ VIndex(3, :p)  => 5.0e6
+  ├─ EIndex(1, :q̃)  => 1.0
+  ├─ EIndex(2, :q̃)  => 1.0
+  └─ EIndex(3, :q̃)  => 1.0
+ p = NWParameter([5.0e6, 0.265094, 0.251141, 0.717884, 278.0, 518.28, 90000.0, 0.98, 0.6, 101325.0  …  0.98, 0.6, 101325.0, 4.65e6, 1.0e-5, 0.0, 190.55, 0.282743, 1.2e-5, 9.81])
+ t = nothing

This is not a steadystate of the system however. To find a true steadystate we want to ensure that the lhs of the system is zero. We can solve for a steady state numerically by defining a Nonlinear Rootfind problem.

To do so, we need to wrap the Network object in a closure.

nwwrap = (du, u, p) -> begin
+    nw(du, u, p, 0)
+    nothing
+end
+initprob = NonlinearProblem(nwwrap, uflat(uguess), pflat(uguess))
+initsol = solve(initprob)
retcode: Success
+u: 5-element Vector{Float64}:
+  4.89510907098914e6
+  4.883573000934716e6
+ 28.277070738769
+ 31.722929261231
+  8.277070738768998

We can create a new NWState object by wrapping the solution from the nonlinear problem and the original prameters in a new NWState object.

u0 = NWState(nw, initsol.u, uguess.p)
NWState{Vector{Float64}} of Network (3 vertices, 3 edges)
+  ├─ VIndex(2, :p)  => 4.89510907098914e6
+  ├─ VIndex(3, :p)  => 4.883573000934716e6
+  ├─ EIndex(1, :q̃)  => 28.277070738769
+  ├─ EIndex(2, :q̃)  => 31.722929261231
+  └─ EIndex(3, :q̃)  => 8.277070738768998
+ p = NWParameter([5.0e6, 0.265094, 0.251141, 0.717884, 278.0, 518.28, 90000.0, 0.98, 0.6, 101325.0  …  0.98, 0.6, 101325.0, 4.65e6, 1.0e-5, 0.0, 190.55, 0.282743, 1.2e-5, 9.81])
+ t = nothing

Solving the ODE

Using this as our initial state we can create the actual ODEProblem. Since the ode allways operates on flat state and aprameter arrays we use uflat and pflat to extract them.

prob = ODEProblem(nw, uflat(u0), (0.0,24*3600), copy(pflat(u0)))
+sol = solve(prob, Tsit5(), tstops=[0,4,12,20,24]*3600)

Inspect the Solution

Inspecting the solution is all which is left to do.

xticks = ((0:4:24)*3600, string.(0:4:24)) # its nice to display hours
+fig = begin
+    _fig = Figure()
+    row = 1
+    ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="pressure [Pa]", title="Pressure at nodes", xticks)
+    xlims!(ax, sol.t[begin], sol.t[end])
+    ylims!(ax, 47.9e5, 49.9e5)
+    for i in 1:3
+        lines!(ax, sol, idxs=vidxs(nw, i, :p); label="v$i", color=Cycled(i))
+    end
+    axislegend(ax)
+    row += 1
+
+    ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="flow [m³/s]", title="Flow through pipes", xticks)
+    xlims!(ax, sol.t[begin], sol.t[end])
+    ylims!(ax, 16, 44)
+    for i in 1:2
+        lines!(ax, sol, idxs=eidxs(nw, i, :q̃); label="e$i flow", color=Cycled(i))
+    end
+    axislegend(ax, position=:rb)
+    row += 1
+    _fig
+end
Example block output

Notably, the "internal" states defined in the symbolic models are not "states" in the sense of the ODE. For example, we captured the load profile in the q̃_inj state of the VariablePressureNode. The only dynamic state of the model however is p. Using the "observables" mechanism from SciML, which is implemented by NetworkDynamics, we can reconstruct those "optimized" states which have been removed symbolicially. Here we plot the reconstructed load profile of nodes 2 and 3. Also, we know that node 1 is infinetly stiff, acting as an infinite source of volumetric flow. We can reconstruct this flow too.

fig = begin
+    _fig = Figure()
+    row = 1
+    ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="flow [m³/s]", title="Flow at nodes", xticks)
+    xlims!(ax, sol.t[begin], sol.t[end])
+    lines!(ax, sol, idxs=vidxs(nw, 1, :q̃_inj); label="v1 compensation", color=Cycled(1))
+    for i in 2:3
+        lines!(ax, sol, idxs=vidxs(nw, i, :q̃_inj); label="v$i load profile", color=Cycled(i))
+    end
+    axislegend(ax, position=:rc)
+    _fig
+end
Example block output

Lastly we want to observe two internal states of the pipes: the Reynolds number and the mean pressure. We see, that we're purely in the turbulent flow regime.

fig = begin
+    _fig = Figure()
+    row = 1
+    ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="Reynolds number", title="Reynolds number", xticks)
+    xlims!(ax, sol.t[begin], sol.t[end])
+    for i in 1:3
+        lines!(ax, sol, idxs=eidxs(nw, i, :Re); label="e $i", color=Cycled(i))
+    end
+    hlines!(ax, 2300, color=:black, linestyle=:dash, label="L/T transition")
+    axislegend(ax, position=:rb)
+    row += 1
+
+    ax = Axis(_fig[row, 1]; xlabel="time [h]", ylabel="Mean pressure [Pa]", title="Mean pressure in pipes", xticks)
+    xlims!(ax, sol.t[begin], sol.t[end])
+    for i in 1:3
+        lines!(ax, sol, idxs=eidxs(nw, i, :pM); label="e $i", color=Cycled(i))
+    end
+    axislegend(ax, position=:rb)
+    _fig
+end
Example block output

This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/getting_started_with_network_dynamics.jl b/previews/PR184/generated/getting_started_with_network_dynamics.jl new file mode 100644 index 00000000..0638fd69 --- /dev/null +++ b/previews/PR184/generated/getting_started_with_network_dynamics.jl @@ -0,0 +1,157 @@ +# # Network Diffusion +# +# This introductory example explains the use of the basic types and constructors +# in NetworkDynamics.jl by modeling a simple diffusion on an undirected network. +# +# +# ## Theoretical background +# +# Diffusion processes are relevant for phenomena as diverse as heat conduction, electrical currents, and random walks. Generally speaking they describe the tendency of systems to evolve towards a state of equally distributed heat, charge or concentration. In such system the local temperature (or concentration) changes according to its difference with its neighborhood, i.e. the temperature gradient. +# +# Let $g$ be a graph with $N$ nodes and adjacency matrix $A$. Let $v = (v_1, \dots, v_n)$ be a vector of (abstract) temperatures or concentrations at each node $i = 1, \dots, N$. Then the rate of change of state $v_i$ is described by its difference with its neighbors and we obtain the following ordinary differential equation +# +# ```math +# \dot v_i = \sum_{j=1}^N A_{ji} (v_j - v_i). +# ``` +# +# The sum on the right hand side plays the role of a (discrete) gradient. If the temperature at node $i$ is higher than at its neighboring node $j$ it will decrease along that edge. +# +# ## Modeling diffusion in NetworkDynamics.jl +# We begin by loading the necessary packages. + +using Graphs +using NetworkDynamics +using OrdinaryDiffEqTsit5 +using StableRNGs +using Plots +nothing #hide + +# From the above considerations we see that in this model the nodes do not have any internal dynamics - if a node was disconnected from the rest of the network its state would never change, since then $A_{ji} = 0 \; \forall j$ and hence $\dot v_i = 0$. This means that the evolution of a node depends only on the interaction with its neighbors. In NetworkDynamics.jl, interactions with neighbors are described by equations for the edges. +# +# In order to bring this equation into the form required by NetworkDynamics.jl we need split the dynamics into edge and vertex parts and bring them into the correct input-output formulation. +# The vertices have one internal state $v$ which is also the output. The input is +# the sum over all flows of connected edges. This directly correspons to the component model definition outlined in Mathematical Model: +# ```math +# \begin{aligned} +# \dot x^\mathrm{v} &= f^{\mathrm v}(u^{\mathrm v}, \sum_k^{\text{incident}} y^{\mathrm e}_k, p^{\mathrm v}, t) &&= \sum_k^\mathrm{incident} y^\mathrm{e}_k \\ +# y^\mathrm{v} &= g^{\mathrm v}(u^{\mathrm v}, \sum_k^{\text{incident}} y^{\mathrm e}_k, p^{\mathrm v}, t) &&= x^\mathrm{v} +# \end{aligned} +# ``` +# The edge dynamics on the other hand do not have any internal states. Thus we +# only define the output as the difference between the source and destination +# vertex: +# ```math +# \begin{aligned} +# y^{\mathrm e}_{\mathrm{dst}} &= g_\mathrm{dst}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t) &&= y^{\mathrm v}_{\mathrm{src}} - y^{\mathrm v}_{\mathrm{dst}}\\ +# y^{\mathrm e}_{\mathrm{src}} &= g_\mathrm{src}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t) &&= y^{\mathrm v}_{\mathrm{dst}} - y^{\mathrm v}_{\mathrm{src}} +# \end{aligned} +# ``` +# +# ### Definition of `EdgeModel` + +function diffusionedge_g!(e_dst, v_src, v_dst, p, t) + # e_dst, v_src, v_dst are arrays, hence we use the broadcasting operator + e_dst .= v_src .- v_dst + nothing +end + +# The function `diffusionedge_g!` takes as inputs the current state of the edge `e`, its source vertex `v_src`, its destination vertex `v_dst`, a vector of parameters `p` and the time `t`. In order to comply with the syntax of NetworkDynamics.jl we always have to define functions for edges with exactly these arguments, even though we do not need `p` and `t` for the diffusion example. +# +# `diffusionedge_g!` is called a **mutating** function, since it modifies (or *mutates*) one of its inputs, namely the edge state `e`. As a convention in Julia names of mutating functions end with an `!`. The use of mutating functions reduces allocations and thereby speeds up computations. After the function call the edge's output value `e` equals the difference between its source and its destination vertex (i.e. the discrete gradient along that edge). +# +# Notably, this function only models $g_\mathrm{dst}$. However we can wrap this single-sided output function in an `AntiSymmetric` output wrapper to construct the `EdgeModel`: + +nd_diffusion_edge = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow]) + +# ### Definition of `VertexModel` +# For undirected graphs, the `edgefunction!` specifies the coupling from a source- to a destination vertex. The contributions of the connected edges to a single vertex are "aggregated". Default aggregation is the summation of all incident edge states. The aggregated edge state is made available via the `esum` argument of the vertex function. + +function diffusionvertex_f!(dv, v, esum, p, t) + # dv, v and esum are arrays, hence we use the broadcasting operator . + dv .= esum + nothing +end + +# Just like above the input arguments `v, esum, p, t` are mandatory for the syntax of vertex functions. The additional input `dv` corresponding to the derivative of the vertex' state is mandatory for vertices described by ordinary differential equations. +# +# The output function `g` is just taking part of the internal states. For that we can use the `StateMask` helper function `g = StateMaks(1:1)` + +nd_diffusion_vertex = VertexModel(; f=diffusionvertex_f!, g=StateMask(1:1), dim=1) + +# ## Constructing the network +# +# With the components defined, we can define the topology and assemble the network dynamics. + +N = 20 # number of nodes +k = 4 # average degree +g = barabasi_albert(N, k) # a little more exciting than a bare random graph + +# The [Barabási–Albert model](https://en.wikipedia.org/wiki/Barab%C3%A1si%E2%80%93Albert_model) generates a scale-free random graph. + +nd = Network(g, nd_diffusion_vertex, nd_diffusion_edge) + +# The constructor `Network` combines the component model with the topological information contained in the graph **`g`** and returns an `Network` compatible with the solvers of `DifferentialEquations.jl`. + +rng = StableRNG(1) +x0 = randn(rng, N) # random initial conditions +ode_prob = ODEProblem(nd, x0, (0.0, 2.0)) +sol = solve(ode_prob, Tsit5()); + +# We are solving the diffusion problem on the time interval $[0, 2]$ with the `Tsit5()` algorithm, which is recommended by the authors of `DifferentialEquations.jl` for most non-stiff problems. + +plot(sol; idxs=vidxs(nd, :, :), fmt=:png) + +# The plotting is straightforward. The **`idxs`** keyword allows us to pass a list of indices. Indices can be also "symbolic" indices which specify components and their symbols directly. For example `idxs = VIndex(1, :v)` acesses state `:v` of vertex 1. See Symbolic Indexing for more details. +# +# In oder to collect multiple indices we can use the helper function `vidxs` and `eidxs`, which help to collect all symbolic indices matching a certain criteria. +# +# ## Two Dimensional Extension +# +# To illustrate a very simple multi-dimensional case, in the following we simulate two independent diffusions on an identical graph. The first uses the symbol `x` and is started with initial conditions drawn from the standard normal distribution $N(0,1)$, the second uses the symbol `ϕ` with squared standard normal inital conditions. +# +# The symbols have to be passed with the keyword **`sym`** to `VertexModel`. + +N = 10 # number of nodes +k = 4 # average degree +g = barabasi_albert(N, k) # a little more exciting than a bare random graph + +# We will have two independent diffusions on the network, hence dim = 2 +nd_diffusion_vertex_2 = VertexModel(; f=diffusionvertex_f!, g=1:2, dim=2, sym=[:x, :ϕ]) +nd_diffusion_edge_2 = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow_x, :flow_ϕ]) +nd_2 = Network(g, nd_diffusion_vertex_2, nd_diffusion_edge_2) + +x0_2 = vec(transpose([randn(rng, N) .^ 2 randn(rng, N)])) # x ~ N(0,1)^2; ϕ ~ N(0,1) +ode_prob_2 = ODEProblem(nd_2, x0_2, (0.0, 3.0)) +sol_2 = solve(ode_prob_2, Tsit5()); + +# Try plotting the variables ϕ_i yourself. [To write ϕ type \phi and press TAB] + +plot(sol_2; idxs=vidxs(nd_2, :, :x), fmt=:png) + +# Using the `eidxs` helper function we can also plot the flow variables + +plot(sol_2; idxs=eidxs(nd_2, :, :flow_x), fmt=:png) + +# ## Appendix: The network Laplacian $L$ +# +# The diffusion equation on a network can be rewritten as +# +# ```math +# \dot v_i = \sum_{j=1}^N A_{ji} v_j - d_i v_i = e_i^T A v - d_i v_i +# ``` +# +# where $d_i$ is the degree of node $i$ and $e_i^T$ is the $i$-th standard basis vector. Introducing the diagonal matrix $D$ that has the degree of node $i$ in its $i$-th row and the Laplacian matrix $L = D - A$ we arrive at +# +# ```math +# \dot v = e_i^T(A - D) v +# ``` +# +# and finally +# +# ```math +# \dot v = - L v +# ``` +# +# This is a linear system of ODEs and its solution is a matrix exponential. To study the asymptotic behaviour of the system it suffices to analyze the eigenspectrum of $L$. For this reason $L$ is an important construction in network science. + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/getting_started_with_network_dynamics/190ecac8.svg b/previews/PR184/generated/getting_started_with_network_dynamics/190ecac8.svg new file mode 100644 index 00000000..d81fc67f --- /dev/null +++ b/previews/PR184/generated/getting_started_with_network_dynamics/190ecac8.svg @@ -0,0 +1,88 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/getting_started_with_network_dynamics/6b3a5417.svg b/previews/PR184/generated/getting_started_with_network_dynamics/6b3a5417.svg new file mode 100644 index 00000000..43bd064b --- /dev/null +++ b/previews/PR184/generated/getting_started_with_network_dynamics/6b3a5417.svg @@ -0,0 +1,60 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/getting_started_with_network_dynamics/7d053527.svg b/previews/PR184/generated/getting_started_with_network_dynamics/7d053527.svg new file mode 100644 index 00000000..5ad60875 --- /dev/null +++ b/previews/PR184/generated/getting_started_with_network_dynamics/7d053527.svg @@ -0,0 +1,82 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/getting_started_with_network_dynamics/index.html b/previews/PR184/generated/getting_started_with_network_dynamics/index.html new file mode 100644 index 00000000..ffcff74a --- /dev/null +++ b/previews/PR184/generated/getting_started_with_network_dynamics/index.html @@ -0,0 +1,43 @@ + +Getting Started · NetworkDynamics

Network Diffusion

This introductory example explains the use of the basic types and constructors in NetworkDynamics.jl by modeling a simple diffusion on an undirected network.

This example can be dowloaded as a normal Julia script here.

Theoretical background

Diffusion processes are relevant for phenomena as diverse as heat conduction, electrical currents, and random walks. Generally speaking they describe the tendency of systems to evolve towards a state of equally distributed heat, charge or concentration. In such system the local temperature (or concentration) changes according to its difference with its neighborhood, i.e. the temperature gradient.

Let $g$ be a graph with $N$ nodes and adjacency matrix $A$. Let $v = (v_1, \dots, v_n)$ be a vector of (abstract) temperatures or concentrations at each node $i = 1, \dots, N$. Then the rate of change of state $v_i$ is described by its difference with its neighbors and we obtain the following ordinary differential equation

\[\dot v_i = \sum_{j=1}^N A_{ji} (v_j - v_i).\]

The sum on the right hand side plays the role of a (discrete) gradient. If the temperature at node $i$ is higher than at its neighboring node $j$ it will decrease along that edge.

Modeling diffusion in NetworkDynamics.jl

We begin by loading the necessary packages.

using Graphs
+using NetworkDynamics
+using OrdinaryDiffEqTsit5
+using StableRNGs
+using Plots

From the above considerations we see that in this model the nodes do not have any internal dynamics - if a node was disconnected from the rest of the network its state would never change, since then $A_{ji} = 0 \; \forall j$ and hence $\dot v_i = 0$. This means that the evolution of a node depends only on the interaction with its neighbors. In NetworkDynamics.jl, interactions with neighbors are described by equations for the edges.

In order to bring this equation into the form required by NetworkDynamics.jl we need split the dynamics into edge and vertex parts and bring them into the correct input-output formulation. The vertices have one internal state $v$ which is also the output. The input is the sum over all flows of connected edges. This directly correspons to the component model definition outlined in Mathematical Model:

\[\begin{aligned} +\dot x^\mathrm{v} &= f^{\mathrm v}(u^{\mathrm v}, \sum_k^{\text{incident}} y^{\mathrm e}_k, p^{\mathrm v}, t) &&= \sum_k^\mathrm{incident} y^\mathrm{e}_k \\ +y^\mathrm{v} &= g^{\mathrm v}(u^{\mathrm v}, \sum_k^{\text{incident}} y^{\mathrm e}_k, p^{\mathrm v}, t) &&= x^\mathrm{v} +\end{aligned}\]

The edge dynamics on the other hand do not have any internal states. Thus we only define the output as the difference between the source and destination vertex:

\[\begin{aligned} +y^{\mathrm e}_{\mathrm{dst}} &= g_\mathrm{dst}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t) &&= y^{\mathrm v}_{\mathrm{src}} - y^{\mathrm v}_{\mathrm{dst}}\\ +y^{\mathrm e}_{\mathrm{src}} &= g_\mathrm{src}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t) &&= y^{\mathrm v}_{\mathrm{dst}} - y^{\mathrm v}_{\mathrm{src}} +\end{aligned}\]

Definition of EdgeModel

function diffusionedge_g!(e_dst, v_src, v_dst, p, t)
+    # e_dst, v_src, v_dst are arrays, hence we use the broadcasting operator
+    e_dst .= v_src .- v_dst
+    nothing
+end

The function diffusionedge_g! takes as inputs the current state of the edge e, its source vertex v_src, its destination vertex v_dst, a vector of parameters p and the time t. In order to comply with the syntax of NetworkDynamics.jl we always have to define functions for edges with exactly these arguments, even though we do not need p and t for the diffusion example.

diffusionedge_g! is called a mutating function, since it modifies (or mutates) one of its inputs, namely the edge state e. As a convention in Julia names of mutating functions end with an !. The use of mutating functions reduces allocations and thereby speeds up computations. After the function call the edge's output value e equals the difference between its source and its destination vertex (i.e. the discrete gradient along that edge).

Notably, this function only models $g_\mathrm{dst}$. However we can wrap this single-sided output function in an AntiSymmetric output wrapper to construct the EdgeModel:

nd_diffusion_edge = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ └─ 1/1 outputs: src=[₋flow] dst=[flow]

Definition of VertexModel

For undirected graphs, the edgefunction! specifies the coupling from a source- to a destination vertex. The contributions of the connected edges to a single vertex are "aggregated". Default aggregation is the summation of all incident edge states. The aggregated edge state is made available via the esum argument of the vertex function.

function diffusionvertex_f!(dv, v, esum, p, t)
+    # dv, v and esum are arrays, hence we use the broadcasting operator .
+    dv .= esum
+    nothing
+end

Just like above the input arguments v, esum, p, t are mandatory for the syntax of vertex functions. The additional input dv corresponding to the derivative of the vertex' state is mandatory for vertices described by ordinary differential equations.

The output function g is just taking part of the internal states. For that we can use the StateMask helper function g = StateMaks(1:1)

nd_diffusion_vertex = VertexModel(; f=diffusionvertex_f!, g=StateMask(1:1), dim=1)
VertexModel :VertexM PureStateMap()
+ ├─ 1 state:  [s]
+ └─ 1 output: [s]

Constructing the network

With the components defined, we can define the topology and assemble the network dynamics.

N = 20 # number of nodes
+k = 4  # average degree
+g = barabasi_albert(N, k) # a little more exciting than a bare random graph

The Barabási–Albert model generates a scale-free random graph.

nd = Network(g, nd_diffusion_vertex, nd_diffusion_edge)
Network with 20 states and 0 parameters
+ ├─ 20 vertices (1 unique type)
+ └─ 64 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

The constructor Network combines the component model with the topological information contained in the graph g and returns an Network compatible with the solvers of DifferentialEquations.jl.

rng = StableRNG(1)
+x0 = randn(rng, N) # random initial conditions
+ode_prob = ODEProblem(nd, x0, (0.0, 2.0))
+sol = solve(ode_prob, Tsit5());

We are solving the diffusion problem on the time interval $[0, 2]$ with the Tsit5() algorithm, which is recommended by the authors of DifferentialEquations.jl for most non-stiff problems.

plot(sol; idxs=vidxs(nd, :, :), fmt=:png)
Example block output

The plotting is straightforward. The idxs keyword allows us to pass a list of indices. Indices can be also "symbolic" indices which specify components and their symbols directly. For example idxs = VIndex(1, :v) acesses state :v of vertex 1. See Symbolic Indexing for more details.

In oder to collect multiple indices we can use the helper function vidxs and eidxs, which help to collect all symbolic indices matching a certain criteria.

Two Dimensional Extension

To illustrate a very simple multi-dimensional case, in the following we simulate two independent diffusions on an identical graph. The first uses the symbol x and is started with initial conditions drawn from the standard normal distribution $N(0,1)$, the second uses the symbol ϕ with squared standard normal inital conditions.

The symbols have to be passed with the keyword sym to VertexModel.

N = 10 # number of nodes
+k = 4  # average degree
+g = barabasi_albert(N, k) # a little more exciting than a bare random graph
+
+# We will have two independent diffusions on the network, hence dim = 2
+nd_diffusion_vertex_2 = VertexModel(; f=diffusionvertex_f!, g=1:2, dim=2, sym=[:x, :ϕ])
+nd_diffusion_edge_2 = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow_x, :flow_ϕ])
+nd_2 = Network(g, nd_diffusion_vertex_2, nd_diffusion_edge_2)
+
+x0_2 = vec(transpose([randn(rng, N) .^ 2 randn(rng, N)])) # x ~ N(0,1)^2; ϕ ~ N(0,1)
+ode_prob_2 = ODEProblem(nd_2, x0_2, (0.0, 3.0))
+sol_2 = solve(ode_prob_2, Tsit5());

Try plotting the variables ϕ_i yourself. [To write ϕ type \phi and press TAB]

plot(sol_2; idxs=vidxs(nd_2, :, :x), fmt=:png)
Example block output

Using the eidxs helper function we can also plot the flow variables

plot(sol_2; idxs=eidxs(nd_2, :, :flow_x), fmt=:png)
Example block output

Appendix: The network Laplacian $L$

The diffusion equation on a network can be rewritten as

\[\dot v_i = \sum_{j=1}^N A_{ji} v_j - d_i v_i = e_i^T A v - d_i v_i\]

where $d_i$ is the degree of node $i$ and $e_i^T$ is the $i$-th standard basis vector. Introducing the diagonal matrix $D$ that has the degree of node $i$ in its $i$-th row and the Laplacian matrix $L = D - A$ we arrive at

\[\dot v = e_i^T(A - D) v\]

and finally

\[\dot v = - L v\]

This is a linear system of ODEs and its solution is a matrix exponential. To study the asymptotic behaviour of the system it suffices to analyze the eigenspectrum of $L$. For this reason $L$ is an important construction in network science.


This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/heterogeneous_system.jl b/previews/PR184/generated/heterogeneous_system.jl new file mode 100644 index 00000000..454e2a4b --- /dev/null +++ b/previews/PR184/generated/heterogeneous_system.jl @@ -0,0 +1,149 @@ +# # Modeling a heterogeneous system +# +# +# One of the main purposes of NetworkDynamics.jl is to facilitate +# modeling coupled systems with heterogenities. This means that +# components can differ in their parameters as well as in their dynamics. +# +# ## Heterogenous parameters +# +# We start by setting up a simple system of Kuramoto oscillators. + +using NetworkDynamics, OrdinaryDiffEqTsit5, Plots, Graphs + +N = 8 +g = watts_strogatz(N, 2, 0) # ring network + +function kuramoto_edge!(e, θ_s, θ_d, (K,), t) + e[1] = K * sin(θ_s[1] - θ_d[1]) + nothing +end +edge! = EdgeModel(g=AntiSymmetric(kuramoto_edge!), outdim=1, psym=[:K=>3]) + +function kuramoto_vertex!(dθ, θ, esum, (ω0,), t) + dθ[1] = ω0 + esum[1] + nothing +end +vertex! = VertexModel(f=kuramoto_vertex!, g=StateMask(1:1), sym=[:θ], psym=[:ω0], name=:kuramoto) + +nw = Network(g, vertex!, edge!) + +# To assign parameters, we can create a `NWParameter` object based on the `nw` definition. +# This parameter object will be pre-filled with the default parameters. + +p = NWParameter(nw) + +# To set the vertex parameters, we can use indexing of the `p.v` field: + +ω = collect(1:N) ./ N +ω .-= sum(ω) / N +p.v[:, :ω0] = ω + +# Here, the index pairing `:, :ω` is used to index state ω for all node indices. +# +# The parameter object contains information about the network structure. For the +# actual problem definition we need to throw away this wrapper and use the +# flat-vector representation of the parameters `pflat(p)`. Note that `pflat(p)` +# +# Similarily, we could use `NWState(nw)` to create an indexable wrapper of the +# initial state. However in this case we can also fill create the flat state +# array manually: + +x0 = collect(1:N) ./ N +x0 .-= sum(x0) ./ N +tspan = (0.0, 10.0) +prob = ODEProblem(nw, x0, tspan, pflat(p)) +sol = solve(prob, Tsit5()) +plot(sol; ylabel="θ", fmt=:png) + +# ## Heterogeneous dynamics +# +# Two paradigmatic modifications of the node model above are static nodes and nodes with +# inertia. +# A static node has no internal states and instead fixes the variable at a +# constant value. + +function static_g(out, u, p, t) + out[1] = p[1] + nothing +end +static! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], name=:static) + +# But wait! NetworkDynamics classified this as `PureFeedForward`, because it cannot +# distinguish between the function signatures +# ``` +# g(out, u, p, t) # PureFeedForward +# g(out, ins, p, t) # NoFeedForward +# ``` +# and since `dim(u)=0` it wrongfully assumes that the latter is meant. +# We can overwrite the classification by passing the ff keyword: + +static! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], ff=NoFeedForward(), name=:static) + +# A Kuramoto model with inertia consists of two internal variables leading to +# more complicated (and for many applications more realistic) local dynamics. + +function kuramoto_inertia!(dv, v, esum, (ω0,), t) + dv[1] = v[2] + dv[2] = ω0 - 1.0 * v[2] + esum[1] + nothing +end + +inertia! = VertexModel(f=kuramoto_inertia!, g=1:1, sym=[:θ, :ω], psym=[:ω0], name=:inertia) + +# Since now we model a system with heterogeneous node dynamics we can no longer +# straightforwardly pass a single VertexModel to the `Network` constructor but +# instead have to hand over an Array. + +vertex_array = VertexModel[vertex! for i in 1:N] +vertex_array[1] = static! +vertex_array[5] = inertia! # index should correspond to the node's index in the graph +nw_hetero! = Network(g, vertex_array, edge!) + +# Now we have to take a bit more care with defining initial conditions and parameters. +# +# First, we can generate a `NWState` object based on the `nw_hetero!` object which +# will be populated with the default values. + +state = NWState(nw_hetero!) + +# The node with inertia is two-dimensional, hence we need to specify two initial conditions. +# For the first dimension we keep the initial conditions from above and insert! another one into `x0` at +# the correct index. +# +# For the θ states we will use the same initial conditins as before: + +state.v[2:8,:θ] = x0[2:8] + +# We're still missing one initial condition: the second variable ω of the 5th vertex. + +state.v[5,:ω] = 5 + +# The `NWState` object also contains a parameter object accessible via `state.p`. +# The edge parameters are already filled with default values. +# The vertex parameters can be copied from our old parmeter object `p`. + +state.p.v[2:8, :ω0] = p.v[2:8, :ω0] + +# For the problem construction, we need to convert the nested stuctures to flat arrays using the `uflat` and `pflat` methods. + +prob_hetero = ODEProblem(nw_hetero!, uflat(state), tspan, pflat(state)) +sol_hetero = solve(prob_hetero, Tsit5()); +plot(sol_hetero) + +# For clarity we plot only the variables referring to the oscillator's angle θ and color +# them according to their type. + +colors = map(vertex_array) do vertexf + if vertexf.name == :kuramoto + colorant"lightseagreen" + elseif vertexf.name == :static + colorant"orange" + elseif vertexf.name == :inertia + colorant"darkred" + end +end + +plot(sol_hetero; ylabel="θ", idxs=vidxs(1:8,:θ), lc=colors', fmt=:png) + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/heterogeneous_system/022b6041.svg b/previews/PR184/generated/heterogeneous_system/022b6041.svg new file mode 100644 index 00000000..8fec107d --- /dev/null +++ b/previews/PR184/generated/heterogeneous_system/022b6041.svg @@ -0,0 +1,62 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/heterogeneous_system/5a435ac8.svg b/previews/PR184/generated/heterogeneous_system/5a435ac8.svg new file mode 100644 index 00000000..ba521c93 --- /dev/null +++ b/previews/PR184/generated/heterogeneous_system/5a435ac8.svg @@ -0,0 +1,62 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/heterogeneous_system/68c01707.svg b/previews/PR184/generated/heterogeneous_system/68c01707.svg new file mode 100644 index 00000000..ce3af32e --- /dev/null +++ b/previews/PR184/generated/heterogeneous_system/68c01707.svg @@ -0,0 +1,66 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/generated/heterogeneous_system/index.html b/previews/PR184/generated/heterogeneous_system/index.html new file mode 100644 index 00000000..62afcaeb --- /dev/null +++ b/previews/PR184/generated/heterogeneous_system/index.html @@ -0,0 +1,95 @@ + +Heterogeneous Systems · NetworkDynamics

Modeling a heterogeneous system

This example can be dowloaded as a normal Julia script here.

One of the main purposes of NetworkDynamics.jl is to facilitate modeling coupled systems with heterogenities. This means that components can differ in their parameters as well as in their dynamics.

Heterogenous parameters

We start by setting up a simple system of Kuramoto oscillators.

using NetworkDynamics, OrdinaryDiffEqTsit5, Plots, Graphs
+
+N = 8
+g = watts_strogatz(N, 2, 0) # ring network
+
+function kuramoto_edge!(e, θ_s, θ_d, (K,), t)
+    e[1] = K * sin(θ_s[1] - θ_d[1])
+    nothing
+end
+edge! = EdgeModel(g=AntiSymmetric(kuramoto_edge!), outdim=1, psym=[:K=>3])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[₋o] dst=[o]
+ └─   1 param:   [K=3]
function kuramoto_vertex!(dθ, θ, esum, (ω0,), t)
+    dθ[1] = ω0 + esum[1]
+    nothing
+end
+vertex! = VertexModel(f=kuramoto_vertex!, g=StateMask(1:1), sym=[:θ], psym=[:ω0], name=:kuramoto)
VertexModel :kuramoto PureStateMap()
+ ├─ 1 state:  [θ]
+ ├─ 1 output: [θ]
+ └─ 1 param:  [ω0]
nw = Network(g, vertex!, edge!)
Network with 8 states and 16 parameters
+ ├─ 8 vertices (1 unique type)
+ └─ 8 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

To assign parameters, we can create a NWParameter object based on the nw definition. This parameter object will be pre-filled with the default parameters.

p = NWParameter(nw)
Parameter{Vector{Float64}} of Network (8 vertices, 8 edges)
+  ├─ VPIndex(1, :ω0) => NaN
+  ├─ VPIndex(2, :ω0) => NaN
+  ├─ VPIndex(3, :ω0) => NaN
+  ├─ VPIndex(4, :ω0) => NaN
+  ├─ VPIndex(5, :ω0) => NaN
+  ├─ VPIndex(6, :ω0) => NaN
+  ├─ VPIndex(7, :ω0) => NaN
+  ├─ VPIndex(8, :ω0) => NaN
+  ├─ EPIndex(1, :K)  => 3.0
+  ├─ EPIndex(2, :K)  => 3.0
+  ├─ EPIndex(3, :K)  => 3.0
+  ├─ EPIndex(4, :K)  => 3.0
+  ├─ EPIndex(5, :K)  => 3.0
+  ├─ EPIndex(6, :K)  => 3.0
+  ├─ EPIndex(7, :K)  => 3.0
+  └─ EPIndex(8, :K)  => 3.0

To set the vertex parameters, we can use indexing of the p.v field:

ω = collect(1:N) ./ N
+ω .-= sum(ω) / N
+p.v[:, :ω0] = ω

Here, the index pairing :, :ω is used to index state ω for all node indices.

The parameter object contains information about the network structure. For the actual problem definition we need to throw away this wrapper and use the flat-vector representation of the parameters pflat(p). Note that pflat(p)

Similarily, we could use NWState(nw) to create an indexable wrapper of the initial state. However in this case we can also fill create the flat state array manually:

x0 = collect(1:N) ./ N
+x0 .-= sum(x0) ./ N
+tspan = (0.0, 10.0)
+prob = ODEProblem(nw, x0, tspan, pflat(p))
+sol = solve(prob, Tsit5())
+plot(sol; ylabel="θ", fmt=:png)
Example block output

Heterogeneous dynamics

Two paradigmatic modifications of the node model above are static nodes and nodes with inertia. A static node has no internal states and instead fixes the variable at a constant value.

function static_g(out, u, p, t)
+    out[1] = p[1]
+    nothing
+end
+static! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], name=:static)
VertexModel :static PureFeedForward()
+ ├─ 0 states: []
+ ├─ 1 output: [θ]
+ └─ 1 param:  [θfix=-0.4375]

But wait! NetworkDynamics classified this as PureFeedForward, because it cannot distinguish between the function signatures

g(out, u, p, t)    # PureFeedForward
+g(out, ins, p, t)  # NoFeedForward

and since dim(u)=0 it wrongfully assumes that the latter is meant. We can overwrite the classification by passing the ff keyword:

static! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], ff=NoFeedForward(), name=:static)
VertexModel :static NoFeedForward()
+ ├─ 0 states: []
+ ├─ 1 output: [θ]
+ └─ 1 param:  [θfix=-0.4375]

A Kuramoto model with inertia consists of two internal variables leading to more complicated (and for many applications more realistic) local dynamics.

function kuramoto_inertia!(dv, v, esum, (ω0,), t)
+    dv[1] = v[2]
+    dv[2] = ω0 - 1.0 * v[2] + esum[1]
+    nothing
+end
+
+inertia! = VertexModel(f=kuramoto_inertia!, g=1:1, sym=[:θ, :ω], psym=[:ω0], name=:inertia)
VertexModel :inertia PureStateMap()
+ ├─ 2 states: [θ, ω]
+ ├─ 1 output: [θ]
+ └─ 1 param:  [ω0]

Since now we model a system with heterogeneous node dynamics we can no longer straightforwardly pass a single VertexModel to the Network constructor but instead have to hand over an Array.

vertex_array    = VertexModel[vertex! for i in 1:N]
+vertex_array[1] = static!
+vertex_array[5] = inertia! # index should correspond to the node's index in the graph
+nw_hetero! = Network(g, vertex_array, edge!)
Network with 8 states and 16 parameters
+ ├─ 8 vertices (3 unique types)
+ └─ 8 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

Now we have to take a bit more care with defining initial conditions and parameters.

First, we can generate a NWState object based on the nw_hetero! object which will be populated with the default values.

state = NWState(nw_hetero!)
NWState{Vector{Float64}} of Network (8 vertices, 8 edges)
+  ├─ VIndex(2, :θ) => NaN
+  ├─ VIndex(3, :θ) => NaN
+  ├─ VIndex(4, :θ) => NaN
+  ├─ VIndex(6, :θ) => NaN
+  ├─ VIndex(7, :θ) => NaN
+  ├─ VIndex(8, :θ) => NaN
+  ├─ VIndex(5, :θ) => NaN
+  └─ VIndex(5, :ω) => NaN
+ p = NWParameter([-0.4375, NaN, NaN, NaN, NaN, NaN, NaN, NaN, 3.0, 3.0, 3.0, 3.0, 3.0, 3.0, 3.0, 3.0])
+ t = nothing

The node with inertia is two-dimensional, hence we need to specify two initial conditions. For the first dimension we keep the initial conditions from above and insert! another one into x0 at the correct index.

For the θ states we will use the same initial conditins as before:

state.v[2:8,:θ] = x0[2:8]

We're still missing one initial condition: the second variable ω of the 5th vertex.

state.v[5,:ω] = 5

The NWState object also contains a parameter object accessible via state.p. The edge parameters are already filled with default values. The vertex parameters can be copied from our old parmeter object p.

state.p.v[2:8, :ω0] = p.v[2:8, :ω0]

For the problem construction, we need to convert the nested stuctures to flat arrays using the uflat and pflat methods.

prob_hetero = ODEProblem(nw_hetero!, uflat(state), tspan, pflat(state))
+sol_hetero = solve(prob_hetero, Tsit5());
+plot(sol_hetero)
Example block output

For clarity we plot only the variables referring to the oscillator's angle θ and color them according to their type.

colors = map(vertex_array) do vertexf
+    if vertexf.name == :kuramoto
+        colorant"lightseagreen"
+    elseif vertexf.name == :static
+        colorant"orange"
+    elseif vertexf.name == :inertia
+        colorant"darkred"
+    end
+end
+
+plot(sol_hetero; ylabel="θ", idxs=vidxs(1:8,:θ), lc=colors', fmt=:png)
Example block output

This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/stress_on_truss.jl b/previews/PR184/generated/stress_on_truss.jl new file mode 100644 index 00000000..16428a87 --- /dev/null +++ b/previews/PR184/generated/stress_on_truss.jl @@ -0,0 +1,199 @@ +# # Stress on Truss +# In this exampe we'll simulate the time evolution of a truss structure consisting +# of joints and stiff springs. +# +# ![truss animation](truss.mp4) +# +# The mathematical model is quite simple: the vertices are point masses with +# positions $x$ and $y$ and velocities $v_x$ and $v_y$. +# For simplicity, we add some damping to the nodal motion based on the velocity. +# ```math +# \begin{aligned} +# \dot{x} &= v_x\\ +# \dot{y} &= v_y\\ +# \dot{v}_x &= \frac{1}{M}\left(\sum F_x - γ\,v_x\right)\\ +# \dot{v}_y &= \frac{1}{M}\left(\sum F_y - γ\,v_y\right) - g +# \end{aligned} +# ``` +# The vertices cannot absorb any torque, so the beams only exert forces in the direction of the beam. +# ```math +# |F| = K\cdot(L - |Δd|) +# ``` +# where $L$ is the nominal lenth and $|Δd|$ is the actual length of the beam. +# +# We start by loading the necessary packages. + +using NetworkDynamics +using OrdinaryDiffEqTsit5 +using Graphs +using GraphMakie +using LinearAlgebra: norm +using Printf +using CairoMakie +CairoMakie.activate!() + +# ## Definition of the dynamical system +# +# We need 3 models: +# - a fixed vertex which cannot change its position, +# - a free vertex which can move, and +# - a beam which connects two vertices. + +function fixed_g(pos, x, p, t) + pos .= p +end +vertex_fix = VertexModel(g=fixed_g, psym=[:xfix, :yfix], outsym=[:x, :y], ff=NoFeedForward()) + +# Here we need to specify the `ff` keyword manually, because NetworkDynamics cannot distinguish between +# `g(out, x, p, t)` (`NoFeedForwarwd`) and `g(out, in, p, t)` (`PureFeedForward()`) +# and guesses the latter when $\mathrm{dim}(x)=0$. + +function free_f(dx, x, Fsum, (M, γ, g), t) + v = view(x, 1:2) + dx[1:2] .= (Fsum .- γ .* v) ./ M + dx[2] -= g + dx[3:4] .= v + nothing +end +vertex_free = VertexModel(f=free_f, g=3:4, sym=[:vx=>0, :vy=>0, :x, :y], + psym=[:M=>10, :γ=>200, :g=>9.81], insym=[:Fx, :Fy]) + +# For the edge, we want to do something special. Later on, we want to color the edges according to the force they exert. +# Therefore, are interested in the absolut force rather than just the force vector. +# NetworkDynamics allows you to define so called `Observed` functions, which can recover additional states, +# so called observed, after the simulations. We can use this mechanis, to define a "recipe" for calculating the beam force +# based on the inputs (nodal positions) and the beam parameters. + +function edge_g!(F, pos_src, pos_dst, (K, L), t) + dx = pos_dst[1] - pos_src[1] + dy = pos_dst[2] - pos_src[2] + d = sqrt(dx^2 + dy^2) + Fabs = K * (L - d) + F[1] = Fabs * dx / d + F[2] = Fabs * dy / d + nothing +end +function observedf(obsout, u, pos_src, pos_dst, (K, L), t) + dx = pos_dst[1] .- pos_src[1] + dy = pos_dst[2] .- pos_src[2] + d = sqrt(dx^2 + dy^2) + obsout[1] = K * (L - d) + nothing +end +beam = EdgeModel(g=AntiSymmetric(edge_g!), psym=[:K=>0.5e6, :L], outsym=[:Fx, :Fy], obsf=observedf, obssym=[:Fabs]) + +# With the models define we can set up graph topology and initial positions. + +N = 5 +dx = 1.0 +shift = 0.2 +g = SimpleGraph(2*N + 1) +for i in 1:N + add_edge!(g, i, i+N); add_edge!(g, i, i+N) + if i < N + add_edge!(g, i+1, i+N); add_edge!(g, i, i+1); add_edge!(g, i+N, i+N+1) + end +end +add_edge!(g, 2N, 2N+1) +pos0 = zeros(Point2f, 2N + 1) +pos0[1:N] = [Point((i-1)dx,0) for i in 1:N] +pos0[N+1:2*N] = [Point(i*dx + shift, 1) for i in 1:N] +pos0[2N+1] = Point(N*dx + 1, -1) +fixed = [1,4] # set fixed vertices +nothing #hide + +# Now can collect the vertex models and construct the Network object. + +verts = VertexModel[vertex_free for i in 1:nv(g)] +for i in fixed + verts[i] = vertex_fix # use the fixed vertex for the fixed points +end +nw = Network(g, verts, beam) + +# In order to simulate the system we need to initialize the state and parameter vectors. +# Some states and parameters are shared between all vertices/edges. Those have been allready set +# in their constructors. The free symbols are +# - `x` and `y` for the position of the free vertices, +# - `xfix` and `yfix` for the position of the fixed vertices, +# - `L` for the nominal length of the beams. + +s = NWState(nw) +# set x/y and xfix/yfix +for i in eachindex(pos0, verts) + if i in fixed + s.p.v[i, :xfix] = pos0[i][1] + s.p.v[i, :yfix] = pos0[i][2] + else + s.v[i, :x] = pos0[i][1] + s.v[i, :y] = pos0[i][2] + end +end +# set L for edges +for (i,e) in enumerate(edges(g)) + s.p.e[i, :L] = norm(pos0[src(e)] - pos0[dst(e)]) +end +nothing #hide + +# Lastly there is a special vertex at the end of the truss which has a higher mass and reduced damping. + +s.p.v[11, :M] = 200 +s.p.v[11, :γ] = 100 +nothing #hide + +# No we have everything ready to build the ODEProblem and simulate the system. + +tspan = (0.0, 12.0) +prob = ODEProblem(nw, uflat(s), tspan, pflat(s)) +sol = solve(prob, Tsit5()) +nothing #hide + +# ## Plot the solution +# +# Plotting trajectories of points is kinda boring. So instead we're going to use +# [`GraphMakie.jl`](https://github.com/MakieOrg/GraphMakie.jl) to create a animation of the timeseries. + +fig = Figure(size=(1000,550)); +fig[1,1] = title = Label(fig, "Stress on truss", fontsize=30) +title.tellwidth = false + +fig[2,1] = ax = Axis(fig) +ax.aspect = DataAspect(); +hidespines!(ax); # no borders +hidedecorations!(ax); # no grid, axis, ... +limits!(ax, -0.1, pos0[end][1]+0.3, pos0[end][2]-0.5, 1.15) # axis limits to show full plot + +# get the maximum force during the simulation to get the color scale +# It is only possible to access `:Fabs` directly becaus we've define the observable function for it! +(fmin, fmax) = 0.3 .* extrema(Iterators.flatten(sol(sol.t, idxs=eidxs(nw, :, :Fabs)))) +p = graphplot!(ax, g; + edge_width = 4.0, + node_size = 3*sqrt.(try s.p.v[i, :M] catch; 10.0 end for i in 1:nv(g)), + nlabels = [i in fixed ? "Δ" : "" for i in 1:nv(g)], + nlabels_align = (:center,:top), + nlabels_fontsize = 30, + elabels = ["edge $i" for i in 1:ne(g)], + elabels_side = Dict(ne(g) => :right), + edge_color = [0.0 for i in 1:ne(g)], + edge_attr = (colorrange=(fmin,fmax), + colormap=:diverging_bkr_55_10_c35_n256)) + +# draw colorbar +fig[3,1] = cb = Colorbar(fig, get_edge_plot(p), label = "Axial force", vertical=false) + +T = tspan[2] +fps = 30 +trange = range(0.0, sol.t[end], length=Int(T * fps)) +record(fig, "truss.mp4", trange; framerate=fps) do t + title.text = @sprintf "Stress on truss (t = %.2f )" t + s_at_t = NWState(sol, t) + for i in eachindex(pos0) + p[:node_pos][][i] = (s_at_t.v[i, :x], s_at_t.v[i, :y]) + end + notify(p[:node_pos]) + load = s_at_t.e[:, :Fabs] + p.edge_color[] = load + p.elabels = [@sprintf("%.0f", l) for l in load] + fig +end + +# This file was generated using Literate.jl, https://github.com/fredrikekre/Literate.jl diff --git a/previews/PR184/generated/stress_on_truss/index.html b/previews/PR184/generated/stress_on_truss/index.html new file mode 100644 index 00000000..b987028f --- /dev/null +++ b/previews/PR184/generated/stress_on_truss/index.html @@ -0,0 +1,132 @@ + +Stress on Truss · NetworkDynamics

Stress on Truss

In this exampe we'll simulate the time evolution of a truss structure consisting of joints and stiff springs. This example can be dowloaded as a normal Julia script here.

The mathematical model is quite simple: the vertices are point masses with positions $x$ and $y$ and velocities $v_x$ and $v_y$. For simplicity, we add some damping to the nodal motion based on the velocity.

\[\begin{aligned} +\dot{x} &= v_x\\ +\dot{y} &= v_y\\ +\dot{v}_x &= \frac{1}{M}\left(\sum F_x - γ\,v_x\right)\\ +\dot{v}_y &= \frac{1}{M}\left(\sum F_y - γ\,v_y\right) - g +\end{aligned}\]

The vertices cannot absorb any torque, so the beams only exert forces in the direction of the beam.

\[|F| = K\cdot(L - |Δd|)\]

where $L$ is the nominal lenth and $|Δd|$ is the actual length of the beam.

We start by loading the necessary packages.

using NetworkDynamics
+using OrdinaryDiffEqTsit5
+using Graphs
+using GraphMakie
+using LinearAlgebra: norm
+using Printf
+using CairoMakie
+CairoMakie.activate!()

Definition of the dynamical system

We need 3 models:

  • a fixed vertex which cannot change its position,
  • a free vertex which can move, and
  • a beam which connects two vertices.
function fixed_g(pos, x, p, t)
+    pos .= p
+end
+vertex_fix = VertexModel(g=fixed_g, psym=[:xfix, :yfix], outsym=[:x, :y], ff=NoFeedForward())
VertexModel :StaticVertexM NoFeedForward()
+ ├─ 0 states:  []
+ ├─ 2 outputs: [x, y]
+ └─ 2 params:  [xfix, yfix]

Here we need to specify the ff keyword manually, because NetworkDynamics cannot distinguish between g(out, x, p, t) (NoFeedForwarwd) and g(out, in, p, t) (PureFeedForward()) and guesses the latter when $\mathrm{dim}(x)=0$.

function free_f(dx, x, Fsum, (M, γ, g), t)
+    v = view(x, 1:2)
+    dx[1:2] .= (Fsum .- γ .* v) ./ M
+    dx[2] -= g
+    dx[3:4] .= v
+    nothing
+end
+vertex_free = VertexModel(f=free_f, g=3:4, sym=[:vx=>0, :vy=>0, :x, :y],
+                             psym=[:M=>10, :γ=>200, :g=>9.81], insym=[:Fx, :Fy])
VertexModel :VertexM PureStateMap()
+ ├─ 2 inputs:  [Fx, Fy]
+ ├─ 4 states:  [vx=0, vy=0, x, y]
+ ├─ 2 outputs: [x, y]
+ └─ 3 params:  [M=10, γ=200, g=9.81]

For the edge, we want to do something special. Later on, we want to color the edges according to the force they exert. Therefore, are interested in the absolut force rather than just the force vector. NetworkDynamics allows you to define so called Observed functions, which can recover additional states, so called observed, after the simulations. We can use this mechanis, to define a "recipe" for calculating the beam force based on the inputs (nodal positions) and the beam parameters.

function edge_g!(F, pos_src, pos_dst, (K, L), t)
+    dx = pos_dst[1] - pos_src[1]
+    dy = pos_dst[2] - pos_src[2]
+    d = sqrt(dx^2 + dy^2)
+    Fabs = K * (L - d)
+    F[1] = Fabs * dx / d
+    F[2] = Fabs * dy / d
+    nothing
+end
+function observedf(obsout, u, pos_src, pos_dst, (K, L), t)
+    dx = pos_dst[1] .- pos_src[1]
+    dy = pos_dst[2] .- pos_src[2]
+    d = sqrt(dx^2 + dy^2)
+    obsout[1] = K * (L - d)
+    nothing
+end
+beam = EdgeModel(g=AntiSymmetric(edge_g!), psym=[:K=>0.5e6, :L], outsym=[:Fx, :Fy], obsf=observedf, obssym=[:Fabs])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 2/2 outputs: src=[₋Fx, ₋Fy] dst=[Fx, Fy]
+ └─   2 params:  [K=5e5, L]

With the models define we can set up graph topology and initial positions.

N = 5
+dx = 1.0
+shift = 0.2
+g = SimpleGraph(2*N + 1)
+for i in 1:N
+    add_edge!(g, i, i+N); add_edge!(g, i, i+N)
+    if i < N
+        add_edge!(g, i+1, i+N); add_edge!(g, i, i+1); add_edge!(g, i+N, i+N+1)
+    end
+end
+add_edge!(g, 2N, 2N+1)
+pos0 = zeros(Point2f, 2N + 1)
+pos0[1:N] = [Point((i-1)dx,0) for i in 1:N]
+pos0[N+1:2*N] = [Point(i*dx + shift, 1) for i in 1:N]
+pos0[2N+1] = Point(N*dx + 1, -1)
+fixed = [1,4] # set fixed vertices

Now can collect the vertex models and construct the Network object.

verts = VertexModel[vertex_free for i in 1:nv(g)]
+for i in fixed
+    verts[i] = vertex_fix # use the fixed vertex for the fixed points
+end
+nw = Network(g, verts, beam)
Network with 36 states and 67 parameters
+ ├─ 11 vertices (2 unique types)
+ └─ 18 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

In order to simulate the system we need to initialize the state and parameter vectors. Some states and parameters are shared between all vertices/edges. Those have been allready set in their constructors. The free symbols are

  • x and y for the position of the free vertices,
  • xfix and yfix for the position of the fixed vertices,
  • L for the nominal length of the beams.
s = NWState(nw)
+# set x/y and xfix/yfix
+for i in eachindex(pos0, verts)
+    if i in fixed
+        s.p.v[i, :xfix] = pos0[i][1]
+        s.p.v[i, :yfix] = pos0[i][2]
+    else
+        s.v[i, :x] = pos0[i][1]
+        s.v[i, :y] = pos0[i][2]
+    end
+end
+# set L for edges
+for (i,e) in enumerate(edges(g))
+    s.p.e[i, :L] = norm(pos0[src(e)] - pos0[dst(e)])
+end

Lastly there is a special vertex at the end of the truss which has a higher mass and reduced damping.

s.p.v[11, :M] = 200
+s.p.v[11, :γ] = 100

No we have everything ready to build the ODEProblem and simulate the system.

tspan = (0.0, 12.0)
+prob = ODEProblem(nw, uflat(s), tspan, pflat(s))
+sol  = solve(prob, Tsit5())

Plot the solution

Plotting trajectories of points is kinda boring. So instead we're going to use GraphMakie.jl to create a animation of the timeseries.

fig = Figure(size=(1000,550));
+fig[1,1] = title = Label(fig, "Stress on truss", fontsize=30)
+title.tellwidth = false
+
+fig[2,1] = ax = Axis(fig)
+ax.aspect = DataAspect();
+hidespines!(ax); # no borders
+hidedecorations!(ax); # no grid, axis, ...
+limits!(ax, -0.1, pos0[end][1]+0.3, pos0[end][2]-0.5, 1.15) # axis limits to show full plot
+
+# get the maximum force during the simulation to get the color scale
+# It is only possible to access `:Fabs` directly becaus we've define the observable function for it!
+(fmin, fmax) = 0.3 .* extrema(Iterators.flatten(sol(sol.t, idxs=eidxs(nw, :, :Fabs))))
+p = graphplot!(ax, g;
+               edge_width = 4.0,
+               node_size = 3*sqrt.(try s.p.v[i, :M] catch; 10.0 end for i in 1:nv(g)),
+               nlabels = [i in fixed ? "Δ" : "" for i in 1:nv(g)],
+               nlabels_align = (:center,:top),
+               nlabels_fontsize = 30,
+               elabels = ["edge $i" for i in 1:ne(g)],
+               elabels_side = Dict(ne(g)  => :right),
+               edge_color = [0.0 for i in 1:ne(g)],
+               edge_attr = (colorrange=(fmin,fmax),
+                          colormap=:diverging_bkr_55_10_c35_n256))
+
+# draw colorbar
+fig[3,1] = cb = Colorbar(fig, get_edge_plot(p), label = "Axial force", vertical=false)
+
+T = tspan[2]
+fps = 30
+trange = range(0.0, sol.t[end], length=Int(T * fps))
+record(fig, "truss.mp4", trange; framerate=fps) do t
+    title.text = @sprintf "Stress on truss (t = %.2f )" t
+    s_at_t = NWState(sol, t)
+    for i in eachindex(pos0)
+        p[:node_pos][][i] = (s_at_t.v[i, :x], s_at_t.v[i, :y])
+    end
+    notify(p[:node_pos])
+    load = s_at_t.e[:, :Fabs]
+    p.edge_color[] = load
+    p.elabels = [@sprintf("%.0f", l) for l in load]
+    fig
+end
"truss.mp4"

This page was generated using Literate.jl.

diff --git a/previews/PR184/generated/truss.mp4 b/previews/PR184/generated/truss.mp4 new file mode 100644 index 0000000000000000000000000000000000000000..42396010e68d9620594437fb8243b068f7182490 GIT binary patch literal 1579479 zcmYhh19T@%&@cRtZQHhOXJgy8ZQHhOI~ymPY;4=f#>UO_-tYa+J!hu7`d8?#syRJp zY8n6l5SqDoI#@c}+X4WJDD^5XP4f> z#n$FW#@@lj(%#OQo6y+M$k3RNiO|W^jE{}b#MH>f-q@OtiJOs|kL9$Hg(~nVKohJIvBeA zjE#RnB|N6^XeKN&M8Lt9g4J{CeFeFx7U+S2652_t<&6GMmpyfD%?vNUx5 zZxTx<(;vTB2;EIB%`IGvet7l{rgr+~_6|SX{|h?&s9KwP{@CVYW@G&SNPSyNyPqMU zv$3h2sj;gIA1mX3%XBjQFQiVU&K5uFPR9EGzq@=tnoh=i#!hC0wnjg3{m-qR0Uz^E zG6)_2bB2$Rp8bb(_|NeF^oAaM>|8&9vx}(%A1k4y!%vca9*CbD{>)|Q_>=$tvIz(P z03viuBSHWi-(Syx{mhg4#9b4PuP45=H8Z@2yiU52bse(+0LcGyscsmm(kK_c_uu|6 z$Q{s!_CmWfj8+g>d-9?8bk%6oNjeack|oKeOMJ0@!5~!){Ofn2s;V678#hR#|40{a zJ0o!mE*ikc6BVNc|C;v?KJ)DYjIR`x3@SBZo^_+LuW~%)jFPcnP zpJtsjK?SD}J*ei6PvUtjbA!28{S`1~b01IN^y8Z7#1S&Wr0JuZ|GSEFHCs(Odb5t} zO%fc9q5MHHnHL>|7!6Hwt>n=r`ZE!=4-}CnEXSVu&^04QIOKkp@TrC@U*3GjS$_vw z#tSMm3B5;zV%MAC^&R1tsouTX_$2VTw>-5l!XP{2?T0I8(eJ(K&EBg=8IO!rN?9%S z(P&8S0PtA~ZH%3CnolrmtMttwuJ?KFZryxKs}|=1i{Bwzp3;V}9##&@4Mct>!|RaP zMlI-GE&yLMu_N`k7gr5B92wilSzL}Neqgi`xR)8TZQNdYl7zo}Bn)YI?!P7uEl*3Q zu0_G|FZ~6fl`-^&%*Uy;)|?jT{mMSB61nHL=G>|}1MIySdPmkrDSmH^Dw8cdvUCOe z)8%d|K()^}z8RTpKf;?4J*EH6HtzcoKOHLfK%`B1$rY=omE!Uf| zFWEFXKwY&39RM_U%U0w)y(=6T4UZ3U#J~H0Hv(+PVFG{^75|9X5{n_p#|)^fqBhwj5o+3&O!auE?B!lzbf~+g zuXKcaxQHxN*fXW!YcJX*D3}iKOp4^nddF^ObRG$MH6WTDx!hf2o%0ZdizLirG&8tQ z5N=TaP~2L^0xrvBNoZ#amkOU4m|<{J)<`&MzUX`A6=(MbqrS0naj4A!+`l`+NXqZx z?QNH)XYC2b0Wt=@>(Tz2*J>D9)hw7}*t?%y7r(;|id&9Ldn8sp7vjYCYahhJsY>_P z&yN(qXC}H8+Q$v8Y<+XOX~lSa)vil}De2@RS^-?@eh(XKbeP>;1l9X<6P5m{=4Ez2 z$>VQ@OBS+ONTEPgL!!=b@;M@YNh*FdRE_Wh&uzbUPKR6h7NYchKt`A|CqmHboA%oS z+JEVUop1ud6%Y`HA&C(~4!%c^(X@2tk}gill|0PT*-~!X%>I|(IAm6iK4!YN16)*= z`_&Di+Ti*Ysg-{a+%L*PAGx9ZzN_rZ$3XrL548$g`J3WpT|O3Av#Yw!yG+Kls}8

rpJS+|=i;_0ih)amt|?2qfdXl9o#(F2$_LM^n0OBjn~{*_uff_}%V`9qYA$OJ|8 zA>S$WXhP5D=MwPD`1??v)(dx3^g>-+Mfbda7^LpblVwcX=+~!NlM^m9Ha$T5ucGUq zmHEo8<6$y>z^8hd&@k_#Bjh=LWAB!Vkkt_~5~WFDol&7o`~^_9R@3D-liB@lOYyk3 zokaz&*nYoDpHOeOV0^vgSSEJMTW_5u!o-d*T2;#Uc2N&5q=X(5e)VPm?a>$dH-w0h zq-;D$z|vNJLAvLx>4P@vM6F>(#5(8&Wa-#S61r6t*l6w32l!F8IG(qGe(p*~7^z;G zUT~^Rj}!A=@EwZ zh4RCq!?`C(KHgX>+6 zts0LkZ90b<{P!0D#J?7KXW?9fmYA*B)xuIY3b{k~N>T@-F3c!EgXk|I{Z|g1Y#Mr5*Uq;M?Go~d zJ%DOXQ7^tIERk(WL)0|%TQ|_Y7xKz6`jE<(W|;h3+El<*xmDRG;?o3#JwvWu%l6dX z@{Jt{guwk};Gpz5AX(~z4p7xD=8zTuDu)tWtQ^{1L}N)A99D)r+?4ee5Be>4<+;*0 z2F?K)o0Es3WQtcN>|G=AZjHJhGxp4^ZAJdx`^lNG+P+MzWkPW-^zxY*xqX*^>Cnxb zXNf41>@mj^W_h6;Y>;s2!Mf2?evl(H?vR`$HRPStl3otoE7Z&dRDRTLwks`kcoAMM zu4u>=KrSbD>4S=HCG?xRz_)_9n+Lx4U3)`NfakLZCBmEK97lW_TXnqgsHyrSQ44;M zs5&>?_8DM*Ny}#Q?;E zv&B_;AHqaQ@b-9Nxj@KX;Q-m`@DUnw;H7usD0MONS)LSqN@kO+-;{nm%M_0GCZtAUg$BF*3)m zS$+$-_g3IZX*94Av5oc|>mu)yVMzyW2$=V^8x}j`&F`}^Jbm$grYem7QYDdRsv1|g z7Kky=7q?jTOx{##`58i_1P*;WG;saM3*jWWH0Mrl!eB@0=U%MKh zhi*jNuSmaZO22;nCM~rNRq|#9GkuVZ^p}a5f4sI%$rSm5^Yt-zKsC|KqM^`?5SUc)tO1|$+&5^rdY^~c`zKJ@oeTh8ismm>@^>sC15$Ozr_W%C= zU5=l(){U7=!VEgy32LST+8mZ_RTU9gZo&Hn<6p!(B2R*Cte*-_QN8`5WN*yXY8uG{ z>AYX*!FMs%$h&B2tAT#PR7nb0vU`ZdwxlBG`ZdDZ>kB*op7Q{$PGEZNl2B*M`29Wj ziWKllFXtY!J~&GrWU*j!ClVYcBh84s7Wx1W6?IwSh(i3h&`*AFeWD&+C3AD-$UV1# z*fmC zZ!SmaF-u?u5jw}!;KZ$mq^oin6VsDq-N8viv&6D>3sdOQ_w8R zoJsZmxXD11l4%`lYF{JafW8@{HsuZdE_KSM85deeoz544$@4EWSYg@?DzWuz!VRvH zV>VaunPRk$QWhIh^bZPm^i$o}>eSX>Qz#tw7FnvN+4PI9z{3E;y?pdZHoto_=r$iJ zpSghwd zeCPD)MyToJ*MExSQ~SEysgZLXiz=C`VWcM8i5oi>$qSM%XFP*1RP&;(=WE|JFin4z zvAoIb^6ddpstVsLa+e`#vjYv`*Udn4eeJ~*wbE?AYti?CndnW-cN=DOgW)A7+t+-P zRum*-&Fc5DSTD~@X*zJ9m!XI1)z@q8>4#>d?k3wh3Jbn7{;5xu{GC? zSzFxP&)#m%YwD63bOiW+H4qxZxB~2&NY&gxn8{q_BpZ}YX9#bPn8TK`3aOXo=fIvi zJi=no(ECL${9jG9pBXKz3bAaQxzM$S1`Eq!hLST}?Rui^_J`Ui1&!^FuZ>8H_(q?0 zEO!#>+JTqWK%of|iKe459_E%Fp4tVTpp^Owvz#O>z{jk>PT`;S=!ZgzeVy^^;=y3uwW5EvSO}* zaut%QmK}Ww`FU9-1RBlMrLbJJ7Y$;I6D#aL{Cl`D$$31+EqNem8kq=vbKrvHwk?3} zqeL<%*_?Zv3o_qa3OUWAayeTNWE#*shUk@ zHR+|g0-4(yab`E-1k%CYkE1Y6B7&t-skqtRYU9w3 z<}*p)y;X=90qX}7yxyw->C7cnK+_8NEBR+gYB!^w6Hajn2mY~fgnuzRwtz;~AkdX_ z!BI*3ZA~Vt)lqWd2;Aw_cm2bEbN1}nAWm%-p8o|$MR19N=%4NW3voj!k7kGFodw2K z*q-D8#!P)yaj>}+*%A3QLw7oK6?kklQQ?vz$Hxnv>bHYgiMHgGL=c7Ng=%rA;E9sU z;Gb$OBUCE)Y%*N@W{%-{^U#jcpw|*}|3RLqwKh93U`~p_{e?cC1Ret-?CLts)K=_q ztYbS26%%g#8@r&blKOxD^QjN@i!sf7;Z2#FcNR%~&rdi*-KSPt1;~ncoqm{@yOP1> zw00Whm|k;hn6!dnZ>a4257U*le+=$Kj(q~);I*Nd8JbYt!wR#|DgsWHFl)pPJ~j*o72_~c?@AT$Oj9GDzXS)i7wW>>b-4@ ziSVZTQ-~}S6);$e!FR=5umr^0PwH+~m8lwclp5Un3Pxn#pgkFUvr{R7W0_ihl=he@ zZJ5O}5upz9V$yQdH(n))Xb_9=HG&vzOoW3T1CgS0z6GBE13H;cghym*>8=rreqs45 z&mgZZHXtoQ6iY2sMBx2qtRp~bgSuhuI~2@{_J1^ahDOMGKtGr0u8l(xth~nn<>_p~ zm`lKKj53xXZH!)c;q|5Qj&M(xpV|=dfYa$*pL}1x>C&qdO>B60P$)yRu7zy^3|t`@1MJjjv_?{ zIB532l!ocutz&)Z1%S|{e|6U3S?)6IpO(i}eKv?eyef{nlc;aI3L{^2w;KtlW_z)r z`FW9rEC^xw*?xrq?-0m+KyfnE& z*I=dH9UiDOM$fB8Ka{p&BMTk%GxuA7e(Eu8f8VnO(u72xil1Q-H1s95f2U_u7|i;o zJFiVvwf+AywkD!hx!5GwL_2=)7lg`j{_`_j+-ydl9lee@Uy3fxM?_i`mkb(0IRLoExBAS4i*gcsQ`$%U6;)W+XyN{RG`Qd@3Yas>_$&I?wW~G0Yz|NsI;l~jUTBV zilj{QwZE_ZI-Y8}BSMs1$8{d+&ymqUVJ1LVq;Jg_Dzz>x#X+Td_U~xNdIdx3mN$9C zNi(7%8L+oNvEoD52*IF`?x^M1g#M$XS328(>JzbZ2FaSp#13%<)sb_5h-2ZGV>Y2S zWKe7ev{C41cZJ^JGx8|!9WY{bsE86F#^0!Cy58SLUm)s2Y$G75#MU^6C?Bb~{d8VP zZ)&jwcY;dTNdq}S1lavOKwF$fMrulo$&mQ?#aj?J1}yJO*!*(c9XJrcM=e+PoNoF4 zvv&nHBD^P(M~Cg?d}sG5l1ZTPHzXPpfyN8u%>< zH*@HDqsRGonY|ype%TEzGF>ly-GrPeDs6@H35`|q8O^#ZTB0>VeS; zZM;rf{+gi-5q5og5kr1etJD^Vs5!5|sAjks=|Y3R8&Tr25_ZkV zJ#mf(YdVq2xbNKcEYVDc^jNp|!4eBMG63XF9hWdBo)JHbs2C=Ze#h~}3}sC)WG zQGC&%uH6gGx;+Wiwo_;v3HK)zz|78G9#{;e;8mn{)wK;eJ6PN} zs9Nn|K!0F#D7I8j#+tmntO9D=|35F)Jd^N%r+{%*)gk45OP)lSk+f81yqIzxR3x0+ zDtQ0-1`Hx)4vH#-+a3VV#r~;4&~+L>-}zA;Y;#0XAuG+?Fo@2vX@8+ z9t>?Xxqf&a6WLgsyET{qyejhlt<(R%ReTVjut3;Tv)hSY^$6825a>U*XZB2+MM!O_ z)Y;Z~ocyQbZAiANFjBMu+#Vce^n)ovkO6$yuJGVmWg57LZdr`A9RM5WT4f$ zhDWM^{Go(Sd!$WjdHFP7TTc>Ljvq7go}<20TyY;EWsjK*7#I_5N25CbL8T2DE=>hIp?!{kJm^%hYy>jrE3DfnR!XVJ?fng^s zuiPC-ACzRS3ecC<#$XXuS2Od4Ty#Zx2}wumG&Mh z>^SSc-$voc6o(=l^D+0L;i3fCtP8YduW6CfQONX4pSQ^ZYnojm!)=LCtwl&oa<0U7r`8}mwg8}cz>M>!> zyj+kWie41Rw(q4YES9*4gea6navj4HGkz8Ps4voeuZ8Q_4J29-fn-X5lR|UCNA_wY zk>oSM?+~D*$owLXJ}s#OXzO6;?{>bQot2mo9l_i68i7%6NI!%2Mn^+sa45|2U<3^8 z(!9!t5AcpGzh+cqTyI<`-65Bk3%r9554uC^>uaB8;<~j%4tU0NHdLS}1O^r8#A~={>UnDh}^Rr}86*6)q(xTrC8SdaVX_*$vT6#*%o=4G6 z0X6gMfDxzaW3w3l=gIL5f(o}2^P9ucRl^`Lh3_y?$oCW1f0w%qz(YbO@{2za*02Ny zW0v1za<~D&Wqn^YU=yGm{G7qaQJKO-f8lTeFGMY)Yrvg5m~%r+5)lWG|L)I$ZRe;X zJzk$3Ykej&KG7hFyw>3EWggB%9UWQEM?l<{Ejw)T)x?l<-GIpt56f^|A!gM}_3QI@ z3--j}<;guWhN5Kof?|e0{o~ZJ+ef}ygO)$oiNjab^M|3+(i^^Qst^*QYO4y#yfXFe zlNI(|B;!MT6+KAmkG#T&2=3?n-o`4%M07i%4gj(f*Jh+nlcM2WL!{z#6l`eK*qfiB zHpG4c&q>u1eZuFwkMDqsumH>U{FBFg2@m7NE@NViX-0gt7|nK52deOpS*kQads6-I zt*zSRJ7G>}tl?H5sUemB+Er(xta~fo$bEWXCy*q#$(AKQv?HJ61^{fdFfG3bb2oyJ zUd}R5m8_%BDy-XupH@K;*iQr%KG4!5q9d8xuZ<;`xNND!Y`(Frq|?s8&s+-x_p4dv zRNQyPAF_d7Cm$N>x>p|2x{>*pAj@HsRbT>?np2r9=OPj)l()QsKyN2PqZ?$O~EKLX!XRiJ} z1W4$06#%Mr8Ye>3Vi11vjE)IwZRD$0Se?c~Jw2uYsc>*1vN%g{wBId`*Na#(<<6K^ z)^zpbnH$ zbPr1D_^!C^1hj2vq8&zVGZ11~5FA82+23Bmc~&7?86jGHQXTHRj8Nu)sMKK~8bkPs z{aA0pG)4=?rJ<9(CO4wOH!{Utq|CM<7?_u#k@px0P1QO{;+_LAEj?q`yiic+0EJ!pha^?p34fEQsE$Ynm)=o*8~8oFA~(Or;|)CKS}KIBz9x z@o)`yVLktHJuQi&s%m)3`FDbk0ko}pP1;9Ye9nK>d$|of8qdvN6upuEZ?S~lzatRD zOlehR87E0rO$3=QWHOAfS;OS27Lnfw={%(7mdM|J+VEAmbk(s%*h|SoTGlMtm~?ZN zq8cY_5k}HHoO}tDS`jQl6Ylq+{*Yk+pZ~2C?q$7goq*>KuOL;*xy$%#@E!_Am|wb6 z*e#<8Fa#XQtM-sp=~|T+aW&?@7EN!EJk>Pi6sRM~V=vWN5wRJoNf;iCRiYQXe2G|w zxeKB|JE>I_(cKkJ~Mz zs60M;7LO85lZ#e%yZXi%g^N|$%nd~5N^sO+zJmhjvtHE<@#Bi&e7~<*$G5))k~%JY7u&@$fIh_hG>Sz;?gygwQ^3fLj0%l2S>elwT^ygMapq45!YI zn~q_?{eyc<*La8jWSpbuvR8C)ro%hoU63!?1D34gO+p(oZs=@1#B+8~UhJj+zo7Bo=qZUL02uC{0uk?7Ec6Njbm#ZRPK8T)xQCjL}S zoX}>gAa`~+t^VHBES->78Z@J}Sw({70|Q6Iwe7ZA6rDb@kdtn{e6(9+3IK@C5_Y_e z0o7f}vt&yZxz=82tb?x=4>1g*bkMBS{RNB+eiev2ua2pJ%kqLZKNFGdj58XaG|F4Z+T9%SRRsik?$WbcV4Q z#kjJY$`H!-zQyj3KL2rB#*r^1ZBCC~*FT-fwNm##i&w=-#l%`O|101GaxDuBH3nBh zf{s27@TdF8N2&B-gyu62j{2p%+Chr$Q!8iRr&e?TDniq)hQgQ3-cqCx8|XqiGCC>$ zax4|3DwdA&Ji81Y3j*d0x*rp{mrX5bi2*$ZE1|WngI&iJG%+bD()DehTON53H}dh3 zCSkZBBYIv)@1ZkTEvDhknOk3VxlWmljORYr=kQ2GsNR*OZ_T9VP(i>WZ6cXPX6aXp z0H#-rAlVB0+oDb?1p}%))e9xEP-4pKqClHtQ}{-exu#rE+c%U#n%$OoYysY7jc$@M z1R-uSNI6V%*OOMDCDUxtRf49SC7-TZ_81L;Isit|>8yj!#Cffp-R9wqz4L?0e4;>seg>oG$muIPAbTB2Y$|qUeMjfULnnP zj-M^0L^suzCzoPu{3CuRj;e9K z5!X3LJ|u#fUNLvnRs5lt;-;G%?`Y<0mJpY$BxSYfSTZ)OH3 z?(q6Wi@;y!`nj^X3#bzYt|h>L=0)7~7!aSmLY#;5cWD(e@vERVx#TgJSMpl#<3e40 zutYI!KlzMKNymvih}gAKqORt#qo%s=M{pO>CK~eJ%uBWhQGi}216 z&k8cd0TVKSj=Cywo`)CV$&-nM)nwK`#f3xv(4T4UXSHxl@uMj@2y+jEJ5d^;wWf+F z4sa9=Pbw%IUOl3NY_OtrwP08)KrJ;*JZm4XA zN6r>4S0R-l!$)B6?0?u+8Xx-kSS&m&W|aUmUGtpdea;vmVxy(aawq(}$M z2tDQK%EWBo=NZSBqPXupH+m9>wcW&QDewL>FVC&O_#$Redo<6_IMpv zV_b@WXK>J(jeI4NLA3oEko2?ORq6sti@HU^@p9GJzdQA)L=Lq%0H>U@wieXzMdS7k znzb|KoIs*3w#M+l&k#GI-(a)FKc`4-EYio^{1u0wzTlgKzZh(be>O`Tij9Vn?M-Z! zXvn&M!3B+_nTtD<+O^V0L5&TnTou}#5%~}2Llgid3bk;ZLq>t)B^%dZFTnXkHkp^p zflVqB^hbGsZJ|kwI85M}fkxWGG^iU_j~DgsT7+eYf_D70ayN7(>fgKBEgMZbUB!aY zQH?n)!%~fzyBT#KMv1HenE&+rJt77|0a;*R?bEn73`#Q!9vj=hh<9Th zWCU=Rlesl+gT7TDoWV=mqo5r5X)SAMJzCWKV$nbIfeZR)l!^jCEjLKk;)|tk_b&22 z_h$ZvAA~~wgX$(ZNh+<&mTaP(Lh`n_(F$c3xQZsvXEJtpjQjHEtq= z@(pmDSK|dSxaWnfwsz7T4%y7lc1w!-PA{2 z{G`V%2xkLLq>*DEd_~;4qpGIfiRMuyDAS#R6E-jDE0@spRuX^PC{_)wZrXAkXMi)gW7UaF^z-`d5(2ChIYPU(8G+&vb-kLTi3R}E>+;$Z*$-pfB;5$>R!C)SA6$!$911yOx2d6VF)bVx|JHV{{ z3`L_`G_YGowjwZ)vu*0|NaCK$dR$G0*eYnaq7VCo=HEx$EYon-%O=P3U!>b|>b=<{ zV5kz;<$*D3(ozA5ol)&13sGjn_Cv!rV(Hk&oz7WK>8_oOo!1i)2&xf7#l2kfJDy;r z@yB(`pn`~8w=}@In|NP4TG4%>)uQ@vm)yl-#i~f)hU{&jh<)J=L-z29ODnaURZj^Z zvLSYd*!n=!`Fxf!MWo!Lps; zspLF$7Hm21U5@QQk_J#-bc|lo>}8k~g)>~AXKWKWCVh~|hh5d;&io!K7_`g4M*%iN zqKYlFIz;i1wtTOtL^aaf7XZz;*n4F?12uerAKaP>0cJ;3tMkth)_5G~yA*?1R{Ujb z2zz{7(dFEkkykM_fgx6q$|Z4{*p*4}09mWyiL*gXraX@9-On|GY_Ch0sLMPS!LwJM zMOh`U_3UkR-zrgdbZkEd?lh&?Sd+%g3w@F4n6V_m`@m~nMHEmB9UOlGQ+8|l9AC_i z0RqttgwN_zYx-a<%+yn}3&_hBerNh#Rce>u6JT%z8G^gaf>OnP3hj;MtvPR+5AW7V zNV-mW!$D>v?Pl7-bQbAEgXd0RetJQ#l_UN{lOaPDCVVqKoeYwLA!QE@<0`wjZoLi2 z1zp4MLh*1v^c3<-xXnRLo|ntg@k^npQ@0}Nd zb3q^8=AzOuk#SJoEtcbVICTuUhPz<>qp$r9R@!eaPwugNCX8-ytpt1$lNt^vd#iwx zDMiNVKt!G48$+O>4_1`yhvmW_8Z z1+x2^*Sk*GDkjnr*teX>Jdv2@x5U%at)C~zNDVjOaUX=M zS0=jVj6Lsf2-oPKNg$A$V*7{l1)eDb?$U{b*EL*(ZHDlU5RDI5&j0AYmN8HEFA)w} zbJTb|ylL^T^!8g= zO)@d2)N^xkDAKS=nlzUo0*VyucB&0I|3%>C2ToV9=hA%>r0|TcM)zhb=PrA^#S?A8 zpeY@H^y1wP<$oehRTGBVsiDqn`2@KE*|=5~K$1Ay1iYzT9t)Q+!IP8!)WL^BG-NyR z`YkgHJKviQ5KOl-TUh#=z48cS|%Ty=SR2HUV7(UrNeAB-6nn}pEF6KrSi>1nON)#* zch(TbUV@DkOk-24$_O9b1HCEN#e@VoGTPG!`xqwR4Jf*+^;RbC*Y`RAeNTLWVd-U) zQ~h%f-$MD@$_H`+mZdXVi5p?vcantrF`CLpc30ywif&_!svrP(x@U=^PP}C(cf?4uh&{x>>8eOLKe*J!^u@GP(Ve9 zG)=szdkkx6mH$j4cRk7?BAsA)*>f}XNR`tIk#wJ(eV0MCwNp;JQ1{dJ?wrDB_1 z!y@=e=p^U7!rIJ!ncG{s_1;Tg+fV@aArj42VMXZ$o6r!?oVIr%TH|x4@(A@U@H!U; zmO-*#D+W1!cpXR3^QZWKk#*Z_be!8?gz*KVGO!tMzTprIlSzXcy}jjJnl#7#O|v%5 z1(M+TZ#BsnP3tqBaQ^ACi0;q|UrSNDcTQFgCW(^b&w_}#up+ulf3Mou_&GeqN&td+ z8ak9OWN~X&Pmc>`X%BcwoiOXrlZn9s20@rPXLvx$^{#@Ky``AMaJ{HiVuQ9>B+i-?3o z41zKjJw0BsV^naih+{Fv9|3^qy|-PKVq{d$iYUGO4M5h&1GL?2bZ%giJ^R~CM-Urq z-ErV)fpl*#K~0;lyxhb+PJzf+v_5y0d7FZ|M#Pt4oh8I@=3(K zcBVJW#>wEd^dBu9V%mQfCW*Q7a!P1TK;*uZe1E-_bz##qA!79P5VaT8 z7JB5VvpX9jtgl#1;a;8*>IxN2yz)$Z(G%wLI8w=HQNtz1Q{2etd@i}IyVe^e6{1=d z!toB5Vlr4R&7EAE6b#nGZA)ON1C=ulXDu6G08)i z2i(!WgQ4%t(w|26_x$S=Kcu=)Xu??w&OdZ&`^zqsSzQqKUO_}Zi6gF+qa>en7$8NLY*oh4_=VR2^qKA6I`F=iip#62b%sCoOTNfR?)?pc zF|l*Ih)7!~EMRXW61ob&$|WTCH$?RnlZTfNBvImVmV&J+%ahDs6v0w}QLdQP6W&(m z%bIfZ=kP~r_@JW4_jBKi@;4W2Sx%dXuo~R z9y|*7@c_y_wrK6u+H{1;A_TG)$qoO_+d7N>0}u-`U069L+nvc*3%O1HxVdvXaF%<- z3r`_>2XV>3`@~X<^^L?m5~T>xQM$cEv3dQw8Lfev`cdxVrr?MnF<(+o0$qN-D=VReS!zRBH^MB`Q1DU<3ecWd*h8CLSXhc}PI)IbcqCGmlqeyG&i>xBDNi7b;$ujZVFDJr1@uRdIdXRQWYMzs*byb=2@T zOfei5r^pV;N~`^t@evyk`sgP-=v5E^dfz?<|Kk6(` z5AI`M`;QD_ds>DI%}+q?asp;S@OYEgv?2{NYqJc9 za1N&I)V&xMG$)=!)#VFIIC?=sug;HQda2}CBXiH1eQ-4J2L1IjXFjd5*Mr{1SXBTp$30*C<395@rVGMD zBQgS)OZ^+^Vqj;8PRTZ`>q2tlyAaks$)ghZr^GI;?6}U4(tb56%OK@iMEP=7u#+k( zFZvucb>S+oSOkQqb#s+tQp+{II_S5P3YB?;3?xt5Ft|_j^IV8#po+Avk{|MY{e0U> zfz1{pmI1OQR}71>?(G$=&T{|)6y*7aX;W}B&m5zqlZFTj7>^!+br zNmT$&gl2TgJ8IMjxDY|bS45(h`J|M1-p0n|`9AYliL}-xJ**L2UK2oOFhJ{Xv=C}} zmILC_VilSG>Y{M9CJEtek zp6f~uqAMIr7mh8iu--T`02X)AwRul6Rzsp|$OX4>V4z<3ECF7bof^R|1$dKcP?X$k z7z2Sy1(SgeMQ`Kd^&b*(G)yJf%!x8q@zI(S8dv}Iz>IGQC%%S1W;F5^OJ)t!ngLOV zT3o_kJk^Pf(UJ~@#WpPpRHXtXQd${^ZaqI4#zJ_3gR)}czrla7pqClXJyx1biY5<5 zyy(liYOz}NSrDB35s;0e;NqBY@hp?N)^?QmQF>$(t@(>v>W;uPHL_Uhe||y&vmi-S zu2}A6wTpFrfy7d`xa+6IQlSBOZlek>P51|s3oJL30K=$@cLr&VVb$bbccg<*?!Wu_ zO?}rDrPjWrX0I&jYnML25#(bN7}d9J1<6nA19PDwcE`2HnaB+A))5@HwG_F9gk_3E z9u6>vh1q%OkG?w^iA5$Hihpl;Z%hW5mXpDrtQ11We@rvLK*peT3a^%0jfE_-ihWnE zIuNIh!t-u!-~74(wQOCD0O91YM;XZ-s(fSDZO{v9WyB-K zx8o8gc9EkBZ~+~x$gE>QRM`lyRTf%uDJpKCMYfVZc^;m(RE&fb3h`V<)@31;=}1eq zgO{Gc{WZB1jp!l{v6c7C3=6MA??b9+JEPN&R5(ozVJ`n z({;2}kj4AixV+kmB7cLNR^=KvK+d0mmjljQ*IA3jkyJu_VJG~Ci&1ARdamP@Dd?R+ zmEkkpW(pBaUlChg?~mE|3;rTjpU9kH^ObmLbF3>w(j%hQsZ)tDkx-KkU`*{9N}$Uv9s`kB#yEJ(p|!Sw?^ z6p7bblp{0=_}~$5^#$WO^#Uw58QD);|u+R>6Il01Y(QIbD##H7+NgqSsKQybHDH`5&Xx^t9O^WOW1u_ zKc%WI0-h-)C3Skv$*1;o(Gqb_Pno*DXANSZ`Dnb!DwFduqafZxgJ*{i=o+-PjBWCG zZ7=)8#9)twDVgv%1_UXyUV^UO?Nz474aK!P+Yi}Z@mtb&fvLsCSC8|+qP}n zwtf4av-kZ0_a#T>!T9=Md`by>naG$Eq)uFW(jO!Y+2$LO00-xno)T(O5@ELBcuU$a8GfsOj(v zFh4OP*Cf+2JR8ORteLKx!o#8Dh69(LQlB0@4TV*}O}da=B;X$A4^*h6FQx6^H(4~3 z8)4KTrHMHR6Xh5iq-sxAYL%XAcxM72Lc$rXiV9O?O3)%E|Q%Y1y z9P!eqQbdM3V+1Ps*G`Uafd+En87-LCh5taG`WlNXKhKQKT}b+xisVP{d#sWTUf(yh z(G?#%;0x3B&^Ld6bZ(z30hZ(2^xwgK4{C_2XZk>KLTPZHscqfDW?q%#9KV{yaX(C1V$S7|NfCimd0aTgjRx}i_d0q& z-FwLUnIjm!o&Ww{q%8SOCcD7CBVX@g1RPKYZij0wb*Ji^%A!-g9{h5idy(djtH52% z*^JovkbIDz`GzqSok8tDU>m^pNe6M5E)GDt*wso7Q%^SFb(Q;VuNRVO`81t=<*QK4 zhN650*e#qQN(bDnM}k|zspp3!(Rx)<&!ro+A%2-{GH|T0V15%a2Z81$KO8NJb6xs_ zGcu{a_$LglIY%SOZ}eeX^f7Q6xI-xSPPbhX&u5EEpPMkTA?c1Kr)WeFkiiMue^Th% z;6|U)zfq8v|ApRu6skoROs=EaSGlaXX=PLM#@w^oa8k(E2yX}N(_e*hx$M2t z34_nUR3yg8Cg~5u64`ln_fCRR+44DkDHu6uI++XAeU;Exi+%HqiB!5h+XAr;jrHe{ zsl9W8!eZiBQo3LIr-OKK)kFiq)SZ#&t6ip7^{$WdoJnH2hjU0kj(f#9gz zjVtZUIJUwqpch+AKk*aSsl8t~RudMEk;twI2YPcCJ4>S}!|E2XtL$!|K^E_t0Jpu#L>06MpZvm+T&=$~wtrt*^` zqU)m*H1nnDzii49TwkNdWnwt9!c;nZg_ZYUogufWpdQsa$qy*1BBfgXeqdY>152>29WD&qZk zc?Aoib2`9+kB^c2-${N|>RP4w9#@BA!o;dTHK`fC8lr&7I)l*Aj5*rB+5iCkeNVL= z=q7g2Wt2qD>^C9i`R2g{2b#yQZg$ktk9IBk_#!iU!3H^W$u=2}=17LMR3&xRwQ87= zxq7LbWiYMu^4i2^Rkx2R%IXy^3g4F({K^!;Hb|NDRL-561v3r+EOAkXvql`{hIL*+ zM-gw5Up{_)|7xm38?*|3BkV%f<`~#jcb!oNy}Ahees}nRB%FhQe_&JUfK8&BTfnQe zPn6Lkv5O2+g2YI5D0qS%ElhWE=HY{{X2}Ft=OS+sXo6d`{?Zhzn!b2`4DuOKPJyv6 zB~_eV82&5NZTPM$)7nRqeh>LxzKcm$kdZd1W`<7p{MZiJ1S}>_>ciNp9sy zX=SBzj1H82M66ypYVO0pzONu7gTH#P3~YZD_Gdit7n~(TrcjVZ&HN+ghpAq2EBMQ% z6C533Kl z3YRmba9-=|i{f>JUp7CruEzPQyV4l2|2{s4KMh%n(l!eV5>F_6s=;X4?45au-cIJ;Q7Ds_m`8~?si;?Lac6-UkdN{R@Tq$#>T;)QLrPx7~|qmJqHC$ z7sYRReb5j9LNF_=4^r38BVlZmQWoeespa5)2hT-Rc8ep0i$t)lw$=FheP^A+TVo{^trDK1k^p^cq=(|E!N zS+8F#)%XGY!*f0A=?%J`K^ItpVpL`8WUq~Nifm1#_RhZdPK8E2Z1F`t>NI@8p|M6f z4I`D*yEbI1&_F5`Z>n+#;W`|#V}}uemo8MmpXK>`L-Gkf3!p>F zzh=qGb-y{NNrIlYeuu0$<-n;Jcx(Y)$^jMp_TV$DyUW%-D46rkm7{Y_yz{fzSTWJq zV}pVKkV2-c^@)h5ThJ+728xiat`T%ry$y()3(cq#?g#q5)8yv4j45C~S!N#yh11SkT!kkG3?)?V*$@dymfT?l$NE&?c)DS}Joe*S64KeAu zNT5^zqex`Id%7X{?M@Y6aQY;c-O3kf$OBmIB;#*;N1BJVEoKI@U*ux~$JOb)lE;|W zG}Hv_@e;G*Jbc>y<{9q9z(uTz$a6=qi6kl+;c7l~dPPhb8-c@RKFTnMp&O$etM4Qz zjgLMgpDi%@aJoV3B3ab|KT+AQpO8)y?ourIycIYuif`z^A7ZaAdjA>ZK7-H^h8xO(O+CGc{anFxIRpeu@|(ED0Ypn9KZn?8a8mVhX89AW(wDqq z=&7M33bxI{d_Mz>-Qt0)0qa@?wq0d%IKsAOW|QVMov~?MxJ-Fy`5Ol)?r~<>)aq}h z^dQNS-NYIK<+Mw6{ZvW{?dI{}^L^CyX58W^6p#DNQOrvsi4IVb`zaW9PQWCMTTvL2 zyC{$D&S+zVbTM|sv8MPX<~0U)$jPursU`)0sp>Bh4(J-#BNK2%&-e#K0FLmD<^yPF z+Q2k@BnFOt@QqJP=n;aaS^nh9L<*~jaS~g+cXDU#v;B-a{X`6~;zpFNIhxpdqsg!C zEMF0Y@PYE*M|!#cGMU7pHjlSGAoMub)-99WFEy_A$YZ}!HYaK?Km#9@g~l#$N$$Or z!PKI{HR7=ZWy-&QBe>~efPmuf;PI9|PFF5ookIipZF|aFj{_L=Ta%O7l6}5WlE}ic z`FL*QGi|lg%Fw*@Hm_)K{-pzZJY=yVK+)tbi0a9uV0w@~lqZ$2&oJ5#K;Qc9#>1D; za*Zeb`aO5>*0-Ct%gtbHHbIyhaT;U7885o{2E{aKvM=)qg9|JLDpiXYw4u<9V112I zEHj@-9sbk2dm@pa6%6Y|lApr8Jg#9@H9`!LWUX_e?>CUm24mwa`b#AAB#RKp=w}f< z4D==Ty{vq||6CO&h8>jBW6z;Q;;&6NCVubY9m^kzi4jF%VK?$(AH9GL9;3$P_zB@w z>})8hpm!26eO)k$rSasMWWr(>Q}xnAhflcnk-D)qi;^uxyY(K+Ja};s|7L4Fg$7<1 z+p}5M_Hb0{dA^OEy?dUMwe!)tmF2mk5>fWDF`X8_7$u}@;I_h@TZR5A6bp8fX5in% zPv8D@Fp3NeB5@HypIaw=<3vScQ>+>40x|Pt`Fs}5}PwCg$01m zE}wW{VgaHVNFCP7bD^f4yOzo;=B(PXPmAWY!(s~?muBXnke4f&(g~Ff`U?e;X<|`w z|54HRZF-Y>caxCVu*hO@uYSsp6)8uID^2={b8Ks=RJfF4CG)(M0p4i#!htgy2%Z^B zQ>mAz)7C<>8wRstrtPAOitoP0yfTo)d!cj%gP*elsnx4JSIkmyLb6B!5d~d|heHmq z2!-iy{g#G2gCGDzHXT=DbWH*X-6i89LiZk<-Fpq}<0C+oD_*mpc?EHPihDWceAX=BjGNg(0$Nkicyn^51MJSsiS ziFEzlCKd8F@spmW`VQPJD4Zt6>C-6a(qD~!H9qm{8f`OC)IR*4PeDP@ZsXsLeD#Q` z+CP>DEhN|11s9RbUo;=W$7y*`A;9XxODE{)1f=xj<8XJjbU#F{BV-p**TnZaQ6TCp zWIjbg$o-z~!)=}U4YpEf&DZutak%d6Ja4e~Z;0U4P*dmQRBxwFvd)nGSNW?5^j1Ux zd+kZ}Sn2BgP^HElLMSoixq!K|ugGZ(=0ZAS!*?PncTcV^Y${=z5SQB0=Om#`5BHn2 zZ{1~b67pA_QzYWw!OcK1tF9*uwK}^rpwgTw#QqwVW5k5xJ%Jd(f;$%{7mPbtYfejq zFWK{QM8Hl7mBi7#oS|7XP@B$bq&!~X)c?kfZO&1g|u>sPTYzLwPY*G)6oaA2XoXz5Me58$Mu zOz4ATW4`b6f6inW|8ed{tFX3(rM$ z4>6x=qY1io(?5S+9l@BLz>y$L04HY}St+&_cKR)pBcvxjj>#+MA4*3#7w$6mLr|2m zTEV7j@XzJ4N+PIQovc_&@t*-SDgeRzL%V1Bu5NxS5Aw;wN6GR`K37W9yIV+iAl2g5!<_;jFL55|PFU^ysQ`m& zWOZQDZbybCQQUhotePq8&YL16O;QAhJpzudcG7;;xW|p+dw!a`$k86L!u19&?C5envDL_SLaxT`aTq}H z5Rr@Tac5x{cwK9Bc(Dp^EY)^%uCup(zfw24(*?T|h|_6Ikr-yJwz~=mxr~1TnJZjQ zK0x)m))E0Sh*LWzbq6;xSP;$O1ow8=B%<*VvcbR&Za9(4XEffRTOYXxaUZnZT;+ed zXi2gPE?oEjgitlvaNe4yw^fz0Nil&Zf^G10@}4_4$z!EntsgYK`#aPRQv930UNIHf za)uAWGig0xKK{6jvUD=gH>A^@WCKHNj@`$PPJn{)jO%7~g%U~>olCC1ZEeX51Bg5K_zoFJJk%+vIz^g0U%(gJ7WHNP*tCd*1s=XdM&Z7*y zak|pwkjprPL1xUwE>Ebs0Z8BU-hzzlnwoMGSKJrRA&fFy|J&vR5#AY0aZ>9%_B0+D ziAM@i&2V&D*fU$7L`VhzY91pFP|Bn~mle1%U|a{yV~0d|6;j~N&rQvcI_2YjdhaIb*}qNY>Y&lN0U)7^Dr*gbZ9w`egCNAC}t zh;W(TPo%XrM^Q48ZdHw(Uqt{8s^8ZN=eZgs!dq*p+UgG z(s!zm<@cnXs366FYFV25ER)4n$@ zmxVq9aCLmQsbxJaE3oP`jPci(A$N$sky$bmB}ddrbqJ;D;gRo`&*4x}@;<$hKO`#a z(llgsP)rVb&Nt%+N%ViiEk)ogMbU7}47T%Z%!A+_#{MX>RKqyKfd2Reis}Dt4OkK& zqf~sd-~$s3L&3WtpPR?2xMG}p5!5<31yI22k^3wP_S!&>g zzFnB=sJ?q}?$*~tLAb674KnoPB;1tsva_w&unfP`wYu2?z7f917(Rp3FAWPH-uB7z z$?}^JzQixAhx`t+-Aqn9-vE-ECrKR*KR;1*Km)nx(p|78M}ppc?C)_`VbIVSOXMBO zS6;2)RDN<&JBq^`Z#(>16K`Oc(GVK2<{R?IA~_`3?sx%Jj7yx1ae2vdNTY&l|cR0^zlb0e{Td6UWr%$P@cPsYhj^2$k5Bs zm%QMRY#0x^<&@n3@@^XL9oMWyJav=B7t%L~Cyyg)pTHspQa3rRMpXld_;4O7kYtPmU* zU3?1^li1V({fnO#og42{a4=pKEGDpv;C!bi4aA61B9bg{)~28 zj3~o)9d!m2K#wYQ+3oggi7<-5;$^KY>YHh1I$qg##$<#X@pWiP8(5;>8Qf8eDBgXCDx<;8i zwdz`T4SQ2<+O3fYu+H^__MlK~ruQ5|NCN_0{5RX*e`|AZ#m%~C9ghXkR(QhE&LGlR z1<3r(o?#A(L06a9_a{Yw)>gIX0VNKahRP?#{O))+%2a^EpwQ~DYA;#{J*)=2#+R3F zh*QY%zBg&3PrCG5J{>KVI?PHoZ#DEi(2P#%N`{hj4uZC4KLOO2KG$KeZ#QKSZOnY0 zMT$&a`Q{Ylt=K>%ph%#$qNAl)L-N{dY0iqA{p1OMRmWSBR4ePLyFw+7q*60V|eJto3ygWY|!7t1Je!!ZigH8J(ogx4LylYgdjyekOZ-^RwJ@*= zrYpHOk2~H>$^K>mFNuLfgH` zaJuCEEL~{|ep#dDs{j??FH;`B_YM9sT|K(qO4dHh1Pg$A8h2_g<$yU=)uGflb@`ho z`TJLa4HLY*6pZPrJ-RW|iViMGtPX$VWEp@yFGHS@Y>u>tdTVMF3Wh{YMmL5c4xSgoyfss6b>{x9Q+Ik_HAg`OHT!%WbS%AouJPI@>{@bDM4V>@q4xJ*|M> zlc0OCZpF_uMZ7QBEze~U=j9}a+zP_(u%9#%N}dZ7P} z_TL_RCK86tF|dpv9;gho&-RhCIn-#)iK{n3AgYliYm=qnRqW#sMN(DMg*tdm_SOeh zP_!!e@FY|oQpWpO7YLzwK}H~$l1ajzAfYG@geUfD-DrLTmGQVdB!~hYtILB^pQ_Xq z8C4ln3s_S@3FhUMhz*B_;YR4)Vr2JHE>Ax^1P)QYVpFe^3#3EN_}A)dWEA|A5VR#T zs*JM6XOtT0;Hc_VhO-|QpN^Y?Ss>TMrgZddSK--?nMw{-f?q6g7s(CPn#LqhDnSAq zGqIAHBYF?~2UVz(z6yQWN#o)Fh)p0<5U8`|2&R(yevc3PN^$X+sRgrrEku-a8HX-t zV*?;Jk!LkRUWljSQaf))TOuX*-L94y_1O^LNmIIk{L$LrBj%K#003}T+Vr=OCZ-V- z32T~H%N0Q_p&CcUM*v+=qb zMl7ctf_Bwkwee=yE_1=*m({*(1+?9?s*}+bb1WC|Rky>PZz>Z?OyY%-vNXTq!V)xL zJR`LwI-6%;z#g@&R^PNP&e-$Z>;2_`-?;~W@uQG}*a*dK4{6FOG4_6Ok+s6!yYfUd z2D*v=l)v$MP&Sa|jaCg6qMciBSuQH3%bJOJqZp{+B?k24ofV;*l8@Jqk#`J;^3mqR z(TeD$yOS-AS{;&cj9uZ^MTXUBJx%w6tY|YZI%%_Q`;SJckUW2sW>ew@Q^^=C$|35? zjN4$scC5+;Z~MvWJAQSD43m8zZIE710o#CM5M(+p?}(tx-Uii!?>#B zCYNElg^)83n*e6d0BVtcn!DtY4Bzj$D&+i5~!H;gO z34m0{Pq8#E6$z=sP;&`n(VF8+NT=hoLpZCt05m8+ZW}|aY!EES`YOdWo+8xdjeml~ z7P~)X9)tv!D=IGyCgU+cT+m$O&op9i7C(=#8J55w2Kg%ffN=|^*`_op6o3c5WZM14 zsV$CG{{r=^wo7#qQ10^Kyk_d^m36b=%Y4hI#Be5WWLy0itUaVRtvgaXyRgEDnZ|Sc zTSip#<#0xDxr2|>wiTQ=u8IN=5EU^A+nff$TC(KchztDT*mG3c%rVq0RdMZwyD}t~6QO{Zf1N)V?^oYs0 z!SJzv4P|MZf>Y;osSFWa@T~Kz=XajY6;1PCNsb5d_R)b6EX9q)(}mie&$e|VdO|2f z)%>1NQvv+JS$YI*E`{Vzl<@eaqr?)NZjS{k17;U&`)j@8DoK$pR;06CNpBAOKHG*_<`+Xur%86IfCp$#COi&ifDvnG zTTD|q!~Ve45G`*5QH9vag(W%-K;G?XMDs2D39h9A43yUD>7`;!I3e0W4z8|7CfUDl zFFo?drP9-Lz>N*Z_1YYf9AqtlqBp%x?_nN9SZl6i1N9qEUE~@Cl*2asDzE&TQryuO-{_GqZI*@l(DXuC32 z4FExL_Y19*euPN<)3E=iY-3DsuL;*T%bs&HO&ztMi4XpLX2Npafs**_krKU6{g%zc z=qZixGBI&`*s13Wgxkp3yH!_#Ner(cxyci#N(}141b{xXCJE||Pg)M6Am73FEx{b< z>Skl(DTOOi^+TAdMY0%Ic+mT%A}EJ0OJE0vNB>i17ORYn`uOD~<3m zkHV^Db785oX71P#ZxRMv?jqZIXi9gW(%Xm{xEmdTW+}eZZ1k;_i zm%_^j6QT#hlYgE_lkX8bAW|M7+F})Y9hb}JdOf{89&*uge zo?2;cU^srCi61Zl!XL?ns;Y#h!z?|X z!v+wryfsk}hy4@VY4=*4mfG5A<0vXD6}J;;RC|+eSr=&Otu$q{iaHBag^Wae`~*ZC)ltnhZ+UW z>_k9XCpcAngnk-+$xEYubu>wog|y#~HgXW^NQW1&99GRxaR!@EQO^qMol)PHazSl& z`W+B7pMyFX29_NSKad?ifjd2@(iyl0 zvq6a^NR;C@X-4B<%{%uJLvT^dyox8Ma=f}N5~Tv}NtIC6eyK^ndslQQ+OLJ%uHz*Z zs%a9N8?klBQ7vB+x_bqiWSaHl@?=mUXCRTz<#=KOot^BAw;vi%Ft0V+sEcmT=b{zM z^yS1s#m!!McBy084%b@1ugfv{*lH=?(3)goc#I^zAq$SMw%8WPz7@t?MH$YtKkRs) zZ4M#%x@2_&c%stGRJTF18di9_;A1o8d9p zIKmFrUUFm1=7U7uZk$t{WS44XM|l1JNrjv;`i`Q(^n#YV#96LYH(vPm4N0;@%L^6jLxZmJiYEC&MJ@U*bcUOE zoP6>Z(I3cQ;$)uO31s!Pus+!Z5lW#lJm15-JO=}J!hy7zMFSyH6sX|4k#J7q*}i|X zy=Z?(kcC`9;@6~TLG}#2Bw+?68OWqsW^SWNERsgYGU4FK$6Dq3)=+S0sLH_IJn7v! zFfEHiLJAE2iW5X*j) z209{HHs?Adq$Z8ZI3qSFuOZOb#pxjcji);z+J*oJf9Lh_f-dJl>MO0dKPI-#rnQe` zqtZRZDF>|#cXV%!@lE-7F-bJ1ws}(LyTSWGe{mtK!ljazKY%X}`_XwlW%?bYr>b;d z^dmQ#i7yA-F30q&f8>md%CL3tWP`yhz*%GRjg<-mhyeMGs6zD{l)y!90{${nSb`ot zBIivr#nKH)YoSw^CX|P1(R7GQ#c{(_i+4S+L1dqyRdfUCLgT>wDkFG1Kr@FQt;Lxo zq1U4vzlu#amM>0?iQC@|AsM=`h*{h{R$!SGQ3bVM%>t~+Q^cuGuRuSoE@*obk|*21Q!<9vC8pWA(RxLI5h{|`NlV27u_aA+@@8CsOUTA6b*a16b;DoL z?N#i#n|2-p`}zJ&{@^F7M@Qpptlmm;88HiZ@Y7p3n}la~2Rq=&31_Z|r5vJJjG@lW z_+rCy6c6PwEhvykA`u2xk+2Pm`KFoOm}Rz{$-^UZP&jAlwA!AhcwrPX-RQ<86T>ed za@V!8+p>Pk`FV5UnE%0jr!17CyP6vxf>6=4w?GORCt-1MYn)4d@R)p4GS3-KJ#9#>qRHBl%0B3+_^!^KaJ#h;m`b zQ`?c3PD{%SyK=}tTl-@uGB{Bgky`Kr8g&T)s-29y6I9_w;@jhDVpg6!fy}eKp)`yQ0~)bTg+y`cCq`TJU>kJbKq_0l|+> zM;Ng=@XoG^RL>qE>H|Of94s9RzUu25N=)Et{G2aqF|QiC52|X7H~g|&?%oE!Q6uQ` zc#!?zSC{8`9U-VjJ`edh>w!jL*&`Ve)2MdEYedWFtd zFkH~NQrGe|oS56u!W`NQ_P`l-=rNY6wEaxk&UrZ1?}*^z;5d}{1#RMBv`?x^<||~T zVL9y3;lr&cP%P5Q$(8w7?J0m%tVfU6M<`bI)_lh-QLt4wjg^i-0I_FXA@r>Iceak- zBbjo~j|4qNiepn}Q^&DQMrZa%;8{H^-&$u@l18|;*Ru9vhe}wX7BR&zaV$^Q$E=ik zmfQmMjUg#`bF^RqaqgA7^X)u&6G7puSem#o@B~L~yJ({o`s3xb)-P;N_w$SqeMR8e z=4R2xbri^lK5WJ>C`dM5;nD|fK&|N8?JkO~x9WElo}~VI66yO!x64dG@&-L~FY(r^ zHXlp@!db94RwIy7q7W0WZ5TW#+?pWEXwKy+Z6$oV$P;=Rnd7@m>ruH5j&M#S%-)^t zr~mJh;w7gEuPrNK-*yC3(VZgRmCMA*2@VWBQiQK+SaAVK;TG_q%yU zYm$+HQPOxy=3R}yPkx(Iu@u2yT9!0YYpX08Ry?NfoFPYhs=n8yfM36{RJG3L6V_v% zE4veDh!8+BN*6}xh|ZCh>}kX3@Yr;5ngj0sZOEXP-A%JdJ6c)dY0PlS+qi0U$a@`F z;U(Ob4h4w|zvL?AX@x>Y88Q@`+YBg`qEw5W`1&*={h&dPHGo2mRwcR6zI0gq(parw(`T`Htf4HSF!rRdBJ&Y}}9>kjmiQ+UcnH zoe@#|m|UMSaC#$mqelPbxJE!g(?ZpYCVOXf^CN245m#KPN?+=pGFI1s?hRa-bk%Cj zJ4I6t30&B-sBXt|ouD#^($M}AMF~-W6f~pezE}++VU*yu-?LmgP+nr0s%>MJWz;Qt zFwa#+*#^>q8hph~xv_t4R_}35`LY|t{qk{+Ve$!p2qOw;-#ONP##tX$Vb_HYz2;K! zaJ{>{AAgv+;pm-w10IJDa!!dF59?M5EJw9&_Q1|YJ2B-+-ucb<^Gwj0D?PaRf-ca; z8>ai|cJL>>M@xZ4w55pd8omP#?dkaiPh6H@j?5a2aNLkav2tD#!FB(AZ92&4Q>gx( zWopP|58*W0QNrq~SY;+6Y7WTM%r63dsd38mM2G^D<8UAGE(P2}xKnCxz2e{pa>udn zEy?U&)qrDD!ea9Q6~FHl=6k#aK|S=!Z=eMp4}8ZP-PK&8P^`wE7#8*L!26T}bxUsI5GsydW7U9vouXj7g2Z&GvOT#TUYmA*~BHkZO3k zW8v)A{H!{?&DP~~rajVe{FMS*>40{q$Ios4csEaEKS?`u)N>!{ua~f}&*KBOPk?d+ zfwN7WHG>!izdQ02@HZW1Cd;9f9A$O-`xxz`go%bcGZCC5e^4jS9uvLw9+eT%&4vqv zNAIKdk`p_#zfFAEw`0Kcu5%c8$JQ@Xk`~s67AH4U*`(hqM!Mw(DzO5lF z9*~2_<(Qho;EFb-aBdLRyfhE@HT)oID?@83VKpcy%<4Z}+_Q6Su{K;*=dm)3%8 z10NCy+ZI%8`Wg?{lxmMSdj!pKnm0|Ii2Z|Nj-4t%+WWIkDW0i{8syjwMdy)INMmP< zpz?&2soT&KTba`%b6+m~#+UCzmREP7hK2HE*YuLB_dg29^s6=lp zzR&#YxE*3KLE(g8bE2v};GX`MEGiP&2b-i-xDf7By600Y+Q1UvUoCLd%;P}hfGiep z8{0mIxVp}QOz}#FQIO|ttrC3Km?B{@yj>31ffK^Z&Wd8GlFMU8E!Jy^<9#nH9RWHE zOc%gwVZCNW6@~xr_y8=0YZUARtl+U1gi~DU;%ERMM}81Z=3cmp})9nqKqIwJ@8^10K8# z72WX0$(ZN2hmOtz|4^1b8tTT8zXNEdaAZbI`*G;x1!xaZ(AT2w)*TuPmZdkHRGg8u4;{fVl{l)Z6Lo)uS1JYtqUR?z<*!Qk~(#BUOG_b&EvYvc-cU+VS`l+3T^_= zJ)kLYv(5R*ec@O`^uy>#{c<+YPomHP0Hj19&j?%oy@2A?2qKbcy|avnCr8_cBIRrr zHzk6xV8F7Yk$Ruvsjx5X&hD(FrIf3oUtxqaf8kMv@OAB%jq0h{wy^#Sb~8NFME z4mAYa)=AY`XyOe0Y#V!cS=A5f!a}O+6=RsAuds3=GR?C88-}otb;nF|9ayfE8Kmjy zoZ1vBktLxl+vVEN1l*@l)O9YN9|w;Oa(4V&ZU6Am2UE$*SZj1pb!m7(aw(N)6%78g zjU+1q{?!>IfDJJ`j@S5!Y-el;{a(hcc;6)LctoUxYc3&D+ezI|_{m)(`^qoinLV?~ zSIwHPl&N8tSk8eYF|x303?|LYgA03j>{mR^O>>yApo0(kLkV-Z{m!3&SNnF+7=K|a zN0O}$Bhu-6FsMi`e``wP8SBWX(pzWh%<#E8r(27VY2ld%FRA;%#3+pvjVt6Qn~->r zj5mk;x6nRbt_dRw8G*TF-vR)^-CpeOEx@f?(xC4&6-X{z zK>BYNsfj}gg7naF7WE<+f#e1zidCQXPY`w)Ha}OBr6RXZK~!~1zHV>xFmKc0jP(6F zJGoIb)ivfGMNG!Bn0oqpy~#0pkVom8^p^VVl!#*%UQDGx!D%zqb|@;9u|`;ji^ zk4^0@s#)|@{8+Q<6R}9=3`;gM!lu>^PfYh%MR=fqTIg5jh#XTQ!QSrf9_}A%G{B6C z0RUi_&4)_rif+g<)O9&i(Q*=t%BO zt!#o+r9k~j|2bMpj4TC!=#vLP5=UXn&vY)K&J+AR{|RUde(nlo2sN31ZC0lvOLibS z36M$Shlv6e3lIkYtUBBav>AXZ`jh!|;p(|Vc=Y0eu-jC_G9jIPrRN*g=N5GT@xqZo zZ%BP$EhKsh0h!`5iaP(BRZmBeD>g==*Ifg%D~|Atc>+CK-$T4gW17`YzezFPy5Ep_ zjH6pwOF@cxnCq1qDi{7gaWN18hz?x1s96^>>mkR`r3maSt>IwEJyxxHA8QZeL#*3X zz+f`_ffxs2{_Pc#lN#xAxvoz{@C~|ijVm=LVdS+QX}jY8hS)#=K<$oquO|;pfOOTv zv)x#NSB%0&4)Ma^HGYItF&4B>eZ?LEaNq`xzD#tY{>D3#~oPn`3mh;ddfMIEj<(hs`p8r!_ z0|C>5e;vofQwQFc{|^R`9p>V}$iV=dkJRgrPsv_^g{C?qi=;`s2Ew%yY4y?xa^uT`*{@JS}<@T#Nncc*eb=l(h2S`ck!96cHbXOj< zN^X?+mZgYDiehasb-j(WB$U6m$a6s-R{GASIhI+?Eu+JKQLsuegC%go%D*zBOXP?O z-yT+FcZf2;d{C5NwzU$FC|0m&1_WC~(= SCsrOYEANQ6|T6f&)A}O((dg0KMDW) zLUI?=)&ZahBu6caQsC=)XQ9d0w5;6|N0Zh`KKF#>{4_d~r!zZzUYNtz?zc*DhXAX` z{sPs>sC~_fb4i=w|MJlwja9nxwhEO^OH?dTWSLA!ZzgZ~DIJ-tz^xXOlp`Ipvy+n( z8Ni=?QUhW?-DiQ6u5StAL$SnSO5ilu46$jx{SOl8a!5k7s+f4wA2B!^*e#fnl&NLq z>`4f7tq)%sEPF8eJor1aAk$r?G%Aq*0^gNR{^}VmpCcTnB(RBxpa0SUCtBBX(r#=1 zz1>A2T?qLkMDK5JT9K5nbleu8U+d_KlkcHmC5YI~{s#mYgCKJSK!~aFJa1<|=#=l?MR>Lp!*i|n znN|Mv%Rf157?-d|npLq4Yq64L;*Dn)p8`@FcwnOa=zVjw!50 zMKq85WZos#RV7nHeM1g7e(j{z0|MXwU7m^&Qa*8s~GM2z*LA z%{RZ9XVO1$v0%j;+_^J8X$DYBXzC#Xh^Zk@j1Oo; zSD6L>cXnU{YEDE>-#lv@kr*vWOG~*BwYr<_pNed5?j|l?iXs8y5&~xC!hi@F3JHo; zp{K8HRd|ETGFT&!qNm#lR$$nNR3ulUMxVPyrI-KOHn0q(O(#yd!Y2m8y#u3HJM7m5 z1k=%!oKoq7G1H6$s&svE%AX(4r{{7+!Y=fl)&KY4Rd%5&AY1ar+I0o{(7a+@hEvmF zs)B-t>!K_HigUItRWYLIo=1!6w~krNAMTeCwM$%xjh{^3!+T=TnSh(D&j!i#UT18< zeNYrb;h#UC-x7g(gz-Usr`ikMM7h64gI#N`YlpT=*W6`(`;XJ5|K|e$#jt^>jb{C4 z^uPbd|9^{&&sdt!+=+4*)$CZl)#y?UKKWk$G(Ykbe_QJY`B`QrlB%vQ!?gV=ZL~*= zlgQ`{-DPOXK>Bbg39clsqk5;U_L6M~_lOGNZgl`I*fnWnp= zcjW~2FEf|AJH+eiGZwD7>OaJ1Xw4cI6$2l4h$hDg1_Mx@Ok2K0`d>^9hSzFKjnGt?#Z7HWC)H1dboP z>b|fm5fqTJF`>!J0bKM20RMM8h|St$rTw{n-eU7uK9Sj1ayIJD#?DEzPCr{+{M{d& zCmVi%oPxLGd3qSzpB9t6o;w7GiQ^qU@qqw#0F18Mpmri|mnM-GtQeNczSb7>U(p5m zai^9IijVPqfT7K43J{D_u|1or7IL2t9bH15!z;==2S9Rq z)wY(Bg!OR1J}%KF!(kO_0(1OczpnM;J^HPO5Py`|V)p!g3gi4~Vc~>;EXKmY_Gw6y zD!!5BKw)5DT+51H`{0Dn$(Z38wzPR8c9`?4wg8w0^9q*DD)9x?ebSxN?^obDP> zH5%O4W&lH)@i)t=HX(2fs(j!VyBrPWqP|IOs){=-yhnXZ-bGLS->^n6M+IR8*~F_+ z@W)#XDl?StZn`0kdS2b5T6lT>*kPrRL{4IK1s(sHDSGkbO*K!A65#8rWbVMi+Y3=gUC|$ynt^zB z`?Tb+>MsLYQw6!DYpf|lgJotOWuU5w&qwN2IEBQ&w~_|)$8(9h75JYit4Q!a$mPTM z6+3xu!eT52r#ndiMF(xaVZlXr7uLmtdq^BD+Bt^yHXf1?9=0cG6ZZW!41oE2|6^i? z2ZFY0RU<@yc_EnMU~=rlRxvJy+@9lT5!8&y7}yqAK+sA8{5>6`DrK9Eo;cGK8R}Z5 zG11FwnrVqxhc1mMBsFi?n0m2S`dO{P(8rO#FjbOEcfoAS*b4!4fTfUm^UkEW)mdFY zeWnO6v0sPgo2&aSh_(L%Y^ZpAkT|RF*+U9H(tRxjDBfn3WX99NlC8=nY@fy5i9#eD zXhB?LBS^nAv?+oZJ}*?5(CE$+S~sz~BDDaOhPah@lbf3GyWQz}i=CGx15Wd8C!|Cn` z#_8TzwH7iUl|2C`XOlldeGEtVn>E+!xL@gM7PaB*zLW*m$9qYl97Tpo^~-$iks)t} zERKXn&A$efWG;G3$!meAU7Wa(*fVN;pL~6N{ZdI)svU64#LLho^5@H*QZN#!@43xW zjdHfZz%l8M;*g-`>jsQH3u37!k~@3S1weICC_$WTtStb5MP3nHiRqy4-fG-V(Z-L8 zxsX!9!{>=IH`5fLfNMEzzsJ9o&s6X_c3TaMZtvAaG)D29R0dBiYiFLCG5n8~n^3!v zR7wH8K=-OrVkXVW3DTH=aAh4t3&N$+EzXmmQh(n}jiN|{GeU_Vc*<|>$3XZ|CjbsZ zXc}sf8694FgMe2&OYo>x!N=|*{2j&yvbu)6OeDs%>q`m+QX=rmZi#MWn|n$QlCd?cAFF$e z@n6kZ-F8{~}UAW}UrQQBvi(lW;Bi`*cca_DCWUPSb zIyI4%k?q!Hq!682Pu*OGu{Hq&Szc*`oH6!4IObqen0Eirokl!9UZ z&cM3B-SWviUs+6_wKR%o$R8N>=K~Q_%SDOhT(9YXeFStbj7|kT7J6ThAIabLU#ooD2|JClj$lidmQ==8y_VNJP6e~(2OT^jvB+Zj z29|Rs7e8hPO-Vl4rL$v<0q3Mw{9Kp-#>}h6>bZ+~O~nGZ3p8b5Q&0A|&ZBbTmFO6J zZbGN;nLk%kaY&844OYsC$k^J6vNccLe%1g12^CFyYP^ii=9|QNY!ChkuV3^Pbsw%h zWefJzGhSt}J}4)1Sa!7xuLv*oMTk(66c`4BrSxDa) zChQ-Zeodsoovo=+nVZ{{_$_Yopx+Qh0s<0OhY7ER*)jTiC&#Ef3BC0Z-0@(P;Eqr5 z$XbO^u2f;HRaxq(bcv>kO~V_vz$Us!K6$ZvwYCNjGEON-A|ie7ORK_kKu|%6G;%&c zV22a6vs`2vBPd9gvOdb;*u=FNn7fltO(|I9rU~R3#`+`MDVM~lm6fJJv+*3fgoCSl zf0rZr&wU)j%MlE4q6kq2A*#2QaspsLOJEeoUp6D~j449$7cqdC8wZp`vVUDS%LpPI zFEDqKT*=K z7RUys(d-A{NpLREyX7}%z^KBZNKYH=Tk{E%^pPlPOBS;2rPL2ePTl_?0Th3X|6U<)M#(OdsFcE^bCWdAtuoHX-Ctn^VK$p1Um(DX}{FR4RqvyWJQf|MbW&8|!H$0jfrHJcuGGFJEgq|8k5WHY6 z-xl_9bAa?}#B!<%W;)c#3S)>(5NS`4004MK4XWfq61tyKqInv0iuR270l16Zba13l zn5`Zd<4o*~S7Z+y*YFKH=H{w&u67nnE@BB8is_|Cz@WJyF`{s86;%_=hIfY}Aq#H{ z$9LKWgN268cx3+=#yd!HFA}MYiq9Sla*D^sz!awJz-fmiFlIpMj#VkNe-5%q6zx7% z_81xaDcjl?{lE=6r$(S9Aw^Dz?-;PWanwOlW3<6l8vYD~8(Tz%7)P71d z^S);4;eUZr(uZRM<%g414Io{|GVZOesNCxviuAf~?$h6h*PA5#Qh-(2=R2x{EfExV z%+pD$@&VA>WFpK;c*_+;c{e#PE(dYY~ z|A83OF%>|M1Az31BB>(`!^G(I>qo1Il|ztYbrgiNN)$6!{1vnL%%*c##B%@yf$`cP zRu#pp(pt(lvsVO=WbDVW{Tz@Tz*W(>0u)ukXbLkq27asIIKl>+Npd+9Y%L5ZR==ed zBGkRdQi4{XL6qIln5j#+ptBS8vZSN$sfNDzXL!2CK%RBPzx{kxoJ1%r9p^dOoJBWr zj{!4b-<3Qp+s_d};6}LjI~kwI{!jqq%w=a#Pa0Crbj!wDBPeGBtjWqpQQ1#-anX8YcF{NjP0-oB{&;T!H=puC$se4z3NZSzEDS2s**h32!v?K9%s4GNY9f0O4 z6Z84CcUgE((m!*GyOB~DpLw* z=)D_+m|nn*O+^zYXoNNtxXF$rglRy$a}njChqU2gC=J;!O^ja2Y#gJW!|v16T4{5D z97Z!fO#HsWZ(Sz+qS<#-H`?H8J8S0J2WX{Dw#OQtQvd+JRFm9hnf39N1NS? znBZZJ#{jN05@J$c#%)Xme-&vq7ZgyJ?@TRJO65a5$KALH-}lqi+5hY$Bj5ih$60k1 zN%D9?#QE`~z_~pPu9sG1ziGaK)G!I6*lmXz7-PP%Z5Fk4c(?=A6b@n`s}UTduoJtW zXc$Jv*74DHHGV1izA*bjy43;ZjwoE;g8#!j+mgxZpldd4d=;M%25I!57>IffL`e>% z^wfojsW~m#1>$n*8Ufa?A?ZoV{>9$rFezE?#Fy@L z4{dI5uWx|67Bh5@N^xoDq{A!syK-DCqJ}W7r;VVERu&&~+5gZ<#g07n1; z%yYSb$EJLR8cw?Xa^zLezyJUP0009367c{4cgjJUBw-j2V37^~{;E{~03-{a07)r9 zohovo4E5ckp8ACrs2>}p23A$v!yP>~&v|i-h|Az7rp5cG&_z_@oRf37%^W9@W_8Yn zt4=d^z48UgkDdcwk}C?__^c4j)06`U?W&?N8}gjDs`hw)+eP&3r*zQ~LkxcT3C(p! zuDu}i30Ga*yY=jrm2gVKVzkw;laHM3#?M5BDQ}v6VGEN}<^RAeM``kk3Jy-k zc83%dnCGU#p|UR~bJBplQ2B4K1`%Jni1ubMHFqp47I;;f=RbfrRwK;a^$%K1w#p1t z;#Qt9z2=4af~x$Xn^?R)gtK&)dj#$uf_uJ9@f6CP9^*~6tco+evQBrs^px_~?tv64 zN*YLKm(HB~;q1!y!NYGM)03T5}>8^NE3rW$W&gu)D*?0tISKq8&wxU71iKi3{aMhFU{p{TyYqfKaZ6xiLcuv21~)Pz{r$Egzb@!e4WtP4j}QYuf6{;yD}ArHmQ6;KfrB{688A#Y&`O2Ql(A zn-e=bpl3^Mp;kVfbr@aW03)*%9+Y{DHE1pZUxH4Auu27A$2S8cSB*Zigp-qjuq=TU z|IlBq4?>`PJv$sXva9YqiFD|lod1Z)p3Fu;&cwUWHf>&9xSv~>w44IhY{JC`==8vpc^Iute3kEhm3#9g#9^Y5-!Jr4O8xpDX+ z<8Xwd9+h8PL^lW|d-9q2U-3v!g2>@vxIj$&01|~QC=8JTF^vq=SG48ZV8xHhJ&I-x>8-oE=a9Kect@bE`*OQZc2s zN`i9JFK9(4f7yVRj)|!%^P$1--pAdTqd!rPA8Ba%k^tIq(U~)xjdj5px63Ij!Pw0q z&(N*#5BRk*AJH38>TX|}d9lk=CmalxoP0wWE5LOO|M~q`C?w@FHK!#7mmY=)IBY0U zJT(F_LL8S4)MZLq2L@L*^!%PO-jY~#30ut>{m8l9h8C;S`8k;AJG>?j_!{@TOt*~Ef!3RqbsS_zgJ>L5q zpa(F%WFIv6G3sT}I%OImOX^7kI_zfYQInVzk!%;=&`*7ifpupcUF6O8G$Vctiqv5) zM^eK^H?V$SC@!dCfA>6LWuSs+Ud9sBfMMgIBw3$f`Yfw)D^gqTJqhRD)K-D^o$l)u z_)%X)^Nwv|YGu$B@vb{neG-9YF8ZBrba1TL)Llv%42SqUtZ6Tfl@@NqWhf-mwlVte zHJ{$_#&i?`tLs#+2X6tgL|*39250I;igLqPqBMUHBc*9(masxuISbeVesrcHhmEZG zQZB)L$xai!H$*slBIXnY_EZ8-BdmtR2QNSlfuNDctgk4HCB!k{|Ge#O{%_S%&ta)e z7X=ImnKC&S^U8^|Stkdv9ah2bp;YhU+eJF?M8zrh*s6PSyB*a`R|43U;_~(m6GDgW z*6|(kT-Ti(DvmTYDc&y^!<7o~P1Wl_(3u2bi>^LOKi&E!@n?4Oc>hlajz>;*F>ftQ zlQm67l|o61*oPo0271^$NM8u2x_YO&|aS@eX|o55<{FCV7Vp#O&Y*`7kU4Fg~R-gsa#qoh67 z3rcyJ9VYY#)h3wR5&;_6iKq+=1==_W*g|r|jg2egi$47fX7CE7kom^T z&~Np$?H?znjQ>5{gYa})IEHIJlhf}a>`0DdYPh01~f=8xgNwyUs#Si>_>GC3OTK!u&oMw&n$u<6!Q$ycrm{M(;fiez;Q zRnjni)@-5$wUlj{|Mnkf^`nI|db6+TS=H_J?+Z+<5(+uQw(P$h*Or2bIqWB8C}MvI z`}v~Lg+v8RE%%gxGq)S{B<>L5$~B#m+VoFxX~(W~J7K6e>#9%^S2JnIbvf|II{5!P zz)j@X1^p}nQ@*rg2Jgx{{$h3$Jx~GH9|hR1L?t`*r3Vq6Jvak;_{o_&D9wNXVd zMkatqgx8VkYabU4NQf{sC;r8F*ql~{Ho3AY+>oD1Hbm(&snbvHdml01`I!m58)wq%36Xhup}@c z{>kWC0wbzilP0&mQSWDafbA2vz-9K)WzwGtM$h{b%ajY#v6NNqdl1Ws14FATxEtT5 zmhJav<}7z5T@x@|`ef7B-BY|f|I$8{am>D?l1jc71&`9Y94B+NZez*zdI1jvnMLfq zz=Yrm!%zUJo+Spa9n<8wifqxuC6#Ht$>JrGSw50}66-M)adIj^$PyHQlJ9ld-KT^n zyp1I(spSNRh2d0h8f?8r`Tn#c#DlM@38O5Hs$EAhtXK#MT|GRn8SUCmigy)@T**BP z0UX{KElrH7ow`^5O&Y@b?>d6SFUfDfyhEGuJ?brjH>W)8hKSMkDH(TIN;s-)3>pz* zYX#)SAQZ3oKG=rX3u%5mmY11}RH8>tOyG2jsJxnTJ@Q^N(NjY_CC1gVr|bVEI5$t$ zEDsFkG~D$ZYe)dzU7HaHoXzu*14K|hMWf-jTP~*-gPERA;Sza2vsvIXO3pawTJh>o zwjAGPZStnH9=FSVZXw;C#h?8xEPqYR&>i2NV8G|#mRi?!1O2mQ)Sx9XhzR$;Ai`#u zVi^oj7N2zoXgl-3A0?Qs@^>^z4Q~yI1}*p+xoishGT?}aMs?U)DSAXT#W^SPrD1CSfR4)`a7gAtX?lAHmc#mKukJ7JzvRU0s2(p%B+A!aZxr#;WEkq_H z*a_AAu`1rPnJvqdQ3wy7g=ER$@mp!>tzlCaxR?+Zb2JcLObrZGH}u`SNd2LaXp3rj z^jxAvuVB<#v?=ep=6dVrmc(VYa`Cc^uzUboY`{TH0Y0 z-lWG|Fc~!$u$fMTW}7qW3Mq@r-NzeG%E&1kmq9t`j#aK6f`#7CaxTzBk32XUrRG2X zf-FR7;EYhj4k9@_|7s*cO91fs#Fqae%@sHR(u|hut&|?K9X7PQ0)B@(7bHn5(NdAf z?>5ElRxO0AzxVEo5AklOtgAFEj@~+r$ml@G7TFmwxd=2rWEeO2&@b#+TVj=fqNaJQ z8i6WDqSq`jO18J4eHZj@Lmj6G19a*EfhnzpAG-A?@%dJ1LBgLNFBbte8i$i-`=snu zdULB>JhXoTNx))Hi=mi$oZz|k6;!d?fudZd1U7ShJY$oSzV4$@O78^hZ4U;XrUOwt zjgmT5B5E#4^9!OIQK%cW4I?naP51e;B_VIdEM10QyYd!_=PdG^N&o=PkPltdZ|LM| zW2 zJ`q$q=K9Y9n^3CqNu=e0&1+8||FdeV{r`*e0~t?FYo)hQ{U$ZhH_5Vd@B}K(`0A?P ztM=S^SsKauU>3;Z+T0K!8z;9<^^*ph>=R!=a+s!&|87F58BG?EZaWbi+WjQLi&) zQOg`Y5J5HAHRm8EjpZ)?>I`n*Y&FD+>{o8ktF?sRnU~Hk@0$KAIFmrXKm&gr$Z$(g*Dqu7n|HApLC)X8Adjr9zz!-X8 z_p48g>LE*iCXq;K=pIMWNf}G)`sWV&$+`22?S-&rDhIRkSZW)`lve5!ZY+qHGs?sh zw%<{$!@!vVI)?F20W_r$u<;3N=iIi)RX<{P1LPc~#ycET8*c&ncpE7V8u$@aat*Fh zu91k1lnZO>J%38w=_Svikr8S^Z85- zO~^DNwHN#re|PM}rVEdZyL^{ZLr>gndtZ&VFMQL&{th@uVFt}|mx9c?1VW4{OF1t9 z^ew>$e}dVVu6pET9|3Wj(|fYhUYrNGIBmO`(?9yN`Ye$f2Ymf7!8)C?k=^=QWoCfj zuib6-)d#Iy9o7v_VCM&=*WROVmv4>30wmD33oUsY{QOY2C2F+|08;FQri!?Dw~3*k z|4X}qyz}B>#DUT;WfTKPkW`S5e}b8yD73Qrg4K%l>(@Bpo^|{rUHPnHX>M-?amRiJ4b65++z?yFg>S)!Iv@*fL8} zGP0c*qG-1X(BAs&?mtlDP{FdSHNf1Vh#!ZZM zFX)F5a4D@Dke!Iw#e-}vJ>K@IiIjN>wKnZ+V*K@(*#=Dw4K9Q^!V3Y()K6Du zKEFT_#UFM(s1wfH=GnKsPDMaN$6g0B_}fz@A9T__%iLUbiRXEsjgw1L8BAmrNy+PQ zm{z~EktP16pcXWE0Mm!!xNtT3In^8%Io|aDJMm4=)!mpnJexir+&!S2`VqP_7F7{h z5pHAWT{aDq{;~ktiealhyB7w=GT%?xnZcEX4w)%iY?Ho9Gmf#jd7s=sOj^u}2zLYF zW)AcqnThy+Mr35*2xJ%r_`kE?txJF!wxHgJA7USrbk}!tT=#(kz8ahVHNJLWV1{whY!Js1tRma zej;Y+XjiVa2^k+o!r=XIv~7O!vc$CB)`)u|Sugc$6`y`x=I+UU+2UK63BzzoUm*E% zeT=Puc_UG~n0QEB?mPHk;NdfSv7pee6gJ!+9YCbckT>-Xz#X-*Mo|`0=dk1%ozu}`h^ntJ~W{k*Fgn&)4dW#3}IUFF-+gdF~>??1^ z(SRV&V9}IlIAQ$sG#NMq%Q~R{#Do3te%>PyquevsB|W(s9;hIvx6cjI+oDwCl4=5r z?E2XXxIXxsAld4VLv3$y5S;#Dbo`1C@I9K>Xkn2=l_+=B3|jB$_qpc=L?*XSz(Js^ z3tG>x@h?1u5kP=`c%|ZaKNTD??sWd9zR~R6JVzJ$RREDA_Z;%9ONQO+3prQ@Jeu{g z52BOV>MFBi3%d=3>y?BJ-*`#gvzb{NsK@K0s+_F<+a*cNpnmaz^saC4(&SXEP&>0c!s3y`&QIwkyVRg4H z+WkYdT2h-|4mO>5>(Y8HUf@>+jG!^RICG!y`Fe+B(9$7E2utQd1skzI)7k>PY{56R z#Hw3<*yOLEZYdPF(f)Q|2K#3sRW^J*G?< zp$VqtD+h!9PJcU3#+L*DZVTK27k0f;qa#lK zLm%GEq*QE|ZzCF6-H)>o5>*VIb7{MFN5QTI)mYHirGCZWDTk!gP@`pYxLrQb{tv;U^BM*mw}Xb7-P=h4NbQ2cx$BXsh& z)0cTxxzkN&duAgjYtQRp`3!2-e6MdS7gX`9FUKfFmblV*FsK3A zrnEbigFaEo>(@x2JKcZw5Hc(2NFj>RDaHt0CLELw!Cs3Ua)uL}?>BVA3O#p^p+Pax z(`9H&?{Gb0r^?CQQwGwbtAfBXOKPBBg=+1e)E@Ek}R0V2yks!MESk+EX$|}`pm3y`Vliiu96pO<~9^ z%R{hkc&6V;&MO#J-1WEq@4DtvOr59n8+UGL>exHx!}O*KvM~E*NfG7DB9dSl)NA{C z=opNLt^tSuz$ioA)@s-aL1R$u(GX#3+$&4(Gb~PS`e}7%7}G(v!O@8P*@sQV#!Q2h zK>a$;>nqE)%d~F30CMs{d99XUp9Is_k!&=h25^D3G+E8;jZr{ZC62Lux{mDJ5gCg8 zj94ze-Pi`}re%*>HFpF_#8&!VQ<8;R16Z)h-!tGmNpU%jnN>P0J(BznL;0 zJ=$ry#eczX1M@4E3w{T-BSOH6^kjaCxgVl@LCDr<`VIlG)Gq%W!tP*@jFktcXw{CtI>X zb9nl56IdGH4Eai0gITbbJb?X-e2K0Aq)CuLuE5yfwtA^7cYnMSc21sh`?nyq!yiQ-~Syuq^2{$8?_ z(!3i?m5;AVXoyEt=rrgzP!14vSTr-K+qL+c0*3j$NiI5rUELT47 z1h*CcztT5jWdqghoVo%WMNZR=B_esrV;TcTy{iyhI&TLt@Gk;-b9((R#;%!jAaK4nc7`ghzBYVms|lPQo@CpymDLAoUICCGDEh`g;|@?Wm@Zk8Y1V z`*I-9d!7$BQ`tKcFwFm*lx;Tp+xL4*!mO}8)hW1V$cZ9v+ULcFw$)k3*N0Ca!mlylPZF^@Um$5fs<)+B zI!)MllQw2C;Xa$Y&iemAdVIdvEpi2Nig%0h`CqYwQRO%bgr) zp0vI_{bR>IA`?)H#S}t^8G_G{g!Zy-@&Ge61KZ6mmrneLM-DrO`nA2vGu@v z#nrC>)%wKM_n1;GavD)1mc`EhX!dOu8C+cZzt9?%z`Fw2q1?n|;V1 zPOHrqk(97^l^3}tDS*VhGI=B0-U+p>H^rEKhNdlE%ZvH7rZ7ijAd!J__ei*N6XE9x zFih19>oK5Sf{b!yum_t*Yg6Rj5Y_afATN~yG#O9yQ zs{4bC`bo=J8JEWH%j!t3jnd3BoYlfuRwfPmJ`Ub)ki|{|2 zw*$He6qBytLop_e!0@kxN;A?c9< zMXNj#zL#*aWp7zq3wo37nhr8PE54l5b6V+zr^s#07ujyrI{Mt!Qj+(rJ}>7e4T_cz zXSJnMUxYB;g#90!g4{$32Eg6_-nqbOMk76L-_h&iqD91g2!jN=2c=w(=%LX zN_U3a#B{kG=5$&$W`=J#-DP<$lc_Z$vuO_V-nCU+P9{93f2l-*PuB9B0_lHX za1{H1aI+Ea9nZ}}IK4<)*7I6j8E49#TkWP6OSH&YMq_DcmU-W^NHa&yohqdGxR6z& zg4E$%gylUuu(3d2Ds8WP0t$(pqI$%497~%=%0NEndNUU~Kg5~DLqO}p@`u2-jWleK zaU!sCiDul_m1gECW`hhI|I*;3^_hTO&D-ft2ZI&qV!+DY#b<=Uxq!w5C?n++(kSLe z4G+VjbYT1El6ek@9=x6m+!6XenM6`0Xl>wGKnCsPucoA@vDtUN6jMWtyv;^i41Ba> z1H0pQ*CNO{xlt4U~grF96S#O^m$fw4BPyE_=(3x1gSepFx?piO0s)hXyH4 z3R)Cm_@V9}keJyg2d^x1$ZlltijH*9*VF_yX*ncN?4tK3&So`yum8Lj^Mti@E{0#s zR__6Yw=BM3HUb{!KP=W=e+*P{blZhcy_dFmoi)}06}qd4@qbg7HVj%GtwMWz7PM3H?z0{kb~OGjod7Lb z&P<#GC|LWo=2e&t8K~};b*7NB=s}A?Y79TCk-WR|+J`C$WG&6&2vJx_neo97@xK4e z2cu_;;BN3KL0b-w=S}jczLTj#Y$yP@A|Jv83_zef5ruSJ7`dy-y$%gdFq4{fI$X~y_lX^4)kJOKw?_rQ=kcEwG6|B_L|kF?Zq zMcVH4kGM{CF!&ITW|ny)@Q6uFeVT$;rs+nmv78e%kZm9dzMjolXeCh?|MIYm{ z6%C9lk5X_Ci|%Ou@G@&ZQG-YYqq!FtxlnJw2L&h}!}Pad=x+sv&=@ z>)Tc(2SGw7l{5+h(($3`Jwrf3Ep}@(9Zn45K9CO9xcyJNNX24313Cxv2}-EjoKMBNAPy?!MTUIc|87l z6!aaEh%gt8Usy!lwp(@|d^ko|W4hL7cw4V6o`eea;s=ME&5GpT=cqPt0B-|do;qBm z9I!W@S189_p!TwwMl zcY#%q9Y$%Xz7U7{Jx^X&uqSL&*_=FiqS$PlWKMbzLI|8)k+EsrPOp_EuW|Uo=dOnC zsKpTe9xlHcU|8gi@s<|Z#3e`?w%2WY09kK23=RG-@G12K0Yub$`TKe?<#Uf%J(mx- z2%>;S1(G;F8S1}ND;Bcmn!gRDn{NrzO;FDv*fQ9OR64SYepz&bmqF&sSowtfzDP{u zSYtin4@MMkT2l8i**&!G@l{T1NFa#%nU^-ofFn^?BB30O>9tNRBYvxwVtDlR2{>u) z0dXl*Qcs<|licmuQxGdquV=m0V4CJ@J3FH`!7vKcTyIUH^lR~9+MDWOwM?9J^3Ss_ zm=_X?#CUXY9(Xt#Rvnu^4AY=0d;Nt3X_A~)u+aqaP@Z4Ar56fadF}i9%xC>{a|JtX zS~gbdPXyLYMtx%oWos7*nJ9DS%u`I)EINjaoPuTA9AxWuGO(nHM7MTY6Ef$h^p z8u#oX$Oxe1eGmV_i1K68C&Au^!2$T znO`iD*8A4i+2ij+DjWe}Bdh^~n);F|5>f~R1+tJQItIY!2YdbS)B}6viju%|##^yW zb>Hl;jP18GT}fGA%*OE?!P9~^`>rtt(l4a7uxs_h;YV8B)VsY`kI>e;|T2#3*D*z=Mq9 zW_wa78atMVUf+Yw;SmlcRsjkLNd{sNkWe8fWt9+r*yrr3>f-f(4QvGI8_`6pJ!ec! z{{lPvy=%w*&2!MH;K2sox@H#2`f<5}cT8oh3LvP95fw+8a{Ro%M9(V(<_?rXIo1z;Uw!44nY;%Zgegf5h_ngr|yi<8AZ*GN3K zZVQ+p_+ooHOpKlI8%HMgGad&Dj~xy{oH!aqh(_kXxiMklYf$uvd>oY!% zf7UAth2YBp8`)smx!5W*-k`I|6DqdQ(tB;cK51^JIpw=s-bB*JbL$grD4dVa8l$N| z?S=4Z#Q;+4)oe=sCTL7_!Uwe8D73O`sX)1yWn+fxcwuzAf$h)E1{=U|+>%SD6-cQa z)eFI)rcPHN{U+rCOhY15eql%vmiJJ>6q)}L%)yLwGqss)EPOLVQ(W1GBno#&R!kAa zv<7)IWd3e9RcPu*ybZip5~(Vbf_vwGO}Wf4zUVs>a*SYn$7~_M$}A@66|R&qdD!NRA`) z>-``t^wc+RQpb(C6lbG=zz|mjsf6{`vjzvyyCP1HY+vrT4HheNet|vtGVaae5XHr+ zzk6_n>${{AH^heoqPtl{k1S6Imld<-22vFJL(~H~5!x^wJjG~t53K|&D`3ws8mJY9 zS#Ww%$tcCuPOkPK_1Tyjgfe^-INTR#Tyz8|)i31G^`4G?izZVB@`NRw+&R4g@_exT zK)zmj-#x0A4K}*9gf5=I&DR0o;7;Um_0ha?APxSu-v#v7D_c^GgO#KT+4AvY$sk=p zH9-FP6i&km$+HC!zjT?SOE7!aO{dL0pO2D|0+UP9rTVh18iUD);Zr5?0eHlU(*=1h z;VoC)wQ)YOVzGE3wER?~#A<7Hg244iP_;Y`9sFY28_V|jZVrsefs&IN(AG-n5<~~B zf`i(VCchA>2m>#wifg=mV;||}L;T`ShZDmRUmF8nszfCP6$-S=ZhBT^&QV42 zA_DzT)#@ptTfVsHkPXm@+GT@UgxiWYnR{k0vnEy^;ubxPP{A7@z2R;t{?}o-3$V7s z19W4`_y}4)Tv%!E|K+T9?&?VUcW#LcGILozHTs{(fxfU6*L1g|1Z&2s&#aG1NgesF zjryn>K2_}0o%9eA3{^=FRZbFruOfF`+-2_S!9$XlIE2vM`YoT3o9w6Ba}|RZ6n3-4 zTKzbOow=NYq!mmu5p0%$eaowK=4R?3hHDM7Ad!TM733o35}1TxG$pWp%q^Lzy;k5R zjBNyw<+s7AYJT4U2_O`g+H+Yl63NB>aB`?UaR#Y&u0-D4JAp&@z~iq*drJaaWoZ|i zJa=_jQ)F=ownw?J`%^q(XE3k5F-6Bie=_n1Y}d$D1bGXt@j#) zDa^>~uA!g6KJ76m2MCNl#Q%$@zS%VEW$QI1k@gbX$~ofu^o&}Ns+|)<7f7s8$Bp=q z4}47@?wK3iWJm+qc-iALxRC=}A65Vh$0e+hhTS=vAg<(RIB)~l4Tz-1ruqZtAV^5_ z+z)eE{Ulm?jgJl#h&XF)!5v|~YDvbFILcGRz4=-ymUs-KfM;aUsfal_o)Xe-2nZ<-J?1a3vN!!IOYTH-OZ_-N77F+E#Nl1o{@ z8u#*lSjbj{7~fKHMyKJ1`)4%TtG0Xhhd8IApO)pVDh-&4Ke7 z3m{R!9rCEvvW^F(5*-Bmak-!o;^yfJW!~Zj?LIB<#h|VGIY*$!f0lB{mwguD2Kuy+ z$X9@uZx5||Gf^zDBt!RdfyaE%U1nG46hr{ozn3Kq&IzLl|F#?Ha+2Exg45L*U|mBn zIixHM(qG9{TqIsgzrUf7-|K7BoamFg{YpsI7%$V`beO%%4e`*I6Rk;|?n@|yM`lkQ z>-MKG&&6vzQ4HObguGE(h*f^_kUu2)XN27EJ+w%-1&mkU{$V5&goaNsNQ?yED(-V< z3eB1az0uO{2*g;=_!+YUHGQTri#j|*|43$Yzy4w$R{`_r2|RxQrb}`>iAE{^sJmq7 z6jkr4OESgr;?>fp&~x#xe=CMuD$DJK=eBo1B9o$@DZG^t@Qav4}QZJavFBw`_ zA(HNhc$?;e`Q?8MqI`0{Nbtij{xZmp_b84JjWSVHYD=5xLX8E%@wvrr&;)^?R3XYs zZIN~{P1|8+PDk$R&q9$^iu-5ALM`-7wT_U2=yTD@y^~GS^y(2i$Pp zwC)zX6n^e@TaU25?MsgtH6s>18W*`V9LJ4Skpd)Io_Rj}12Vy{Aht?izIbfRztfq& zwZ9p~i1lNvqIwWV>B2*)ykSJumv`3@^6?@TZUeeSM$R98!ka9s3)*0cb%9-AY4#_0 zg)tt#h>xX&2q%8WDD;~0Q!)!#;s2qBey5jbTU%>E<&VXR(OION_7d)XxEzzFVe`MYue_Royj1+#77>4E+D=KaP z0|jd_VR6{6*b237f@G_7O90%JLTVN(=2I~}hhYCe9}hG*1IGeMLxzmf8fd%T@8*eU z^S8Xh*bEB}K9z5ETH}dwv3|{hhmu0OiH#{kFkHudq9nLo*FTJj7kKS&_u)Qt$w ztV&PJN&X4lFb7Cq1Az9>fkz35HSmfV%P3=;#7C55<2!Q-?)r%2IszcZu7Q^V*3rme zMBB_hR4Pm2|7xbVI7a6`lj1ue;hT*y9oV%47~*a&l8S8{_kRPVx&;B_3398^`@>5N z0eo+5D(#wv3rN7PxV(I8UZsif%6m9)#`3PNc(CM7SH|*`{bH6+*1i*(b;}j@B=h5^ z@Y###-j}A+(zO$~c(wkBy#VH*hX}1*0K9d?I!m~dG`~ey+xVH~0q8*A{xADeTYS|` zE)5tB;0U&nu+iVwl6bNnfz^zmo9;l;svH{dG@thPIJI=Vnb((t!}3aS(H+RxS!un& zMc@EstrQGd^=N3hobDTRy|PBnX{fBJ2ZsJEo?LuuY6HAsPLi@kg=!vrZ7_b7M4u&$ zp#(FlAa8Ewtk-k`S$Z z_Oo^F;Em%i2cSxbyaM{-MO<=CZ=)2YjG*I)pqLB88}o>(yajul;kuYrPrqTSi$mdw zRJj?(7t$c{k>Y-O;RW%H|EvzoUfCN4Y|s&_*2EXRXgUmo?VVlCKb?ADqC2hUyU@3V zXYM{k#K){kF8z0^81xOxu@q&-PzY*`czXMStJmKa2ualg!cd$qxP;doCK8p9-k8|q zRYGKP*6e%?9R@~o&;s2dlMX+bWQP5zHb8h>Nxho*iZ=WKH=Cg|1Q#f=Dq$>zOzrvC zd-R9ty-EfbIEdg_?TyM))1rVNlcc5D43h}fO@Pec!TdV$MpFooOD_OMXM?c05dZ#B z@Kb4@JNY$bUb~(>x)vWy0JARll+hZ;I;k`PJ@FqJII>EE$K4#j11}io)_pwf#>=Pb z5f_Zh60K80*RQb3eT`i>=g0~ncY$rxJ45G?-X2~oMXJux)~VIJrtVfUlcT_ua2Swb z|4$&o3(u9>6u4dB(MnR9r)ZAt@QN&meIlBwRl6dwB$J856Rne;`raU2z0O>|pxI(3GDf9`n z`+N(>loi*8@C74N!;ynDElpul=wvEN8*-_a zeWS;H_d?YWN0sz3W(%ZsFUbTk8R}z3QJe+qoXR6^monGnFbvCjp&BsVs41amHuM4m ze?X@{n=J|CbNvy;@Yh=`YBx_fqj~p;0g`roS)=m6E&j44k@F8<^xCIC-sOGjbgth| zmamrg)jVa5cf}_&tTYj;hWP&8U371VBn5sE^0;4Qm@*?g+FLA{5c$5EV3U#mB4Efbm?W07T`;n&p;LD7GlzZ}J_a z*$N)W*8vtQh(2oaP*_%8ze4bt3L;ouEK*5bjv`x{1Gk)4)=-&ezFu>!(X;yFTj`43 zY*umRj}jKKv{pYYiWJr5ad$7t5CgKB_hQ(CU9VlY+*;f=>;8CODM}hV5GA zOE|;oQ2MmO6hHt_lA^XG6gdV9kQh0RYeMWUrq5`p(^UwA2TgTq>ZH5B{LoAll&R3S z9$G!M`jq`rnbD(^iWPAs|0Iiq;!Y@;!D30G2OkcZ1QgZrTwRopOXS>TSy~AbsL9e| zBn)YedvU;oa^4%mJT5)09;I9_9^8;ni{L3S!GF4HWrp!`x0$mVGU9kIg#Lo^)7onQ z*itw{AU4x)xpHCw4$bbd>kK3JfbmS3C+up1I-MKXb#9@yOc$Wc`w2dken>jpn?{2P z_8~;umwPT!s9tpm|CM3f>*1X(`0wf+s{p8$F4{yWsM+o#jrf}_lT0>ZlCtUr`tcK* zu&FbMr6xh99xE*3#*(t@fy$C@&gPd;enH0!#pcJj*tut3rGeD+_sQXoK^q zEitxjCD9QOn>ILqiN*r|0ZL=<@Lt%ffW*=RG+79vL69pqo3jzo$~1;N^=3wX2+<0( zdn7IS*8BrEQpsIBlk{j5n_rHp2#?P`n0{)f;ZqtR6W#S_Epe7qu^i}#6Cne>l|uMu zw$aw8Eok?X4S;BTWYv7dpcwGAJ9ky|tud5(mF$LHK|g6;&Z-tnw_HwAfPq-0Su)if zJtVl&UFfJ&UfSbz!^~5vjP5I4#@z3Vf+?tmR&0NA)&YG4k{mx@KpV>GX8`0cJIdqH?n3tS;q^lu5q}pzKWq5KFckD07KEn%uYcx`VcRxxfOf%B zd~Vc_#=&R=d6cnUsan+6Q%mVGT6(&z5YII`t8>NYSPrt=9T0u7x@IxLr24op3E zSr-uzC3Oc-dxtDGKI6M6k@^4dLh2%7Vf-}?*-mDguXBivKaMs?uu>>mpc%S_S=@IS zS+M6vKF$?sF{^b2UzQg1tv%>}scW3sOS!mM@g}`-d?%#Ve_1eX(0R=<@P%JavB-x% zI4O5jEbn}YmnF-3aTNV@&9$&|Mf39bfZH4B!{Myj?k+SbsHDQ0@%=XS(}ocar+-XG z@k;8t+v)nzz#fq(ou*RIKHmzSZuKwKik3{KqTU0?1LWuVLApAkUuTAg`%A@6_aZ)P zKsuWcO$#tHsLPZUJ{$?~YV8b(CAs;M3T~Rd^!u(5}Zd<5si;0|`;r#;trGF5LyNkuBHp zT0!si<^0p4;PHj&P?Rgg%3(xaCZ=@%YdxS|tivxQYP%;+xCWwsEAO*@w(lB{>79H` zZ#%tDp0a>$GZfh170lb-V85?tkJAL+ALcx$C*KO0IVONVrGdftG?&Gk`+8sEmBQuG zNI>9u0Gz?dP95b_>mQk72Y(}AX}zbn-yQNrk6{^(y715so6eMC$^XUs+HR$v>QRtf zk*P3Y7Cu=2hCQB~Iz}bO4G>SoGZ77Eo0JoShNHRJLksaNV<}H${#)1rs6n!gM$#fg zqQ2I~qib8x?1n1|4}$-ba6Lb}##n$`)0XBp8oPYsSbq>59PBz$N;t9QBoT45GjruJ z7+dI<+_rR@l<`M-LW!^dYV0QCiDK3iyWWnYqb+LtJ)hvh=b<&RoI+PwZ^w0|W%V{z z#gn2iab<-WB2U7}CJ9;%>9)S^v1deC zuBma>-g+tH`W~ZrPL}09H4xQFs@+J)>AI_jjQU{*B#H}q)Nzo3(fkv-iXIfduJ04B zb-Ika_9046@1=v!6>YeTQb_!#zqLv6f&S}x%ISK~WFyh26z`E}@%N?D3xmbU?#U>G z?oABNRuC9_Y=OPm*%^*UZ4VpYVf4+`0k}gR0xBRvW4nV>jFEce-LgOhz0gCNR1Pw{ z*HfmF{>2+*vkH9*{wB+dBr|%uU@zY^IMs4IRW!S{t{MY*;RwB`>UL zCS&P+hNB<=dSN58IdprUPREi2Zb|50L15FBBs~Vs5>x##RsnAv;e&AR6npE6xox$z z-#EPSCD^enu4(QoB{p#gz<<@)GS|o8vSf2--hFm*QOA!GDHjqSRr+?GIzL4bg;YIr zNFPToT|^G{1VxsKSKhY&2$wKtlb8+JWANj)Wg5a&Y_|4aW|-EupoS9tVZ{Jd%Xv?N z{WAJP5e=#;;|#Zs7P~c|Y<41Zv-B)u3a{T}=C3UECjnd_&<~%?uKaw#TM4-yN+FH) zJJKyu@-U_puA{68W-n(>z{=9FaDq2csvp$!_2Az($PgdA;ZFUUet&5#o0Vvl8CCGt zuzS=XvX+TXSb?p>jL>BRtgm-w1_@u_;`y)Wgeb5nU16SESqV(4%h5M#{(KoWSHN8c zWk+uQUV<~yz}It?)35*;scbpz)v0|t>E0pcRq+0w20hB^=2b-J)JD~ruznCwJbdq) z)Fbgttkv3`M}XtzRw2bOd{pVS$%)^|QM_$-G~8Hfyk*3)#;3b&3?u5n(uM4iL44hr z!O=7!RIw%Eos57QD6>NFaN+ESmMwz{J`I2h7>j7Y7#h1UgMkZ3ql1{EJ&62aOUt-# z5B7TNrfRY0E@>1oJ4V0ui3Mcnd|w`Ev89%@oaM1!x_EsoGZpZ0Mufeprn+hU`0f&i4D*E6o7}GW1k^`p<36ukT)NP|oXl0}z_7H(t_Ma&_RP^)%Q=f=h>WF3 zPxoCt@?k+mht0ZvXYk0qN-y7$Pq0o3D)tAZqEU72t+w+nEjJud3ejnFx{f2|zDF`b#G>qA9>mV{T^0aZ43km zPr9Q7WJ9gcQJ7R-u8pvg3~5h8zppr%%w2{a`$pOcGdkK}EOGMBjZXTKBuBUgxR`U3 zo+e@A~X+dC1}{kQr%V?GX<&$M4=c_kmuz zC)Jj!5~SSVt2Cn;F{iWv^wTu~wdi#wD_MuXJsUl-xo6&uBe!Un*tq7dfNDA>7=Z^4 zENvC9V0C*^YdS0;{WK6|{uh90If;;4O`YC%pL>=H)ZkYcmP_&CX1#eyZPM&0(W zZsA8aQDb3HQ_%}XICOMlvEz9}#w{}`Ay11xxXf7-b74SUB7a$*()uo6O*-Xx+rYAG zPrxlhWAn@pw*wN(6=8iJx)jJGMZ7aFWE26+qNy|Ct-T0)n$w?W02c8U>(zf2Z7|8< z>~B{T>`^DMyavpEUxaAAL8i!WC)2E)2R^D8N7&7mB|^W@p9YKIrGGllFt!PFLJ|qw zeNxFv>r8w)PnC8#xh#IzxU^k_B!;`>|F<#@ z&|uFqmYy*NTx^Iv0bT&DRV{4npT2cec6Q-hWGFHSQoyW`Z)mYj_O{RUD;+7KMS@Av z=>T~Q(w8CYQHt40>ArT>OtcN*92IR=o3lZJQNZ{j=izOA0%B1#-*+ZJoSXD6nUSC2 zU(5h=xsa6IEFy+(Hs?mTYHufwN0@e)Aoz2L{V7){$Dgw`CKbr%qq5^VLQe?bow6OWP#IBX{f#9=5 z@}l$nyAbyWUv@F|=;qJJRvQG^sF+(&y809aWn{Y8CD-;VeO+TjZLvSqAy5XLE3s@b zi&;^aL=^=~gBYAvM9xT^F!R+EtB_GYIW>{xjY9MECX+ATg~FAIC=3t1lXX7Ejh!0m zX2Vk0&q*t&Wl%f?Ii*?@R-~zZx>L-ARhLRXw5IUG^x$E;8vz;6@=sMskFOs&)Ga0R z4VCN!S6zFOF$l{B_KprR;ZlDJ*rd7D!0I`&=)Uuuv&gf`$~WJgMelsVP5(#Tn)KYI zL8eyrbcReoVJYj}Tf6Q%O|{F8U=*^$CBD>-$d@<*$Le*w5ntIPt?b?8mQp0x1PG3(i-fqj5pO$`s9`jz3jZiK0^Pc~pOaQr(H!ZE=g ziIr}e+@iChg(5neOowCCjpZm*9ckUldCD*W9A99525N-u0!9`#+}KM{PVB0W<9Q$w`-_0HztZ$X0J?pOCifqAI8k0Ss6WKSrFU9Y61|aC!3}sTr za+mo;xE6|%iW9%D8?j-@FOJMrM{;rPEc@^?*Y@- zKib%n-HHSXWD|Es=+{#t0B835V!4&ki}TCOF+vdJlNaI+Lxf>6C9jqpSq!LM+&?uc zOCC5g|5?0$(3W<4=?~@|lgBcKO5y+m-u|n8$@{AJJC9S3q4bJ?MS)4%ZD8On7Rtv< zU`lw#&tv4YP}0mRLW}1%r9Y#Z<(#L%GgjmS12}D{)jB0x9e$6~hjlfM$gnY2V`Gi5 z{i`(=f@iTLrzRRZZ(zvA+fIe`5d;kN?qxYrr%63Ls6GK3NL`$+nS*|d>VyjO-;92S zzysh{mJs8!8CP4kR2I6ma7!kN|JSibdHp$t?$5@%=EUjWB_TT4jC1k7H-;{5h7uxI zejb7|j|VAzACh3&1v-Hx$Stab`1};Zj|$^^TDG2gNHm9VN;$H*IGA!pWa)2%Ib@Rh zkCT(Hn0u0&PnprJ*(tueK#O3yH8NtC#jxm*AzV!F#>AxOk~5?}rw{((YVb$D>JMfV z=g9c)>X-=`sRNil$QDUJv|`im2DjFKTz(npN7(*CElt#=sm%*@J37PLg0yjD-gY+mwJWxLbv zj|Vjacf_s6_EI}J8X83Kxku7W7YfiSjBi%jJ!5mam6uqq{+VX=hGunnLy#8_IS4#S z-k=Aiu(!jB;(?iDys0Z>+M5B*5q#!nMLdQ5AeMBrf`{c+Cd8Qd6`;3oemn~l`ug~& z(FV4-WYao9$A)#qC}l7n>oMU~?X4xK^uF7c0qQV+)D90%KGv#J@#;G)SM>Q;ccvl< z-daNhUy^S%eG3AK%^FkYC9b=T1TJDV`cPj*8Kbeq-J9*Yv>!VO1Ea$JeZ*ay&B{Yb-iDR5 zeW*w3_h9e8I%A~WlNYVWRb8OM$+zo)hv3A7Bb7A~s+4))Ioi4zL37tJ{ z&zdM624934QkU!+5$XlWlrlbVJxk3~g7ZB=x2%^@gY9wmYW*900-?>9vMe#II&J>3 z(6=mk4-qz=m;8^+0wT7~zWw*1=?vUV$>J-2Qk?;wU#EJ_A1&9oQ$!v>JV|dwgT+RR zmwJ;nA%hO2knu;PcY7vuzNc{Sf8|W9c_R{uNDG%X5 z9|E3yXsDSOStRfiustz{{#I`i_9bd}S$W|T{bR7h0^J^wUyv2$n@s_Vgrzp-s3ebC zAmrtdnEdPe1xGieyd{1td1~bP>-*41i8=gQg;vF;^t2_=G{%q0eb_W(gfvI8 zO=;$Dub(gQp7eaKQ=72xL@15Ah`rPVj`t;V*X96NUtJ8sECZEd_ee)P8alc9ThS8G z0f89Dj=j5jxE*krWLT-?@W_UOfK17iaNEXgoxZF@Ef@*AW|p8mG+yCYfh)Xh#wI#F zKU~xv!-%~SQ;(ocElN6Y2QrE+C{X1vai&pxB~?~PNBEig8@q=*~4 z>#q;uKTB17xrw{~CL*7hj-v4L< zs^d+`73|gC8+S5WH`II@D4*NdMaCL62hjFs`oXLm=ho`#oc5*?Z6)I3k$v&U_{E$I z-4diD6f@HCSws>@B_JCLU$23zYo{&y$rKzmgMmrf>P?)3uQdH47oCid6;FoRZx0 zNKpe_E?WdQOkIRDxwFGhM4e6O+D~L+}w$iJe?o?ZHQe z22b%@4Mjds@973v6E0tYgS5+X5%+it4>$>O8tB_9Sz%7;_XS4_t|ELb&F8T{6kwrM z9LuCFy;IvmO_6oL10?F@45C1YskuBpYjoy;8<74NPV@N^Hsx6b*d`2Iun-)brwnB6l`q;O#yb(V!)9GbaDOJW_W&4q& z_Up&Z)hBa$BuJr>?pfeqm;~RA>_yQf~b=Dc8#adgZ9yqnV7tW&tA9!rKh{8igKLli`K6{rmpgV4muk8{{% za@#BIUS@kS&tfmn;9CuUZ)RQpRGaNkUv58PWjH-A3n6S+5{?5)gTPYT)Oh~VpT}bw zj}bR58N0mbLY;ahga+-^tr?vp>7#ES4F<3j*4}J%VH9Ra5swBl3FirPs_p{c***$I z0Njbu@Xv?}1*LeLZS;-Mq*y=7o#m1i4qOC5m@y@Li0|&l%SeRKcrIy0Cs+Mri+p|| zX}AZYm!fQot$k47uF;B}+RGojmF$BfW{MB&0HRGZAOpOv*$Pbrvxuw`Gmc$8FbF%d zzbNY?er%vBtTHq@FnuqrzNoW;_`!Uy_~nAjPzV?1G%Akh&ufapa`KsC5GvYH7=zYH zC%*HKF+BU|5PQVvjElT!)UpaMgsm&4nLEZUARQm=6CGg~f9UlHLN6?B2^Pk9j=L-? zNKt28NK+u?r^dDgwC+05qn-O586QnB#M+5=!GZqD|Fk(5-BUPkJ-<(kdh3 zlWcSSsA(~MaH+=qS@;L*!H}wU!MYj59yqumhfT79DGg?lsaA^Tw1J)L4691fwj@TFhpQ4~3TG~_h*5%xiIrLMR&)w z(r#sBF5qSRh}5BeXb5Al(@#LbI^IJmld|FAkQ>3gUfAiuC=`4b)bv1_^U^t%oa&eY zPlJlfn)OUiw-nRty=l|cQ%F$sW848ID(yZsjiDo8IYl`}I{a{Hr>pvhn56Qg(;ZXo zXzM)wP%^UCheKLYmVljLsRb>DWSc0r9D6e!S)>10F|>w+E~Yle8Y96h=4hQC{XqR? zJLQQkIrf5;BpZ+{lt`YY?ju-sxU&M^2o7Aq(>yP z&l1@mfqR70q4R1QA(bR|AtY_GS8-VOE z8yRwe1$tK*|Nl+cxu88+A~*1o)36w&zYPX?><9ng#Ptngzf(5J{`Yv!TMyVUc?YwZ zL#(ZrzLK_#b)PY~t@Yd!9%O?h>X~(E<6ag$*dh=1h`DSBTbxIBP3IEBiYq?+^to!J znlRQ4+5(iik%`O&?6*UV27p8;!>(Y#O-~p=-A~&Xge_=?Z=M2^IqdqhWqB*wIh)ZQ z;3(7D5I3lDKN*O7)X;e;G>!mwCWws6bK zQ*+>a%%TWnhPBda6u*4}$}P4%?e!*=ZZG*w2H7xrRXE9Qv(urIqU=*-g(}#9Mw=gb z6Ms)ZFI2;E6dZ5e=4#@vf?ei$>iq1QsJP{+C_T{cVTXl`Pi0h(pU*;)zGl=YgT2ck zp<$v%WTN<~gHQ5DIiK!~Q(acd3_Dz|Jluu;lkMJFYbo1MYBp6|ILs3fJk4HM6gmcc zRqUy$FVff9-z(BExK(`e>~t|G!b7wNCNe143Vb52_1+t;A@AmPE{?-AKg0P9EbkI~ z7dnlbB!elYgcgnS8N;zE-GRG}U44)>)|Z2u|M%E)ef*=L;$GHA3$OfWB#_%AgpyZN zh!IEdcXmd8PpI+xYLAT&8@q`c9>q9!nyKe%UN*)7Ff|s< zHBTeq8NLjX@ws$%bZf`;y42xid^b_uaE?eW$}x9pTfm|pRsQD0cnmcSA!IF2nyt25 z{b-{@lB*VGFtmGpP+hfpTAc9G3s`O9g*@Eb(+kc5?}1LhL|i|Jd(1wr(0)8u}W$3IWO*R zTqSBvk9s+5fL(;wzv0JEY`Q?bxh(m6&_V$k2i-wlj(})Vq`(ZM#tW!#3BnKoU8CY8 z-&bpqn*mK>m38T{uJ^T`*;{14072-Zx|n?F^Ylc@w^$Fip0ui&A_+6~k$`VCf5G-j zcB#$FkhsK63Uf)}l11{8HcC(}FrHC-NO&eQ#Ln)Z_#LX#Nk9eN)3qZwyAs8HisCev+7oj1}j1+5$oUl>$)e8V8H zbddV!xGOip^`(vfIapSJyXAi=tESHs05cZCUB?_G98eG$MBg?oNb5{A54k%cB9CtE zC_RVCL-09a9+%u6{fh_`JK{mCAfUw6kNK%#ym$x>Qoazts}M^;7xwR}v~P{rL$L}hcu4iT`Idv}ML(7+-Kxd+X9x-UEV zi{{z`Xw}ghjUTGAktcUaw|ge-yD*2KQ1Bdi3V~@cST!1wJ`TG4x7@sanI?P840R{? zzELeJ*b9uokCBKMD8H1Aws5G%O z{QeP;an?t5BE0hqE2(;OA{z-qNZ8dhmS_dogOu!)}BXRJ-a-S@nEY+*R zs4_@$Y6W{1WM%P88_TduUwBuxBZNP8Z~ZLPO09(kd!=dOZ%oP`j_Sp_^*(p}E_ARf zBv}479&SnSAK@Lr$^G~lOT;QtSL0o>%lf@18W04f@onz4Sso{EII*nQvHi@f(lqsA zh-1L)M?Tn8Mr%Vua6fZiAF4^&FRwiI{aj_8;0>#_rT41gkoZOLsE=aIo-H1)EJT|b z_vh+vMZu|uY)J9Q_ksgqx6SY+qnmoppa@?*6u3QAJoCw8iP!XRm=d)|8@Lb93(rsH z5`P7OwLO}v)aqIMX1RiVpb<-k=?+>*E;w!v52`km9-fwapbLGb(}ev42h1TG0=U@O zKZD%%a9Znbu17ha@J64NvedJb%;8kBm_^|gqK z6}sWXIf2Ysxn63Qn-W}Qw}Q@@Mwz7=;RHqZaKb(

>K0-aj`?J10>mD@_gEoV3U# z_X+-(F9r=-sx*&gx99IKt^nOApd6o+ueBhFb`k<5?f}yY z0M&(vVn_9BD7ol9ZK8eJUiFL~j;T&#$(JTD@)$6%gp;>hp5Dy1_1*(ln?xIdr zPJpxdf#j!i@C#)LD4GzsDfgf`6o}rH&v&$2^$XkYj(N+q4RK?yh{K zj6aC*z%B^%?^ocNPfo3{cAQ^|!2)0tWYvD`#L-DXfl#aH=Zr>=y*QAsQcTf|6w^p6 zpfnq(ggGJYRXmy>Dfh^kW`!8ZX(!8Pj&MP#7`-}EhdC&wU~Q&72i|su@W2cW47O8! zkLwxe z1;E%H(uO`;t1Vsry^R5-BOad0lGy-N0Nv5ZIS-!gsZG{rQg|Ma_x`yQ1MZ4h8Yt=l zKgi27$|(HTb;M`QriT2iH)ZEG064xYtGXxpOT$oV7zUu{O6w2auA+YmK1 z>8=@8B(=gTj?xe?)aJ~qq<_oBnduU+Q8=h3Y7ZnkTJXP-A2y{r|5C)_za5$06*-Aj zy=hvEIV~-<71{gce*DKrpf-PUc{x1jh7&#VOgtC4oG-|*Jm7##rEY1yMk^he^x0$> z{cz7CMUfuuHX zF9<~~kW01{lK6o8wn40@JL2$cu}e&f08tpLMAO$b*H9%i7RB{vAU5y@BQmafZ}xISzE1^44Ww;Iuk{8KDuj91BvlKcLT2-p@i#+L}G@)+sxfPEU zSY^d~=@s0R<}N_Yft(8=N}@Y{1ON8-^kD_|2JtSuC^jndGqS547p5lRPhBL(U=hlb ziXLym<_^=yWT0~>`5$aAzLm=k&)51fpD0)MO>B?^`$WUI;#M}Vtshpme78RFuFfLH z0!P6J9Ce%-pVdEb;@`j@j0FXA<93BG4mNN@Y7U|8`pAOnIW4;?*fuw~Y;BXN{YAoT z440RBgjyOLCm$4qSnks|R{E8@s{I8{b=%i-TsI^}I?Voh5a+Ny4)F&=pqe=b@K5vg zzWq1SA$&-QmAtqx)%L|3`YYp6fTL~Ld2c=;Us^3^0b~BY8grA6@UVY9TOs-+T=!b# zsiR`J;_CZ4)K+&JT~bdn_1^3r5xXy_H6wg4oSXkwOj+8xg z?x0gLbfKe5jme{1WW`k~u~#wt$Q4uyO9W1NwYJ9C&3V})Qc!Mk*T1q66EbLw=1u*o(%WMsb8ctcKw=45`2n!7IRDx%)yLLJBdA ztaT-!)LCL0%pFB7?1bfoXcvf5MV9AE^0d9&Mqyl$nFc~PphR#b{%|Yo+@w7au-f~I z!n68P?FfcXu6O*CbY~mWb;m}oBmnM3SV`C*5V=3V{uQ|EH|*Wp>J%*yD!_rC#+|-T z+7`a0B=kY)Fz2`b%^xj&)ysnD5=pUXThJ?n$3+nC#*lZg?3(L7f*qtZhqP z00!J5ehYsP7p$|equc+D%vyPs;oq$~G|^ODBv{k18PN9loMtTT;A$m-e?-Bm0ghjylXc^yhIN4#Nx zmns5a>1d__*-ybiB@ox5e~j_y*=!%Gn)monS4c@{T0H)}o&W!Mg|Y_B^=Rw*-Da2w zVWj2kIH#q_+i%gPPC&;QRurR_EmAeo;wEhatK(+_49^T`sWHFzUO_Eaf=E5csjTF< z6V$kktP5C(0>RHY|Q+{GH`KN`~A03kqfMhsYo*otRptVwh+ z@0}22H=XAO${+Ngh*{~9W=l)|&7dIId=~$dj>9-UQXG-(*bQ3A)R5He+0$L9awKwq zlC2_FFV;%RwOn}Jc6U3^var1V9tLlRYl`IJ@oklf#IO2*PmV- z)AQ}W0#GWpVx0MpS_1XMiBH*@X3SySmIPp>zOv$$wKcaFq(6%lqPThX4j^DcP%hu+ z4x|x6a^p~f)Wn-$$iPa9=jUkgtG!}NkOr;_iUU&JJJRS?HnxE!C9}~u5r=menGkxkbk_pLQ^t~H?9BIdRk^83sviAWLUHxx37gP4m?VV5%U4i6S&Jf zBaLxDZ6|)9L?m{+b9Vv)c0=tCISR9ucY&V}ufb1Q`V$;*FW4c-$!Q?7t}E?VVlG5; zboUScl}{vF zt|Hukvi^5 z&WsHwss4}@&Xf5MTk!jJ6N%ZkbfjY{} z_4QpOG;qt&w4n_19LoZL>k>^zXMMJ`z;kaP^Ng+Fxd=T`#Oe>1h;&uORJOs+yFx3Z z`Cu=qpIc%SU>Snp$ThBrpMN-cJbNR0#GT)O#{A{eF+UMZf|}}xzOvhfI_MGC>B+pS zPbZ%PC?3|Om*7-mlP)e;rscNn&&gf;Cpa_9u)HJ^WzrqT1+#@q!nh8Wcc1y)OEi2x z;$@&;fJRK)F-#^>VB>Mbx|y@(`l1)mP-6MWgJ<6$fg#ssi>*}8+Jq+FA^V-7Ny>7s zH4B-wWWVC%QVv*ZzoZmy(NsDBW@kDuO6RUXGL}<$uX2}gTiqj{uZ&}Ed3?CEjpPKE z=_ret39ZiZI`$uY$g83eRq*kqofSCi>F$xFy-*J0i`U>!_DxW4I?>sFUGdLw!IT`( zMJ^F(q%`v+r@XuM9R~Dm3X1x)V z#lb3CS-)j4Vv$D+>dBE1_U#4?@e4h%9?__!4zijgOuz_vQ#wsWg5FHckBoIQ=Yx%8 zckE9vl(;#GxaVg5+&hGp)K-V?4fG>O-Slz&3dbZxW%XwFKUGHd)E_2k?M^XEUXE2& zu6WUfV&+s@%{Ap`KqDzqFMYzAB;^b<+>{n*%clQPT_oZ`626SeeJcko@iWd=G=h!+ zqm%$PsYsj0d-~h-vj6Tt^O6D}WuLcr{MkEE&!$?QcaAK)Q}}j5?`prEIGCBAhY*?j z)(klGx)jTKBEe;g{i*$AjLyDu?K0A#0GY@#PnSO~C{Bst7`8HPx6z8G2NGV$TANGT z{)b4-1L@F@KNhZa(QH_$8kgThK*=ihmWp!w(xc1vo?Mvki_cYHPj)mBv9PgF2c>o! zauiY53j=G+dEqYE^wn%PykMX#5z9P<3( z-i?SQ@DJ)4aYaX5ZwVxR0QQkG61<#jg#I2AU%t$644Io$RJgub#i!R}lvbW%w1~7K z3cw51^M&0ksb7ecdheq3cn{HqCCwokJO`Bs2qqDG&8tVsb+0{;6elEuM^34lvsg|i zD@og`&H=C19;oGUr4;w9`Z-!KbY?cPJX((56FUzsR1=>8;BKqGj;Yni;gg8-6)nZe zvti$D=0u>q`Cs5e9o3nU((JJiCYcrv-m^rTi+GfNCace{ z4Gk3i99|A+wAdRP)G2TuGV>QUC=>)-x~;DPfH-7O$;`yLd!96WZ|4#%<6v7hTz|R5 zju98~NybvK`vpg4Y_ z;Ml@mpj@omk$;0K&7vQ`nj8r|q-wU1+q$Aap1mF>pZ~|7#lWM99DM-Jfvtj5DlC0iWSPBjR{W3}Aj_ZLV~&y?YLo%^m88V59^P*(Z-9kgAS z|J2{KK76W+MF@p`%f8;kBKo;i2*|GWw2Pp6Fk+h;i8FhHQ3s$&Jseq-r`E7He_{{W zd;LC!vuoQ6O8C^v>1?4kO)u?wmEx>xZyw{lZk2cmb_w|ibazv*!I&;P@TvD6`@e?` z9KnO}duf)GL3Kbr4Iw+Wf-%g_0*X_Tk@wlTwxWHw|sx||+Lk7bs z2?pt}Tk5MHn)eTU8PqSW#eXhr>^gG^f!tnlKg->4Ku>_Y8#Lh$uqPN|nX??Bwgh?j z*wx>4G(c*E;{|p~9pZ1-`j1ULtbfeK-hiAPho~LmF-FF*A{NG^OXNv};I((MuDo~& zj{ULwPD6Yyo_CVhM@K$)?q4crdy(B@O+8FEf0R zWr1jOe$+a!(a?HYX#=A;q92I4*Hl&00Bq4+v>yYO*fx}A$RmKN6cY74^=pZ(DxYCn zD?$+aIRUXMjM;qMzSv2>R3rpouDQG3w@s405w3$ zzhWC4GaSh>7m3I6QQif08c{mtLUUVRxJPJ(FB18%4Cq;U@ZY*%0cu6~>|}|REjB_mZ6LU)3V)y~FWRfLT4qluc^5lD$^&>D^0$v;b(1Jw<8J~&2)~~6<|}mzt|JL zl@0FahU`gLutS~){#U7H{O2prD{>mbre8$n~ae^LR!x5F7daN+tpu;KAZou z>R?e?bR_aLg#oygS&>+^XKToEk#Cxdmteo$R z92Z~eWnEE#vU1>#mXT8fq)v(DQN1FBfQs9YMq+2H;&fVKa-nd97WQ*{Vo^0SZgF$> zMstwhvUvT&iqR_y0Qz)@65%{n^u~$XU7!?eycNi26;2Mf(0Ze3zMoQIU=nE5dZ+`%G-8s zB^FN04>mpd`5Jhl+QGfc+KU^EO5yzX%#@P*HZCgKDzyl0#}n9O9=|V`qL11%)8S!Q z&TgZ!B*$XRUvG_#fh4l>fzGaOyE}Qc%}T3xKqbG>|4okk%HwbMXEVS%t5?1(u+5M1 zqSWe0I`&SUX5=atKlyXP9w5gCC7_?stK*~0`3JpQ@5)&}8bsMlQIsdE<#lPx28rdr z2Tg8@5CgE|VPiga_9hwtD_AZ&QJl|cMnB=DpX=y_nb>?7si#jmmw2MP@8xztP-z8> zpsr_lSMW1-S#KCeg%gz$aLc6G03D9S>?+oj$8g1-T7#biLs)?q3HnvZ_Lcey-;b6K z7B}I|0JxS-w3C7B)$)=jI0qg%$YRfC-J&`E(DD^Tx0$_R?#mJ~8uTki?Uaxr|7`io z?EMgt+B_Y58oxPije~TY(c1`#NqnYuj2?~P4A&YAU^Fc({9ztxJlTl{eEiPAxx?br zoAeKPPg2oz_8otC0B(^MKV8QFtsRQaTKS(e+`<-$Z%kzO3pjP4`e&5Xo9V&0OofMV zlTl=?*FYR*AWIxH-g0B>%97BP?0t=xQ?Te?ZZhQAqmvkhSFR@6+(CG+xf@Xr>5pyp zK!mU!u&T(hL=e#-o8TiNMxfZU8vkkB9&fubKdn@gnG(N@(J{IIvnVG z6i{lVo)a+rjf#zI$9Rh;;jdO!x90y}g4C(B#0t-52GF7XPM^We|1e-4${Ni$@zVk) zj3e6CY>LJSPtO%TeMMYJ*>A>s+L}t3>QZv5If$$En;6Wh3WvQ_)kGLRJXWzFq~z+V zpL_ZJ30MS$v?h@5l{t|Y{s6sdV{}x|(dpJO7VVjv&;72iIF;M&zA~WBCv3C4<>>+h zcfAKu#bvL0;xCuv4!#LBxd!G9(l&cML%`6>rD&@tb`=d_V1TY zwJB%1hdXOw?u@;{2pa{F_WtD9+_PjinHR?7=)C8!1E;WZI}Xu^ykNsv^8&E(BUyL4 ztiCz_87Cq)_m^wYRc&HEx$67A;c=0#)J_^YQhP*I?INjitcM zMwszlwNaLO>|v?1f2SoO$(dKTMc;=+19CE93&pm2>tX5?Q|q8L4xmPbhYA}AV>|NL z|LL2hUuvA|lP`x^{b2ToAHNz$DmCV}Qg6azur^VAfZjOA1WSJp4SCBZXT%y09$*Q0 zE)mQA^2!SOg^!w^($}~hO)y z0(Xx$0km~i)Z8c;bJP>NrTG;UKR<+e$)QV5+iB)maF|Hc)E&dkq64tb!T6$f!sKou1*7xSy!pj}F6{D^Cy_FW|F|&lEG^&x; z&m?%Yx;r=%1e&)=!|92w12A^{x!W-1{8ika8Y{FBr^6U?i9J^O_=y z;yg%HdI6~6s0@EH`_#@ z=U;OzSgF%F$DOM3VQQ(PwD(i_L?}`2Z}#M0i+2FfWlDQ$V$cvR@;?zHXVrN-6K9Y8 zyHSm|M>g<&TVHm^;mG`F0|DxF(yO7T!UNdT;rK-nv?;Azkq6{oslrs?@iDvN9P)M| z*9wXX$@-^-`6ha!6(&{Zf-SCY&&}DQVd|y$EnjB1PG)Jp0yuhQ#3^XU$|8YvhT2tc z%x(K9Ix2PYylT?y3W7<|@k1we_y87l*p`k4ZY-qRL__l)y0O8}aZSBFiuRqjZ^JYI zaiv(*E;gY?FZGI7v;!C$+>dxNh}n_jkj0N4j)?}iOxGZrG)4fko$sYD0cO|r%f>#Q zsE#*5-nG^x^M{sw8eF+4VYW=N=ojs$N$CC`Cf9k5b}+g$>B5C{OO-b(Rib%U*h0}K zmYU7kA0DIhh4On=SmX0-sLW`8^YvUAp5#d0^bmg-xYkfW0OcK~uGAIU8nj*J0qhEN zxU7?H6ClFKrFIMqVzm(Zmd;@{DkmG-v-F~-mDw*iX`Y6Ne%>tn7lFZ=fGD}vG2}(p zo>(tu0R{xMEy9w5s~Tp8Nd+l6Pa9fpPLmTi&{xJ9e6;Olh}uyvv~DPWXxaIn6t2tMj%`?m-@Vum zBYaplT{***j|~HHd@Jz`4b&Z7UOMZxR$W?^D6cw7%Cd4a=PWnS5A+Coa*{=*8Re1T z$$Br7Ky8cA;cS_F(ibs6`9Nt_JR<5hZw`JQLBnXvgu>@`-Yq}oyqB^{ri8sSBDSN859ey3jGf5qk@I z)WQ@+eIx<#3lCf*WIvL&Nkh=M{RB;1q0jWwAulTaE{`t$*C+N>Ga{H`n|$(%6pr{1 zT7`aW_Ll>dq%mbC4c=P?P?ndFn%|1XoM;ADbShH^uK--7X8^XWPmQqCIP6Dj)wwDH ze<`(mDmsNHwdOTpg!U!zQs%aeZ0Ib+a}H25mLnM zc-Jl3O}feX*7oDHs391cvuXD)>;lXbtqj{eE)p%KlhgzW_ePYnl^*qxvt1@jgy_pDkNmeE1>ygf#hkO6L&6l zIES)k21;W76jR@Mxj3E0XXWQ`)fiEDFWCw6DdqwU2498m1kACXC-ocgo#HhW8tCH0 zCk>M%04x1bsS5mSbBfef;y8&ZQr0gpJ~Dy)k4Ky2;A5R9hM26<2sRjEmOf^W#67=9Rc3f<<+uA`=v|uBsYV+7Lk31x+7w!v1D1 zFpmld%~~Xf^AB1F&JrZO>knI{uD^W3g`(=xT29Gut&caC#1%2}&WrIuoYP&(jcUYM z+p^2s=KL)z%`li4^It(7X_xJ-<~~u$R5hWKf7c+Y7VPQV=%s?0 zer!2oB(5t{XYn$z8}E0GdjT3DuEbOVa zhn!_}hjU;6<50osH$_A(EBrnV%wXE@Wv7AXN6+}P>|h8dlBEDDM{xhS#!S)xuQKSA zlYoJ|v^+8?MdupTYQh58}h{Jp2!%BB|=+6NR|w*T|T zb_pGlDyz?}0eu1ibAtG~iRs9es-zl>u@Xu1Vj>Thp#NfjOhCdkg^2)`)s5m9f=ftr zk!Y%huJ}TAeUu>MkpPLsN#6pj1^}HQ*HytNvX=IANs|Pp8Lsn`%#9~%^K>claf16! z^ZvN$V&1KO(1t)mKNH?9{tg9QpK!wtPCY#8rLf-J|A2}7nJux{u^m`tsDv_(lMW!8 zYWKUD0{!~x*Z)W}+v@&Eq~-WPYbb_QB!wQ(|K zc7Ab^Yc`yFpPU;BXl+!2JMZGKtg0#h7ADxAkbAh&^k*g}N5J2r!T z+N(45MFU+ZQ%#X=wHsj({?dZ>1jeke`Qk2&_m0y~yU{muHq-_%Ffa!Or$tS4ift}p zfssI?#WmF*#%Z)N@$iwE!(o6k2$X0sqWz7eh*IpUg7d#&za{swayXhBB?|sfwMElA zKY_krmPS}m9=2h{MmV8Iot$E*aRKY9gI6@%pDP0zbYZQQXeD51$ZrtjeJ?3FmkP{? zaza%rwKCfUPrU6MG_sl zNDMh`s$vlc#Xrb7qLPT6uP`GnY5tGQPaG16O+4D&ba26nGqMh)kfBQB?f$&E<>yu@Yl@|UH{WwG+3rcN z3YcVJ^NHCcgDh*u?P|p@EuvP-#J+d4tee@|R>9$cu9k`!rt%9Y2iZW#7)k_+o8jfa z4D4g4H#i#MDZnNnB>uuJjOHJL3PAxbVDlk^CdD~YEwV*iQ*OJ>APs75mr44Ux8PBT zgTm0z;thzUcYlRH=sib`bKS-Iq(4RK34e381Hv(e!k)?qz)sa1XbEBwWT1OkM}=W) zQ{)R(4sVh3x~HMp0%=H8)C+Zo9S4(9?SY}KU%vh4as66NBgYi4;rPeXEp;qHV0N3) z{uuTIpTN-@H}u(~{=jA|BMaRLx=fcI{0iUq+3BF0;=rr8F-weYA@exbY=4tjZ_RgMsT`nWclp}d)QDEhT~5(l z!1?-3xhJK2a|sr`nN5=?%kHMJstS&;KQraUaa(cIkt4ST$ z-Vi~j3wKdgW~i8z-Ejp0i^^L$_o!&6v;F8wnkJ;4eC>b)FbThL z2CTM`F%9K|6sJo^beDby0;vm9(IW6S?(zxE9Aq;nf zh;hY(M8l{Bpz#fc=R|(1-D~H6v_>|i2c*^=m*8B5(JA;&8ij$CsxhQQ(BH?XiZ9i)N_WaJrw%iu#m+i60;Qhc4LlaLwf>gr|Q zJB78-(R;*vB3_kj{DC&b1mw&rZkOQ8Y!ABtWu={O3IM*Xjt*DZBOO{HH~yMRc_z`b zEguCjnV8OVMkt8K(?)^}Sr-2@l5sP2gN#A9V?doJ8SXcd?Wuu+6DerA5Db z?0UjabqqLFk;P0(nN4}Hs#<)T^c}po)kxF)(Al_d8)a;6$CTubiKj$ZFt6WPsWf zh&@i-vWJUUIWX_W-jHOFKaXybO9M%j6G`)~tNVFdCg3^;D;AK=QC;p)HtjoR^82fI z_*nNX%*rGRm%i-N3S*e3sr*EdYi~oBxnLZD3$wS_dT2xD7}bZt)t;M-WO&hO)pYC= z_&NZ*`{*PD4o5p+JOtwU+Q5cE68Ns*B^c6a5V3Ty%^sKY0Lod;wT8g*uqeQ7AQ%iS zzulS+%+&sVCB?6bu&Jm(7_DJXR*}?^B8NMBq%(ja&-Qo~Hu%5_%hJwzOoX;=Rs4Sd z=!@Xhqtx&V8)VhfPk5hFL#3hyvv`y!zF4GI_2bpS&GWK?7J#+v?IF+;(oQ%j@1U+ z1D|#F`4mw9zdeqOw~jhouCWL?Awh(O5`A8OCoz3?f&Xai$pOX3+y()$T2_%*htx`Y zZT1cUy@v(5JYbLKIFLVv=ZLa8F6t#1Ai3W(5ayUKwAr_dyTn*9JnGGgEIjh87+{_R zM3Xsegt}Ugodw;35-CUA)p^V&j<*TU@`EDM+_RbnQ7P6jsHle4RS6o^)ej12j*vJT!FF8&Zf!7`8AL#Jcg+weAPlmx|sd~U_ z-Sbuv(CnP?jhr!^L+c?EjGbvahE{AU(`-Am2+9K~qZ10122@#Y`>f7%kyzH7*$elY9XS%R*ND`o z>diz6lo53t&2Hw zkg9StZ{B)_MHj9^I2(C8clEk30%{`ZE|OpnOY%xsw%eQ6>H6CRI-^J$z(Zt_*MZO) z(4+=v6OwpsQ_pLpz=gw)t4%EaTE6B?jW162Hxw0??I@`0P`ZXN10E58w?yWe;rJ3x z@cQ9wm4`aaP&(hdU-MLklLT1MZ(oZiQKw?`GSaVG-~_5#S7LeogW^j~mfJv;he*el$n>y-RGwXO zYWVc4>PY#b7HAlz)%O}%^EI(}$4{(k@6MitmI~z|(t{aQ1 zni^n#A0`HaKI+e-F^*jOk3RR%j!AN}zFm1}^}j1H4;`#PdUab6%qVdL8MQ$5`@vtQ zT<@>3a%Yc*?lMXt*VKuYsX{Wk&oogynHWhWjawFnfgy+PlziXBKiU@*zIYI-x7=(9 zPjM726ss3Nsgivn5{np27T%RKP%z|^5g<^@i-4tHj0*ri;00o8extt>ehm2!X2BhCr@Ok zj`fMR*dI1eoQ-u1PfjdW!=2$ABMrTClEesP+-u9luu)EpPH;l4sHUD}G<4wna8!oEDFk%4yD|*jcaEwb zJ_e%a_b_V4QE%hH9tO9KQh~)YT%?DX^FA$`d&J(Hmf9BuZFrLS#aTG7e`>#ujRly4 zPxZB=BH+$++VVcTxgEG>WB=xn)nGn=WK)|et>77lJ-96nd8x~fz#%rt+v*vM`hA)K zF2Jo&mv+~1h8UnWrOhxq>k=_T{oyTtoe&Xg?}T1M{suxdU&g3dn52BsB+nB4GX{q&9c-fEDFxfrMZBr)Qn7`2 z*UJ8{zoH4p;1HZ!%Gyjomxor|Af+WPt7UPf2FTcz1mMKRRCs&bcaRcE+7+RUT!3qb zq-pT_Sl%4lmZSYfK49Xkli^7PEj4Xi`|aHgCJ*y7QLi-L;{@SUZ^97W0=b9~NQsp+ zhIDDf2Et4qY>Nf<(R%jPrf&=I?UsL>zLJ^css2n-|63#34U{Z)tT^SZTS}%R78!>o z$w1;#Y@6mkA;ebcnK|`O*rDy-mBKZk9PnvQ7`$wr8cO?X)oPp8+1&Z35`A>HjUx=Zu80Tmz)X1Y_R-PcY4UIuud?n)nl?P64EOe;JE5&&vs=2jyOp#(Eq zrXT(mMlfSKJEF)eg8l(K&S6)+E*)i7tq-`F3;IF1hHdd4r>#_#2@t}6FE6|6CHUue zalwt6QXf4R76Cr)9+aIIQ3$m&+sD=bT)$A45NzpY9)H{hX{;6!IDBiXJP;q0*JWbf zw!l26F=GjWb)Q~5bQC@HkbOi8$14KYA`$(iydAj_$Q-N;M57B9Icn;U zBFhexdH33;y%uz&ov#Zf5jT2sz19ttq3x#IN2oD3_uC~q zWnvIX0Rbw=-TA48h1&QWOK2O48ha>%v~9F^yXtvTk7k4G*QK@V=Fd@*KW1Xu_IS-2 z<*2s}OY~UkfKsn0_}UxBGkDvw9j?PE3Rwsar*c@di~zf{YH7n(=+zIQxM3Yt+D2Yk zRUqU*6UoPu34XNcDk%hJ`K#70aMG{nVTT>cY-_ZKU;`nwvc8B zPeP2DJEPrnHdF?_t4_}!1$BTaP*b>GhLzteQdU1dg^G>B*&12k_lyZEbg8SkTv}qf zvFsD8>#LpE-7dh-PB7p;jz1v|8=XM8`Kc__uvuR;`|y84uTSr3#d-RWrct>mJCi{k z?MlCPNTUpU2ra4$Z$%bw)z}gX;+`uZ*p$aJP4C2r_-O$}lyc5AxB^tCidyU;uT_En#8 z6Vzn$$Thnt=iFC6)okDGn4n)Ed6AEza5s$&Ly}i5BcpeA*a(ZELv8A8cyZ7oBecT9 zH?cj}GcQ7F(%_{>21y3p=X8NXO(^L}@m2C%-gP+{UyTaaNShT-kkO^^n_;eJW?`s0 z5=8J3Ol9KCy#R#K=Oj`7{Rj;;b@vmoa{m^D_`JopO>!Q#7Ds9{Tu&cwQ#yUQ60VVf-fKP!pUfqv z@Fi}yoO>{(yLTujU4Wv4AjH*WH5y79(Uq1uvWcazeCu+vXKJgPzsuMQP$M! z`>pXCL`^f$BDjl>3nccq!7)zwSUd~Z2qRomq2}{KzmJ=5mm8>!kfA2xWJPLzsjUa5 z|8vIKT*JVpfS{HRw({Gv_g7Anyf z#ro~6x$s8yMjR9hK$vaW*O^BLJyP+ftlK8_#B0ztECl-4+Isso}?PEd2K8H; z_`Z9Ag{}rwnl*4qDMSXcn&0;!9HqtPB*g)wxgly0-);0U@tj5a-pxLq9#%pm(+M;q zyqLfM00RJ@(2@SAS^)ah_G2J{%u@5%_J$`+!f_%m_EBJr?&Od_wb&^wHm`OhnJyPf zxc=0#t?fZ!V6Po>KzM3(%`EpQo|LWs;GS+?ht@PO59@PVy)2gt67Ypt>9j&u$=`1g zp*$sdzaOe$zY5M)iKl53OsWG4FKmn0P$EZGN`b*0^fwHdfhw<3Kv_I77BQVTxc!{> zq}aprJZOO$w;gXcs0^8q2c3{%S_eA{5Pv}-&7oY-A{?9ge>}qKtd1_-(OPvCKx`}% zDaT2wUUuCx6VHOxLV$qYTH#I z!Y(G&)SsLbaGFY1&KtD~WIU8i-!{dEF)k!IgRAbK05jf{#Mp?6#MbDj4RomENS&I0 zyA-j*+qHAI#Xr5Vwtim$u+`m@1uBNUPpKjg9F(QW97}s68nrqz;4V(me~tH$f22|m zT1=A&nwkeymo6&n9)e>=m$3wb2vl$Zuf!9{3l z28~uuPbKe;Ck)LP`Luc^YVziq$EnOURk$9PW@IKZWhLp-u**Ip^9S?9{_Uz|hoU`$ zb)4U)>9TFNpb#+t02>Vfo?$dXe*ge3jRh&>mCzi4dAuZ*V1p{sDMi2lJ0h7qGng0t zeRyJ~iq)IVH@!ny^?;VEYYn?vyNojbk6QX;J7Rko?DdmXYm}2;T2C6bi>zY8wjpU!cj_#gnDu3<@uG`KSW4TRm*B;6vB-R)s z?#QaN2lekcHk&wDef&z%g}I>chq)lEfZiwCSh~SA>3Yq6G0d`E{YjE3XDWhhyxjMg;awKE}kmL6+{A+`^ zwKPVTb@n&oSktdVx-DHHd;cj*o7R74%YWzw6ZxjRTBEY^O24BFnL^&emKuN#2%+li zhLd0)38&%PRJKLO36~@wr3n$kmrrX%Z`2BIMif@AUdO@XJ&PR*Uxb>*1PZU{EjDOK z>7hzLD-r$7HA{8=KCnVd(=E%(yC$exu-uSyJ95)P^rFqV4g=xM?HNa+>F-+X1-Dm! zK_gpAoH-m7?u*r9s426Dy}wR57sJC>Z8%720^SIBmyz~Hk~sjBH?`FSeU>$)J-~0( z#g;>sdJqN@E!&QNX1dsm=v_B7pKH=oBYmsk;5J4P1he&2+M!3HCHEHNKkKeZ5a2 z#K;uV8gUuA>+@uFG_i>J_YmV0A2(?)c+4e76NNiJ^)_}VNm4QJg0C_>Le*9`W86JZ ze^tF52w3>(qqWKCyBpJ8E@W~W>5Jl(j)=;>2CvgUDnhli0cmY_EQ*&QJYtNx$UzCj zSisz-$8rq*>WZa(H^MDqTf~-K7m!%lu(HWeRm(y|HGznhH4SrV+A|jr;!<@etjo)~xiez*~ zsly|%pg9i*71>hYvYFE2>o@FyalWBjHIYHXL56?X5qm%v~Snt_-Ft5d5 z6oBR|RQ%I*hlPBXW@l-s7T5lEc2cpJr(m!r4f&ECJtB_Qt>6f*$@dXb+}R-NTpK`!qF6|owdu6=oGKEJD!xvpC151NpCAU^Vp>Qdy;=AE2J;zllu zlXHNQhD1_rGYxfFMQxqcDeh!r#|Y4P@X0oJwddX7MQR>g80D3X#1C2NmOB> z?~8QyB-3{xAx|;GJ(QwTS;7tYHD$nWRq*$2RPH3yq8XBdV)SNw?%S3|n~+%z(@o=~ z=HRLrT4~v|r3N7MKwdTOnIZw~?T8KgLaeXhtz>NmX@44=cVt6sw1)?jgDdbPcfVOS zB_gBebV?+}Lj(hJHXZylG(riQn1Ca-_w{u6b3{=~F!CSijbk!~KtCkX1#yl|M2Y+z z159qqbPD`6&O?P)+(z4>h_2q4>Y`{?MXY z!HO|(2do(cIFAD1(|tfnmGlwXzCawLU=~bw&kX<(VED>1d`4Y%K|p-j(&dw*@0FG2 zMOjV7RJv7aQiJ!kHAq@*Gd1AJBAdX(GQ(Wo#PqN8trWNxddg2+C|W+} z)tNwak0t)_uvIW3U*{e)d;K$bWJPy45nKk4$5_|EMURE=z=Pn3I945L6Un*^ael)$Brku;Kr1Bkre$RjJXPyu z^t;ZC(aB==8nx9&>16HSBi7eeS-Aa5d%b)~j$H4oOG?)LE9fTO;^Tggeu0?u}~bypCD1c2rc* zuTk|DVEzM(WsDgk9iX+oTaEBy?cSuk35+Kw1#E#bBTQJ!ZjKWZDg>H%&E7!&(NCUY zY;MY~+&FR+Nul9uBv+W*^AX}o(!KaKb#YJYi zuPo^lar}%NH?`gL8msr84`1m8+U#7@gOzuQg_bH97`To;(Fr7%LVzl@XM-$hO4sm+ zTT4V`K{9lv8g#|B|Kuj???vu%_>jT_{w%79g+CJE>6d2>8|ff_xj+04GG?mhjZKA1 zc{>b2iykD|(WiNI7G1km7-VQg?9$Zu=6cd2fW%3w%_&yIk>dmP5;Wu7k{41HLb z#u(A6BjuV7R@^Sg591eejr7R}^uFIeV>vY1e}Hka%YDe`dc$6A!Y9P zWxT8R3^412BRyqics(id)81b3iUQprm1N5~5^6{JbWdIOO06M>!J4)5;O{1BW`>F7 ze*`oD_cUr3eI!9h&h%w^C9$QE5kVAvgc;5h8ySExhXahu-Q`_`8xcso$lbsh+&Lk{ zHE}L5eZil0i@zKM;{0I>YF|D8X^xidfsj~8K8l*SF z4G9c>GVm2KcZ>t|%8#sG3_wn>#L!05Bp)+&78=2I1fh&2EYK{sDlgidWpj*ys^kQK zx13gp>3&$}yFs!hJnk+x-qu7hH8TX!ib3>cKEW&LZzlq(^#d9dnZN~>sF&0mMXH{D zAI>HnRlE#?f8iOvH0;_D;Nzd;x_H9r7wxo=F^gz4F(j%jR$Y3~Q+)mfTFF0ws*Z21WE5(Ob#a(IdKyosmbcRP-1UTzPP4?2DCFtK=cZ-kbIz#Y1Ky!7_o1L@A!;T}_A7A}Fw zqA6*oGGjU%3hf_MWB)vUxnzG0gw)BtqX~9P^ht^D1V9Pp#hG*aamNcp+~V^_h^@-$ zTu!9ZcNL!g)(!ks8Z>)0dR_38q#zRQyGY+*aO0Sp`P46xvpJtM^535$pwr66XAG$-P} zU+Poi?zZcD*BC{5f5J(#G*(fa$IL1M>MT-A7d>_y87`%!f1)BN_~pAJ$J{j|rCEhS zx7==43jssZRd&Ss@o2Rf#TT})4llndxZp3aSqUrucn2wD+}P&zS*o$mD^8`*jSAx$ zMz7kPglkZXnPiXh6Ap)n2gIfHfBJm7?{UgCXL_AmSD(zh1^pKqA-2i;XeB7aqA+9E zcm#o-X0*dp`Zn0y^g26Jau9GY51oCHHwN@N;NX^iTna^nN?#n^GIg|w`l~hO%l8mL z1}lAb({rN8z?_T*-F~53D@!#AJwkZn=7gg{&^nxRhC#vl*PxdMo}xcKOT)CIR=lSP zDx|zTWg9}n5UE2kRH_y)MG@ZXW1N$wXniE4NGIg+RQVmU$8oJr^y5kn-+C)+|73~_i91M~tHVWg=xtD(VHt9+74*xS zPuZ!`L1M>;!~fF#w+bC|_nHTW2*5t-Waxt{$oXFRF)@l7H;AF9ex|q7!QMH@JfxPa zOXE7<0<_SEsu8uIp11gGYnZeq+6@Z=3=X_vC!t!rnyx*}+xeY;^{%&+DJeg}IbK50 z>5jd8)cSee#^1`@`>f>E$Yl4OJ@;p?7pvNTqX>YC-cgJ$Fx`@;4zu5OY#--(T4JwV z)(w>1mQs(-o`=E6#P-QJ>7Hc$tRctpbM7Zfd=eY+k$X#JdYX?$>Dnf9dq@BB1T@HL zGp^|!SPE1QB;PO;uc%3aJC#~8Oav=;alYdIB%2eYuQ5Ieh!N$WS?8llcmEF)y#|3s z-VxMI?!BoIF-+0=wYw;a*rt44%18aH>DHKoG(&8nf=l@_Q!fUP>VvOcu7E=#y;?j_uYjJ2yAGhWXbQSGFXPCi zOt?lzH1mJ@NvA<|qfR;`gl^wp+5cZ@YBkOp{NSwnFZqvV(mnIk z_!pi`_^-(|I*0q+;tN%=JD$yX^B~Cfdt644DKuTDM zvyh3B$X1Bp-fH>c(6ZwlIpD@%)@V2ZhEbd>?4i;PQSCiIyU1C>jrLiv^07gn*o3$@ zZ@Nwt%lJ2U_^zk>0Ah1zLtr+gahfr`AyMT5k$r%U>M>>s8(lBG37>Frt1LNulOZB3 zivCY?2haTKX;54kt|4n~PvhMK!01d!$scJ`K&^I;Q?+G%`5c3jA_HiOyXt{8VLxE5 zl)vVIlvLkn!7#l@LUM!S=6KxeaBfpH-x*WG@1BG{E=Nl}q$K3XUZbP7XZh|;%kpnM z)GCnH^bcKjj4S0IDWpcG6eiJJV8$)Vaca9&O_KfXG2-?R&e+7q4fOCMv;74)086>i zCq)f?=@lL+Dl#_{;TyvX)Q`M|q6vuqGDPS`u{E1SgGlIimci`yGVI@9FkiKj0Xlom zv{iMUF(0%1L85Dtvo*O-BWEX5YXE@(23z~vBYhm#xvn>15OGd>@#UCf{Arpy428{B zsF)%RV}{D-;P!ru0K#15Zua}c<)Tl|M0qmy0&3gsu$cvtEN3N{`kS#>4(R+?l%O}M z@^^~wtz)Af<98gG7D`5)!6zIZ;})N$w{9}q4J}Muv>jZU^ruxp) zD=#+Jgf!WWLnx3Nr9$zKVBjOgSIyCc(b|=+06E+ToBar6Z7S3GI+yK}!zzEntx{gt zw@XV}v{l)wX($ZiPChYOgfbZKSuJXNl78%dt3r1SVLYLXKhnZn8t}vRUQ>LG6e6dT z6`FTy?5)zU)gDn0%^ zsbb1dG>h`HyXFMI1~i3z0$#`JG_-qQe~f=@V0MePejtubJUZNsR`cH}V8+%T5$R^N z#4Kclg<<-dfr)Ej;uoy{*Z)7n#czus{(CEEZyFS@?(~qdpxn77^8d>S=5w!e7dvw? zE}dDsTpUe2O(d4?wPRhuD zB#LTb6m;%$>Bnh-dFEtfToHCBQqE&m>_c)sgWOxRjb8#|OXqsU+piGYyL_ZUxF;E32#@y*%e5)i9D1WHFXXy?4EZp_2?P{RU-au=w<{rbU;?Vh zv)>lZgI)k#K%&3cS{-Tw>i@#ggMdmKrVmQ?6fE_U=>tnCARoKpq_j5SJ}vA+*5-Pc zmmNWj2?RC?wM$`UzI(q6p1`RnyZoS9IxyZ6Tz!yB`uIwg;&mE{^qy-%xLuLhdhl0e z93!OdG)@eGWFtsifb=U>*?7yKt5{5E5E=S?qoPlfUsNT?MC8kZB%o8WF!i$dA0UZ? zP;$jXGH}{}8k&-eir%(p007fmKiyW78l+Q9x`d-&GuB+Skc`W0Vt97o$&YtQFofZ# zN@`!`0}Xon6rd2;M7enkva@0v@Jv$%u)o17;94Y#E**4FpdXBdRlG-Et6&%<$)J>L z*jr0@ECp?0|HHYekWU55JeCE3*w&@U4w~<2)ZN@)$R6znpcYZ_(Cn6rto&DiV26Ih z24uO5>wi5+pf#l)$y%Ar4h97l6zu(`k-jD$(8{v?lxSaMSoo!C zTBe5*##5U7I|LHiR0DZG98e}&hD+mwLkxTZoKB+0COsEVzH`tU*9HY7?DQmSZo5d{ zcAPEvZh@c$_GTD1_DLgp-Yywux|>m&L`7+wP;5h9%iq`iwHJN*`WkFy_{i#qdR|VL z#Xg{|s9_lsMOGGJn#{rGRDZ@C7S@u3B>S${_5AmP+Prod_Vri*00RIlUrw`0#$W&l zB^EF^Xre9<+fST{_4#Xh)D+H+#)}zvuh0Hqy=H}fJ+PO{9 zg3qlE|0dXk$s3quAL--)(nguo6~(qhqJ}t{@{D2yl7iD40wC3n>tNzX&sE7t+>Ge3v-Hy z=BkOv2lIL-x__NekbBspy9Zg<`uKyWfQ3)8MilnPFEehuQs8K^@xBm1J8XAo8Z>ha zaLA>o{WwfEe^9n?P21%c^S-S4g<~Q#EhxKEnL@B@z47=fOmPg8;Els7$g84;9N*Su z>UAt?RXo?`uSzKqnt1ergGmPhgbQtGz2_?~#t{D>*sb1oj|(j`L7JA%!YFKA!jaNJ zj9o)YC?Yi08gMj>9(X7Gphc7 zZSjKy^Hff?qF9JnHJ6yVr?$eGbhwZJ?22VbO9h}_0je2JQFx8gHE!RXggc;NdOQ+v zDH{{}4^!LQ89-yP7>L=Hwl^Y$5F#O$rf_X~hXkKu>dLCeGC;gAHA-%hbf60Wq-*uC zr!Ie6P2G$Id8^4&1ZRxYhGiMFBGTxBM=PrnEW|@mZ0j;^gEnGco;kg#}G&4W4|h7eVCws-k@gs zS6BSo`1{Jg`yyk!$64sw?GzRsvnFUumrZtbmoigj-vQ%xBts$#CdU*+5ewB{Sbkam z#md0057C?K<3sO^OvqL8-;`hMhN^EMPv zftc6C%hQlLa342!<6W5>(w7&W$`50!J5yT(#r_5#N4-Oq!O|+vs^KY}I{?HW0U|6n zH4Y)_t)KR<4_%=Bya{uuSbSFWMw&N)%Srzs`kX8lUzF(e;C0=*XTPQ43**y?$0N_2 zpa_YT(Xp!8l%N8D$=u$(#dMf5#wJgw5Whh(lj(%HBn%a9B|!FKsb2c=<-R~zE#x0y zK9n7^a1#$vA;m~(qfEsEyRE}!)u1Q_cQ(YbALN&>6N1wILNP(t*{$>rJmehdGI(%e zO6)rK1_dJ%VlT*@DGM|(^;jBKqzO?5zVM_n>~Xvp^?xD#*&CHfpsr`=bt+s>=b3Wm zB<;iPAcP))f}@ZP(Fq1kq+Ag5zV>NnRhcAQn8~bkwM} zTgv(_cwt$I2RdsMSXu*E@3DF3+D?%k=}okFG6dtDcZ_bPVfHsM!7d$Y5u7Chv2ClT z-;%DCF6YvAu7JOY&v}x%1A??u_1^7YmZU8TH4{$MA_oA_b%ASh*N&hOAZI?`+MU8| z#pAcdl6Lfy42ik`c4vPkl&TvUp0u54A$wRlbuoiOVh1U`Ch(CXGABd1}tTiB?+JxXWeMn6ds=+wWeLDyW~E_@n({- zVmD7`lc^2+{IdsmFGga*W%eH}Ko@lU%XTmN=iMo`=OH zWrj9YxEz*_g{5feF5}!$nU)*@6YqPfAbCvgz5B{8*`Lq4wJ;SM3MAd@5F3eN2B7V1 z)+U$}V-JPT?Eez>NJrV7(wx>mZ8x1HpkUDh-1?={LY%P%<-WTvU_>t%9FZa1+L8H9 z3b8RCxOjiFyn_(P5aHZ}x<}p0KQ+>zS7txJhx71dgz3v6#;-UcEBxQWZ$pX^H7oSf zrGYteo@qiZv769CY%}pV_QbHZcNr~_50nDo4$w!hJ2ra%o|ynVc68uHh%7^|S32;j zizv;>7EQ^Y*gl9%Qs3`BKg4RIGDfYu)H7dA?D+S!0R@PMETw9?{S-izdg@AOX6gx; zgxqyX3wG9*oo$aIjq#)oFk;;(pk*|}jJM#$l<7Ry*L>%TpC_f#zPtgj-Am+h zt?!=j`&dQ9e5A~l0b@2SKWkSI_Nma{;M`NU;8WUsaXc{)%IfC{oC&71*2>O+vV>0?SpHXiZi zYs)=Bo>>Oto6}i_Q85{q#C|PUXe}^Q0dWS9`1qLAlxZtB5F1jTv{Jvn$P{Jep)36y zh5Y5T*kcLsI(dg)IK9zm(|qyvj{sBj^bt*W{abGY)wUr--pTe||MJ&LI+JBblg!|} zB(yd4wKc(ZK5kag{Ahj#bArL-{JLN&8H#dOp)4mgrpiAd=Y?PM@1+K&Q{+S02>eD7 z^^E0D6lsovY4&LFY>aV=-Y8At>MQLg5s;IPy}dyTx{d19yx&m2#4tm21hvJdnB=<+vw2$hZLT_wsQo z9>!A!R~$=-!mXq0>TO%s{%?HvOVA5}@3J4u?Ddv3- zTpsBC%R4GA{cJvjbX%Rq%31>_()yOQ6Y)W-K_aWP{=qRMZL+SOgz=kiCUC7eFQeYQ z9^xrPwO@d^`v3>I>;C|Io^k8Z7({|*)6hTY30K1=m_Na7S}GYb?TBJ6{cmAcm{m&7 zTCA1CLv^G`+)?x>O5x8QOd&hhnNSLG7(j%Lsv~L!f=64sWZI_+#mFAdl`xQ=xM{`Jd};Ag8FaFTH(ilr z=;e%15e_k0;r$U51$Y<^7J1Or?dA9$)=*vGm(>RnZ5JZ|Vj3f2C-r^Z0BvP*rw5_f z1KXIx-hckVjmowVH7+{Rg(b za0a_{LQmH4Kcq@MhLxJ&7ZcDBW8p>yOVRfyS)fp({e=f(J)mT%9Dh~? z${~ph_r%t!$o$HkTMMQV0VfI)7<)0ZuemCYcs8N=a1esdGTuABhb>{u@?qN&2N*^b zCvR1`m4I-9+JNBYF!WKZ5qm*>JaL`vvj%WFXsbo`&eh43{*pgdJ6-dxojumP+=whm zoy0lQ3p+Y^LD{`u*q6Ze8c{SkuysFI+KBY&nF0+) z!>F6Ol@;}>g54haruvRKl>PIN5yyyC)y=HV|>SBAkZ0yj)15;%2PUVX(i$m}!%2Q$r>9w!@9(;i6up`1JTGv|=d z4v`o46Me%M&;P7JLwu*s&1u(^#$#rcMaR58VL4qD260T#(B0Uf0B%ZQ~m>CCK+HrWzNquxusjSDH(YM+V}i$F+Txkh^I1A|r{^^J^> zI+2uTuTa15RFQSPo4eq)kW7P|Fcw6$xUg$%)qIzB_Xb%19=|s0LIRfU$v!{Q_n2=k zvyi627oxJLUC6fst;zo#%%D&Ifc+ksz@N9%ODjR(f=D!ni3g0kx|Dsp8H3jjE&9QT$-?&2+Jb|l000&S#ongNXl9Vf&K z3p`Pk=Yy^+y@!KtKdl{bcz~N)q@%Kd`SCJ!0-(eH_G7NgjNmvi&jLEmn7^JPgNv{- zrsC;tJdj7tRL0sA2hrdTwrlK#Tl5n~|G}5vTrBe_9rjcZy}-U8toJd@LK!rrp%!{7 zt}`d5TF)+s8+CcTOg2v1&-*sIM zj-02Ybv!PXvyC~i;sdt;17*j>Rg~PMx*7d%+~DIq4U?XCTSE)Yk;zQl)p=3P)6OQU zJC3q=}b z$Y%UOsl1XLjPPvntNmAi+V?DQK2cwm<+-M)spy}?ekSDj#fd9QXZR-h>?JZ${3x!{m7f=b_i`F2fQ%b4KsD5Qm~L)}4>YCJHP;$FM=y492~GAY(Eqd3 zz#2960s0p?yv+yN+6mS7%8z>$70(i-n?Tx(xFrS3YG?_SA@{v<@EkfmuVi>Ugxx-( zIT2~MBR=X6NhU!5PXa-vsUeWMo(!0iVs^(@y_ImBf9j&@#jo_e}{K-c+G)l;o+a z6isf7di>f-LdPgA%s(5CDrPe8`utFfc1*vwVo<zJv3#73l znP3*_c>Qhx>VJylWfRXjOwn5Ub0V9x7<2I_R2xR4KwC5XMf?6)d3T+!Cy?cmU>dzH z5%hIgYz@6`<=YF!+*|Cg^AWdOB(QOObw&6-Ps3nr%V=8&30m$F;+(+8HNPj-ZX99z z)&&#MOdYHf`0xeIy9yYKl~RV!?~AN7W0=WHlx&Y=HNi7@Nm(8q18_4=WuaBhrF-#N zfkU@tWVMS0Z(;s0$)#Fd zOK*dPnLC79&=})Lob+iY&;UBcdIO6;&Bk*F%=>@3u~zbN9-->T6iG)-~E3@dy)ZG)*2fa zpX45GCYOy!uq(j6S+X-sH=v>lT7$1aM{GPd(D(Z3CiEb2Ft@Z zth#cO(jRUCTLrh8J2E^pxu#?{<91b(x`qw`L(a|(2V&r9R_5QCy(5eb$kwz@hypoZ zoSinN6{nYfU)VZ@*AKC4AIrhZWBb7y*19Uu`S^om6KapbA=H4yKUpk63Co5&(5v<# z7flzl7>Bd?hl4*7Bg4QoXMTr;G!!hq0(wX2Myg56g%~wbexOpo6 zc4itz@ZtP7y)M|43y|y5__!a$WDB1aUqtA(=~_FL)G!p6NmX+Qclm#BX76SE?anij z9Uw;@%PFftScYSiH7jJudUGE(8!lH?j0>nFVvhvFXgdPwQlA1N=wd-ZDm0X%69Efc^#J75ea+E)%9F0_|Jz(=(m|6LF@9N?tkB4*^pfp51psH6w z_>7n30cf^SNOwkz%yhVM&pI=W@PoZ}LRpf_qmp;^VfeCgHW-+}i&UDQ>TxcNfJ_1m>TE;TUS6~k4iPXskoh};%4@X#wE5}IrW#>Lc$)}nKN_?c!%XVbF_?ruugt=LjyP*Sx1@&ZC%A{#!gu zo^6f(vaD#sKp*kyx2g=C?^yk>OUw_32dq++aMjYQ`IUsqqS)R5&WkgO_RHD;{ulp< z?Ncci#Ja*V2;RM&z9aaNM*f(@%rdx*c$9V&g|At>G8@E#bz8 znm{As1fK>H$?#~8*B-z`N~vI`Lue`Ys`g^@s*VC{@&r1IV8&x8Q^^;31k=9Me!99t z@$~7{T~cqkq{y_0LC)Q4`dr&l8(TK73cy8mD1+bD{$6x&%hym=)j$gH1V9sGt0OZx z&M)AczQpvtl4&G}Bn284^Lohq~1VQSHJ}=p&y{{hhZG9@BJ)SlBjMXPy1hwM^bHWtlbD_-uMW zJVj}8#O4gnW7r13d7r58SoF08-}{h1%|VR!;wlm^DGM9qi&9GCF8RV;__>?C zekTy6W1#(UKPHNdYG1e5x@mc{Of6WO$>^%e+drVEenUcrTjNA??=7mQu&p7auB~h? z4&w!6lRZ9GId(~XH4=%~Rf#K*9?Yq$f~z4B_dus9#KGy$tykciSA*O+?F7fqY4w)0 zBS_U{Q-d!}7N&d7^(=9pAObD*lE!B*XiFpVk$@@mJlAsP)be(gHQz!Q56~G6HCJ%c z1$f%}L}>!mhNUt#NFc6ccv6m$=a6Y&-wkMFj9dGA1*8X$2>|Ph~ zEtc^&Hzgq5JyU=RiR1rx_Ci+3#Wtv$ZDfd6#vqOvsqu z#bn&o$uIa;kf2bLb}!Bc-rRHGu{x-R2Y?RFcXYxQcrp(Zv(&duw{xCvS@RT)SGiPx zf=(+E^Z=6_U7E56>VYG04jcKxWsC{iLj{WD4RQt9#}7BrdRVWkg&pvNFr-b}Uw3FMpo491hyGUZ$ zbkNmAyR=otOo6@uBwk!F3)Kl!ZzjJW(0xiGUAm_PEV3_khR&Ha5f5!vJ_ z3e*fgGti64F_SsKE2T8%2rzh?Y_@6NkQT%=s!cZhSiEIEb z%v4n;b^zg+D>4=M@F{;b7-_JX(YklX`#g24?lRwdOoyGppsBMW)Y@-3OgF|lvh}ki z8HM2$7$83%ZRSmm$a)>yy=_UQodTYjhV&&~GrLeCJxUamS>m1p4iE7DJ3+f9+b5Mw zIuMz%{D6&Ln`6EeUealG`DH$fz)K(u6rbt%#kp?Q=zn|nE-~+ulH%PW0VJWDeZ+~w zr|9?0xTyB^7vi?l5~!sp05O5ZAG#V>ed!ess*ECp>8yrT^;$RxKp_2XmX6*2Q{jVSe{?VP@MC~wZmNbQvz1x zt?B`^o!qAG$enuejgNG{wdV=HctCUrN*;hUn}1r9@_={!ps!eQwd$^bi0pX5bIKX4 z1Q0GTI}W+E(n>D-u-&ztVxV7D@3)=adT#K$Ob@aFk5B*pJqBL~*!`P~d9=9eW*55n zl36hjzT0!z2Ig_HOzDr(Alt+qpIbcl>lBw*q$t4saGfoQy4IObe9YDSx!J(hSzj7k zpP$rx4RiNK07CO8NJU<0K!)1_N7a#k_9S|2oN_81n72M>Lx8Rm_Cv4Cb31YV1J;L?l7O92IxC#87vAs#1?Vz5r2P~i{Fvf?f`VmKJx zqY)pbQBYdv`(NCsk5=PB3d56V|4orqq2mSBMveOK{q5aB19jrQ!Y`&CQfqgbS{6j` zMvgRbPUt>)(gc_n9e|XJW7a{vN%V!W05NpU*p86gvW_4Tr@XQS5pY!QTpk=XtIr$nHVv}s|&!OcYyZXw<5Z)I7 zXwo5d%M=m&&QoO8FMBz1lP=o_ad4qxkyZj~BC6*#L(M&Q1AmeA;>d6uS&HmnTmnBV zlLdmdd8({91hr!rdq%hpbO~~VWYsqi(+%qOTaxgELT&lbvT~+4bUSP21{yicw(r-b zFXAjBtt8mazB8oQYH97J1#MpLyR5U;c)~lriDr{0<;y{RHOk(&&1UQ9 z(yt)Wk^zCD`LIDgF)RKfcAJ_q5~>>;AW+xXavozd&A?4T004QfL7Heus6l9%ObBoP z{;E{~01i6#i^&Jb00MQbcOEN_AhL5s>6dQL8iqp<`j1+P%mJCc$V?Ns#Y6!& zej1i-7K>0dj0EAG?0!XBN@b_^Gh9LokpzzRTdRuK#b?%7jM0$5Hxi!fGWV-T;iTk^ zvp1)lc2GROlpEh(Wj`@kfN^8l0fZ{*!n=qkc+5Lb!&Y1(-3I0AE|sLrPI8d!uqOIn ztn(XJSk~NJ)y*2PzgKRa_oxeTTPZ8!V9F1}wLdYb`o{t0S3g`_?D*t-#!uiw&*IBK^)!FYcgR}KgsUgC@AC-pUkC1G%oz$K+fEl-MF4(a?aEB1*EUA$pZ)@9+DSyAFTTI7UA^N_zAPAMYm$Zm z8>GK-As$ivpE|pFS3gJ``s|Mf-bWzu!^la(;0*p<$cr4WEY~O`#jxQqc(7#Cz1${B zkOlZ+Ro!S{l#+MklIkglQ0J@#-{NS}5qmraX6*fz~ z#bpOSl8eQ(jF2U)QM~Ug3FM$HriEnOs%?Oy*1`ZEtl~~zl zEcZNc$N;(ly{%A22JvY8_cs^w*3cR%)=}E_WHoKa5sb>`?I)aAc`!!rPzME{h+rfa z{a|VLRS-?HAD4K!AQ8CscMq%!2|-0{pxMh@l3E<-T;NZ<4|z3tR6c_5w-4L!HEy*y6*0NHK&r@Vvoq>t4j3C z?2Ya*XFTie8SU@^^RSeoz@&T(Aq;nK!lQoIBCrko!dRKC#c(6=(YbKLo@5srEfZUf zt560Ionia={Wmc&4a3PbPKhEPgi}4@Ga5sFbnK%3@dXVxOat#xX+v6S-p>NH0>Q9p zEMvf|>I+J?J(~iK({S(s)~;zu)zqG(vowkihkgc#Tja_4Uyj_67dYbflg{olPP^h6 zfNk{3t~+e_!aI*eTo)Z;VGI()L9`Ow^U^F{0hg(5uGojSVB${|>7Z8A1TBXZR^3B| zpN-(68-7k=@({QQf8)6?(ExAVU@~=yq0p*{oPoOr5}o-rQi3>*kJ_cvON&1sOWD1LAlw~vnY{yx9^zIhqr61@@g>*SAkr!AU6@|n zG^fROaEJK!=-k6t!QL^@tSS{qshOTEz6*JQM#{^l5eQVg;}&mFHLuowNPcv!@tAz( zR)@K-OS*mYEWp2|4#T*ZkR z;`0O_qzYvPZeD^t_+}0r;R)P37^Uyx`@?Y|Uenw)Onp@0M` zJc#z?RJiJj)uOoSU4Q=(kjXj7_jc3)N4w^ZXr}Gn)QE&pfsWqws%fO(QySp?QIm8* znb;%bF=uAkQ)^BbF<2V#@UE5Eqnr)Y9@}_e8o4!XkyU0j*)~?=z?pU=1BaeroB?aCusv;IeZ+^{q7=_?^9p0D0&x(H?bEcD{yF|+l9U7)0eOMHkulBb7?D=D3>W1aL_jW;ze1 z-5nKp9H`_Q#HYFL#qPXpW=$9Cj0I7N>fxME4qTU(_SA;dsY+3iiO#|Ga3$y67Zed^ z_Qt6%tg>P_lk zXtq#06hlRd^7!v`W`$ZQGmpz*!<)JQKL>2L2tW{_C5B{vXeyG`n&=0t6rikqh`aQ@ zW`N(OC=7N2OE@2Z62*kBG%*NM65C?87E4X!sCRp%VFa8v1YJqQvpkI^^dfTcUz`3Pcxf+} zN?UP1E!<*ob%6{-u8C~UUkoQEd%}!N8T2sC@VvZ~1S@DPeX?h=4Mb0|#D15Txizms zL&s~jZvK=z)pvt}BH3YFvH{J*8R!~(2vi_-q{_s0ql+#Bp*YhSXhKq`*28Y{cb6-j zWpuf!dM<@yZMhr_Q9|f`Jt8<%>Jnq&L64&izy7PBu}AI6{X?LdGva88;!Hjr13|!m z*)dm9OE$CJ%;AmSdde4}i8zigHv8uIC{%P1i}2hUSXbbX3W}|XYXfGvjnyN~U8eOJpPR3P&Q_blBj(UA5atZ{S;z8LS-d4 zf5`F?uk_Z2p7=TFR4GDd7L!aDEkdCTK31)ZAZQ9QJzbmPhn_P6@2ocKYl3c`q~)s; z#|sgs5@+jyj(>N2>Jxcf;}?xHA=kH&A-V;)_ouIyYPQ4(D5&Uixd zGV4AE?+(acYKR;VJS)lf!>ndvfaiR=ANB`92th`E{nY@hgvt6}CB2ymk5@FV>t*$r ziJuPlawgPma4U_ei6Kg;rTZU~Xsn2ERy-<1x-kJ$zI|6nf9mBL1F z>~;5*aI;hinS^Gu4er_9q8hIHsWyGw`uGN&5%aBTCZY{wEZgq({N^%p1NS8*Mf8*Z z`0&{^$Y{WUzZLbfy>xat=@9DgivMJtBET^%=p5mqGPD?cujFM=WiV{0*Uz9S)1hJk)&G8@@ zeck6W{e-mi?4xkt`XhX1yIM6<1O(qnHeIJ6=P7n_EFz{6`X_!(t5W{+lg|Kj z1H4Z;@FZ`epL&`3Q$vXlgj#(k(D5{swvzt3l0cEq{t@8DH^cEE4)C3R#vt6tQu~LMV%u8(5J(#sHNlvgu2f{I-gfP~^l%=!ug(%Q z7u-pp%mOBFc{4 zmGAxpX1dD#>`GqV#juTV=a|`tZ!I`<2&6$cjx}KQyeun>8uq(80^)u2NF*HX0KlGV zc_C1sTyWpH!a%DkZYIr#N?zPePrvoTX&2mQKlas3Ry#cM$3FS~Qf=L(QO#7;&L(J7 z_jhKCJ6(B)wTxa!c>h&AzsHyu9Rs%iO^WzQgD^L!Gc4>iCXIMyEQ}SiuRh zwOsU4U9|gpeYYYj85^BO?GYz}Qc$H&6|sD^y?RN+Q8z>i3TizPIA0=~K)1#qXC!4h z#~|QRLH$p@Nl*Aaw%uKy7op^qH3+Y2-Njh@)~24SB0358Ggxt#e3xtK`Wi@1Z%wRrP6^ zmVh6zFU{kBeewWkCETwxoeWl9h-20}et&C<><2t|vcmgqL(TONY0 zYpLeG6LAf%ass`p=aB^OS=R2Kz0dSIqr|N zf`Xl&Mbibo&-`lopComctnMK-2d14D-de#r0Fq z=NMEZi2>DMo%2FiD{1}=dqW<ADVDAG;s+vhvV*# zL~~YcvN@ShY6}?p9cGa>eZ&KA3CXco(4FYd-x(plkJKj$%Y=MCy6{J?#ay%Dcye$4 z1|cb7OSXHRxIQ#gHIWd*l_?3ef#`S+Lp8UwK5jX^L#45Ue+T1k_Ne9dUn<8VfSpte z_l8VxqV?IMJZeh2i8|A$lsEE7-w~F8s-7>rj;MBX-CFX&$IJ5*U8?>aM$Bdlv=OXxGr`$}F0lw}Wn%1)dGELZS$obcD<_8ZBo! z{aDqfkXN7aj?V9$z?@Jbs%?8H14brZM;gA4y`4XHN;!fM^R`nTf9m!B2r78eK?#QB z{grMPkGp2 zz7csb&ll7OgZ^MGG`6R%xeV;p_3KmB`t4u!xWe;y-xEo@TC?m?xhkc-iRlK(kZn_d zCTIE}HJgLYH)B%OqGU0YR*}0U$sOeufvhF@+m-(0E%wbkWC<$WP@lOKTp%xvKUP9|mSpDA2Iu;Wu#yeZn0ZFY&F`< znpIql$;Si4m)>WkMPp%C{24HNpiDAQCWQ3MdR@WDefG5oje7(QqDp0c)n>E|uk!_r zsqkbJuJXhRAvn>njkLraLZSK5163||D~_m`-8r!T_Bd=i)59-Ay^gVD?%#@xLY||G zl8){_xjSs(8Upm373<3T%FB#p>ig~;oYzkZemgMpyI~nM9u2AMfq~&k9!397ML@&j{xi@nWJU~%Q2$|3F?66kYfHX2r zbM1F>sqfgt);3+lQM1@8aCh@Sxl(AfmxC^2iQt?&_Ab9K@E#z=X!B_O{oPDT2Sbk$ zG&m$m9j5;~Y=h91yrTpP$RAznA)%Buy*#(=3X8D%K|od-1(Ho8D&0@3V>P->ZHb3f zRf8nJ?#+7hTl`u6)SgZKB+7hx-%TRK>C#O1%rb&b-xHz8HwRosiPrx^y#kxDLQ}7h@57aCXMn(@W#zG zze`!F4-~!A*`d<+U}zQQ>kryzuqQA`2I4ujCF05$4*CFz&%HMU5CtvwrO)pA zv4KyFIK*^bRcD0*^|^>MIs-rS2%WPBW=#iu@Sp<&@I!uBfC{O`)4JYkZ^Ocq39P+E3qnv=!=X{VGFdP^Rf(= zyyHWRi|D$Z#oFD>VA}G`wjt6)ABnh2LY7c2C4b!vQiXcm%z33R`Y&aYoQcm^xKcWV zP%Bx;>S1ogsMhUQ505_USzAi|y0x8nhnZ(zfvE8^QhMYlQIH0@mRqnVonvWA6>sIB z87GYcO-6_&JAo7$foRYJf(K-prcb`Vh7XEw|8t?aH3mK(#f4-x_Yn~pO8x8&^l{Xg zfHBPt6zu*|XcCGJUs2}Z17PVX1Ili~Q)&cOA<5EbzGqhs05=Hp-WI5KSw%!(l1HQ* zP|U|)`GX01$#r1^crR-_S@esf=N#Pdj`x0}UMWaQ`9-<9IBMww1EG&+hY}t;V!+OO zzb?-8dm?v8yyGE91ISC6LqRe`c$pqwvTpcDK_nF|Bb4(j@NJtQV6{iYnfv5bIGC`~ zsRVyyusMgBw{NamGUnWG9{`QnKJ52fQ=eY^O9}G!`z~8)8RV>kvq=c9l;m6&Uh?=$ zlWd@qsg{g?SO@CP9$&^e53wmRe6^teX%O#z9zaH{4kVwTDcaG0YYa|9T zp5naL(roFG^F3@l|2PkEx}hu{gf-(F{&FZnO>BxxJ^;+@O!;F|aaw8zhlreeR)eVM z1vq0U1(Vs_AJ}wX@(I~0A;fF1U>2YiJNmEZ_F|k}JY2Y~)(zru|3!b*f@QAe&#WA$ z8I@x&);&{iC#nWNrzv1AJI3Ujh=Gm{Suq#oMsp0GjLWBCJ#ROG^xKW$W%uc(%pQaR zMaLmJ{W0kH7#x-Gwe{dXK<+_FOVvq4V)b^D%vo%a@xP-GzZs2rt4I0CA8hDI5{-F4zPMU&I|)ta%5?_MY5?W zdqe=i{h2diIf%?j@U@W{I%o7h>S$)TTFjje<0D6*-lVn0)@60TjVzIzoAcPYM~-Z6 z39l4})JmocEehaKrKsleN<=mmku0TTh~KzD;6h*8%)*=Ejur80W%nD-lk(uGdktwt z3rW~{PbT~mVZj1?3>qTj8pg#e|H|TI0)rwFN0ly;LH-65phk5834O<5@KKHC7FFtN z1_yg(VwHO@5Xbx?0LUYe3yC+IR6%A4vichT4H1mK+H?U;EJW{>*7bSiRkYpEvmF2+dnt&Nj+k z`4xDMLf(duoW$lxmdLS4C+(ngh?0L^u*>bq+x&1}1N%eZ;K`~&qjenI7j648{TBXk z-3RR0u)*E*U4|B{#LEA@PV^bv!l5l$Ayoa>Lry%`AWG{up_IklvN~E_UDxa@gY4I{ z@dSg*#7<~aYRkMg4vJ8^PhBgiYugQrwyja+`)0A~Acxmx0KNn~eG4)zx>yGzt1q4d z%W9>bpa^~rmK;{RY<$FLdh-?M4!scGa`#&?f4_O&&{lw=BdEf(_YTGml=HjHDuSkY ztoo@%fw;{|N)rcFBN4Yo(X)TP%Coiwz{ZG^9idxs=?Oo?wJ!8FxV+wvdE%P6nx`%hTUq6zbs_xui@Ldz zg7`rH6wTM#|E1%OCyWU9Y?njsQ;SLr7EVobM&j4Sn2NU?lG-Aa&QcbsVWUz@?5S(N zyu$H$)WxtcxWP&J9y<#EHw-o2FnUt0TGC9(SunukP@cag5-Ad>rTLFci*<#}Jxn%W z9^09vV$e|Au|gOmy~?vlXeb#TkpEf|+ueU|Et9TFr7_j5C3W=#psRrJSJ>XBcm zvNkL`77<5@Rlsc#8e6bl&;?;?5Gi5@b)y@{82~qr6wM^b1B-@g2qejyc$~z9AuakNEZeZmjZf}P&KcIXVE{k`k#1BTR z(P!Vg?vPm}r^(en{Lh_Anhuft`?pBskAGI|MT22Z^Uz$zI+G%Cx z_c_N^n1jo(+cdiU+S&w<^Q1BKCKeFU8!%+jd+%Gfa{3Q?=L37&4Nsn>nH+b~{S>KHifWs>dc} z(u{U(yov3-CZtN)d2xC`DTGz^uX_w3OR7x@EKX0Ba5@Wi(`j~(PNtB%u$`5PH&B|K zeA%9PDh9+OkC?&4ysFUNN}~tMS}4td{kJY2A~>;Uzc!SBftnYo@{e(t|5Kzh?*JL? zad1iTw4Hp|!$apQv@!U}yAkfu_pjE&lYMunx}Vm8w+7n+4N{Hnd+9Kf%`G;5&?xg!V)GZFYUjsu6IH#Z zHB|gPZ#XI8f_FeAxMWqP@t5%E2Phv}o1#=rH^Y}E|`;n(9`|750?@z|>6*z8} z1%gQXkNAt%ZzDcnY?(Z)>uTh{J;nD$fz4~#{M_n`=`SDPs{>c?n-~9e%P8oFj0esPe-ntI%0oE(Wv0eRmKwhXGk)0VyL= z;-Nse$=xn zghKj6l}()6Un^s52`aU>s!CO=$|9a99_YbUK3i5?`ycoIS>9H40gvB0zL)tx&4`0F zl@jw;jV2EElQ?60tY8*luXo@`m2Qexlg$lnQX)a&UL45TVr4Vp3k>+fP}?th$q)H9mrU)+6>-TOLzC8P(z70>g0n5uVW@2();b8_vt+pSsi} zC;Xe2R!`)POvCFG=rNM19H=-Z>^t4Ii@=smMws1@n&Y6K^=z5xe!Oe`&LWQkH$02oUoe66NLRxY6U3;I>vQXtY8iI* z1d4F8ysn-%VzfLW3ft&qa_H!8WCjM}aVfXgUml(67npcc5O3?JkjxOn<^SrlCs}|4 z?toq@?kIuQ3u1nlJ4~myzV-+yky_*^L_mKktl)5|X$2$stZ!M8zqSe5qyilBSQuL- z^=JQ0dfP&0+Ej=zNc^ymR-KAvU?bc6wxx&$vEL9*whYYVR#$Vr5rU{E?76JOHE8iH zM|!Q5ZWu!BF zb6vw>9TiiE9pAg7D-OoDS#BN^irD)5nULQU9RQ1OcF$jF!xeyThl3tlFpDYYUhmS( zbwXq*>4Ik-M_Rcg*r_2jZ1^{QaUFX{a%`yLVB8Kaqw*w#GaMnd7>Y;{Te{%U@(dDq z=c;dl%u%f|j3HvbC~1m6OUAX(sDi4#|B5oNME~CndXt75>Q79rsp=s%3pqwA2EZn0U(&m z25eYNzw~{?p&9i@HDPcSmu&GRuCJTsGd{i`dd$!K06qU{t=s5#o~-NI<-iDH-ED5V z*S;1F7C?*J4kIDvNwe_FXkVF?w9go)xn{vQ1M;brVH@8K)=3>R@4RxBJe9Cqyycc* zo>S+=MT%lAmS7^+VR;iL!-F87vD2UHc0{s@$(4RnLC~Q)&$8!?woC{GDE)6NOQR3KWQ}#XDYE7>3YyrS85lJuSkQ3S~KLm%m z=O?wLsR(@D7$J7{bHesrJ{3)GbK%=3U}rJ$_;T4Dlm93U^p;p3RwuUaiBmVK4Y*4J zmf@%}+UB7@wa!;EO_eZ%w{n1li8pY10A5Ivw@SylKY$KB5;x zG3Jb%*dAF%;+~kTkM4!ktQs3Y5hK{8a)jRBUY7iExu}Qu`O+x}pjqz80i6 z-X!X7?TmVx5*yx8K%YAm@WXL=qgfiwkQi$KLuDZtHrAsQd4~&OmGYJJ<`(Fqt4L1B z;%phTUL(I)s1V=%@#;B?=E~Lak zgrS+YR1m96vaq{K&ffqkyDS)vOv^-xrkNA4DpuPBf2x-!X_KHdXXk#MY2PB(zvRd~ zvbWzwNE`-&!f}@7(DS!=I5wb~B5=hlaL^n}5V5s^Y(x>lOV~?%1DQBE@IbTF2V$Pb z1CQ=7&N#-LeCW;mP3}`PnQ1#|X%!YP;P^y311CA(z`1_$IwtlYSIyV`fC9!HbzvW+ zf+>whYifnuosl|?jo;d3UR;0p$IM=7XV-!Gmj6=jd#W(DsLYdUQ<$Di+q??*GPWI> z3Ao!zp0O>`){OqFw;}5$PXiJ?Zt(H#g-#%)>>x9ndy24p;1n#C z+)5yJ(Vqx`ZD!ak#Sg5z$p_v$9IpQ$di(o$_nt5c20$lxBh|WQ8+N`F{!w^>3gQjm zJ#0hx`Af5CV-S6Id4Gnzvb*zfp+H7GxMeL=3zw@O!C5wzeDv*_U(gFd zMc7BRVR~;O`nx1u1ms6XKNUh!kZzQR2On}3M!ZZlOP{e0y@OKK`eIZ>0o{${4A-sg zQ(}^S`g!_$ytzFmvw#^yJkHh{c)-@YR+iape*11^R!O@XvqGX)CR^2SFro>mu=~6c_Ep1u1 z(tefhEDcSpiD{lmpFH%Aao_N}UP;ZWaZM1`qA;~mBh-Jg^lFRFe|A-t`(S~Ii7uN9 zQ1E$}hl^h-?pd*hS2R8nTU9-g<6mvwrQ~aLjnuLz)GT1`4xA)|wd9Ss0(lCSK)tsf z>%_ZfbLFm5Pl=)uFgi)ZzhXzh$l@5Dy^`*`-mlbde_Y&D^G(ki{X8Db_jDN^x{^J= zFz&y`Z$e>})`L|ckAt7Xkwv28}dEOb#DG}5(+FNc# z<2M+2_&C*~3h%KHVyF=xw%#gSLb!|NIb$ZdnV0BrNO5g-#`s%T;j|3&C%>UTNm#Yl z2UgXSS9bbj`rs7zr+xMl8nTT>;`%Xperi_2IBFN&`8jq9J~C`OHV+o5fXP9+BcK4P zff{M3P{-qwv7ko4%p8lc{CeYAt69P25IV}FYW>tPfV>MkRDj}0+_KgY%U<$Q*ko8D zD=b7~7JM-OA211!=6cmI3BAJWv>jdXeL=OnFfKe&itA?RJ7jgACCjK95Xm@bAsCrF zRQn@tLZDIXlPVbv>RJbCBEj2;=}ttazwWwL@M0zZRQ?%~xK7_1jE zo>vDPSpC>=!lEt=Zt6yz$fC~z<#a@?s0W>H{mI}TD#5hWsmredH%)}(-m?|hMgWtf z8lEcFd?03LP|0@7B~F)Mt-ZLj&K;CB;w zyF$1Rh0^c@Siv`(QZ{;51SocneZ5#i&cb(jHUw#VPz;AvEb9ZgccO@m@FaqUCC ziN(sJuOPpweJ7^9Q}8~H5Bqh@T$Tf9HdL*4p-8W?DwnQ7G~Eod1oMmEskUPza;WGH z@ID9Y$LgpkH#NO{E%U)P%>%S!ZS5ZJLBP%mwU$#`sUNGcPh(vC`~^O=R=IZMrXK99 zN@JL+lJI`Namv^QA6_3yz3H$SE1}h~X6IdnvqRQGj*obP~%++}HtKJGb_lFWFu z{z&U=_#R8{0ONT|KSAf}EW@-Wbq3bVpSt&Pgp=psE1fJFm*8p9vE%p`O)Re)r zs6(J8=h?{Zp6HyTaecx^xl1e_IVAkunY)xl7=q=IJsI=ueeWbTlq_~`mFj?4D=*#{d)5YJ043{p+8Ndie81|uD zM^}u+ben5zOHRSGpo9G#iz}oFfid0m{q& zlFEQcUQer6?|*-AU=tV9ZiM}? zSI%ME=uL4j*oVtsbsC$QbGIdkh5it+*@XkU>bWU+%s&{9|4-PX&lf<{pJ7G76pB>w zLLl{TcGl*WF7Me|2uEliuXMp@&T&Dm}HKWHskqsD|qM;|*a)eX7ih}(OZ zg7#fSj-Hb91B-)$q=9l9hh`78<8$NcPJT@{FH|4xB8lC(9R$w&DN6e^WKCNQQCEE&zoBca9NV*|gc@eK5oF|LP~Joal2~ zH2_mQMVMJ$!KrpG#^}EJd)t04w<*C?O~b5WuhQ`x%&?c`ile#HAD5s7*fQE+KS zNkP3s1@(fK!69Kky=J2apY+oYFgmd-@@>J1K1An;Y3W^f3`k#XI()shw?i2esEI^jY9gP1!Klje&asnv%R(Gx^3S#N1TmSl30QK%O~6>d8ATgpl#EUb}Fh8 z*-EUmW$JaZ*9|sCz{vi(#yZW?zc2uAH=&!o_(+;0ljCY}4LGm~c#ZB&p07|ni8MZ| zAks2|ra%jtC_~Rb*M?Lt4f@NLHX&-8HbQFu@iWP6^CU-~Dd{#U%FVAAel43@0dh3-Wi^8qV~W{`hOXfxK83 zT;lOdNJc=~+ltqdw@xaCb1J(#gg8v^7BoO`P^`LiU>j%}bV4TZwfq z=wf2Ox+ju2H9vkXLv|dNUAF) z8Q?#;izRv`|L;gyka47OEtH#*-G-046+olzT+lKStQ-o3#S$#aL*rTiNSHeVB{)Iw31rT~zC;XrT zC=Y1r2niZXq`mP~MJTe*vpJvA++fOO{YFZ95LyG#$A>+R?1-aH;EyQwYiU5!M`%Tb zHPePM^2p|BhkilaDR3(u+}k1jq1(G@v;`dnecQJHlk6Jrrh7Y!<6h)l=oT1w2$5T1BP$Fp1_Sm8c~lKK zDo~hP+S6Bu9YXGJ#b8LPC}Ch5H^rVx!QBtI1y-=YAc)BJ9U5CnX(5k+KU#QJdo{2y zv`)omsD$?FNzkBt0>fNv@}(B`zlOvt@)f?v6}uXErv|kc<t?L zt7LrWF!Nfw{EI()kd~hljQ~+5bHUsuB5hBPxw8)0XWMWtD>ovL-S+~T|BLuqhiT9ty~Ct{~v{FT2K`>TdG@)B){Ay zfcME)f~VcMFOe{a5yWGODuUsh@UbSLf~)b~X>V|TjtIJ{KGugchYY+Son;~AuFzm+ z_!c0JS#~g!%6NR{(u_u2>L3byMvAxZqyFnJOFkpjKRCQf;$rT9VzPn!^HyH<_TQ}G ziT_UFjyL{^7$VIYN0oVmzpA~J?RgJPrX--z0SQAIuKG#@ZpO+a@Fhwvpx%r*bRA74_l`98);YPJ(Jxg*C?qnc zpeL#3SkiscTt#rjNH#eGyKWk8+VQQ%LM4iFE9I7BIP-AuyptQt*Z8D{rc%K4ihKML`v!4DJoR0_t zrl!}&+*#e~<`rN@;)D*K^0{yxu-J`oPIv)t1)UMv^$dU#%cf`%a(_5;-MhaFW+;Wp zvIp@u83UCn#8jr{k(1{vyan_YvF>dp;K2r$h*m&wv9NhHcD9_S@`<@ew%z^~M%J_) zYj03RwLl2@;S-Y0EK5A&KrlLy!o0`$BI5RqCGd)RjMK}Dz{y!Z(<6C4c9)|I#w5R} zhN|P+6MpM>qv3>*&roLy=t1-ByzQ|tJX5@#J#&8#qjGqqg-2XAh?muObnKdC%{)t# zsGwl*qv7O&RqY<9Q4XwG2$X^ixH0akE$!&AfL&qhDnQwmyNl1JG8Y4pBXt z(;3(P<&<58Q^BPJh{&F|3a{5++iUn7#*xJaU6+5uLuF_^!K#T>@g_(WJ!OMw2vEda z1|yi}dbmIiutu^-{4f5ir*w-QeIcl}Zdct+5IfflBH^%I=G~4GTa{a05A`&hSI4O256l8LGtq`mqbV{1K|*iUx7`^o z(&R65WF7d(@d?V?@(o!k>|3`ANgugugZ+6M2!uifzXZrk#E~v0C9z-0ka?^j+WEq> z*f4TE#)AxTylM$?SLG&)qeiiQ=_2X+LXeXd+I7Dd7znGfgHt&rqW5=nLvjfS0_-f- zp`6VAzwuZs(Nl}Sm(V~1T41m<&dFR`E)vm4asFIyaBcrd_ZpE}VM6Xkrg(x-KSfs* z%aAyk_X6LskE&x8r|KaX%NaPO>*~yB7VVU#5jc&<@?P{CVMxJdG7N~3e<6yCd_ug{ z;3uQC-c2o7IcID?Tjl1s3Sb?m?>V8rOH?OtinHq+PZ~vKwS$U^B=W_3!9;LH`t%Xc zL>2=x={C)C5(>D$kl2=dG4?Ne4f+l!5mN#cbc_~+7c}+H_A>H$7btD5`Ht8shd&JB zZKHD|n+C&{`DRsGKv*9_DV;?s4A_`*Oej>QTH~`92xiU2pB@mM|=#84Jmh{%=RNbJ9gTtcg4=Xr%1W+V{0Z-Pvks9KQmJU-MI z@sc_XWK>~NV>lsRPOwHNi5y&rMTWUl8vJmQ;$=&!0!|#dn6AQe-PQtbK)uBo*&iI` z$){E9P03p=%5>L#WtHi1(QAOQA=+p7*8cDnOUV3HoOSk|lj8H`f#`2&O`Y)N+af!q zz?o-OlZ9{^(2Ci|Sx&%PD11*l%wzQwvR0dtvtSypkux8Byr?NwNXpAeWOYM$HsXf* znV@bjf#OF3!=Q>96iEl+st2Rd^&Fg0V@sxpAe4tI#pQfUoVFzq%lzBNq>@?}>*HqzNbIdYEE&q40G4x{tS&gb zdq*0qA4ZE~%-)vCuI2IQ7lL@?1nA*7iEm;IY(g%2thOl#!z`hq1oy2}%SLYgN-^1J z%byfw`io$r9zR!xT95z5k&FF+l9Gp(%ImV-)YG-G;L3c^eLCZUtw$EKHrrjgm)|*=zUACRMdp^27_$ z!@8tsZZGewJb(;!j<&CbF$Dc5!J==*ZBYXMHn7kPz~T7XL)io?HvodrBfSWHT$1l% zh1nkmz%60pc@ji{Sa`KL^{v#43Z5mA)Pq3m$**Wsu+0N*C|U>*q~w8EF}Lp%8fKSF zR#||G7z35{iO8M~smX2^dD0qfRogn>qI-1O-~+&W8m^Ft^MVtuu$q3yM{C0`$o_vx zvn;nW2Gh&myr7e6KR}krZM+{IIVMUc2$AnJ1TOvyVrttwMVN)(Cq9L^|z94E!XE zJ#)iWC?IOadwk$d09fs_k{|}z8r9bPHqM9y)gzfCb7KOf_FQZdt z2p3h!oX`x8H;{iC>no55mjZi>D*-?Df&CH4H{w;0<1Ts1IpD^Iu-KPv*1WIPEG3k% z8O>K{G0j|wPn4kal_>~Fm?}_ocR^Gte62>CuzZn@`O%}QIU|6_cO$^75X$3`g12Sj zPoSsQj7HUKYMeBuaG(-+6LoF(3@81S=uIerOY{+j0)#!9TRs&4ZF?93cQVcePD7=V zt&?k^+VKk?+RW$?bwsO{qO`~5>vw8wucmd`kPc)5NRT_Ox}BVT6z(7RlM(EUhi{xv z)GFdGtcuThK9V3|_@R)ateaio@RMeYX)No%>Xk#I8kXRBslmh2!@#46m6j-v8Q$eJ ziJJzrLl1d?(>M%bydI8(9(jtvoT*MXYe*0i!ZE7<;M~RKnxeAhzn(FP)zSt~pQxp* zjq%cb`hq=1FpxeAJ&v#p3+1d8ybObyGpBJ)Mt-V22%dZGk2>I5$-z~vJ3w;RCa&2v z6bx}3O^mH2Mr26t)?(IMI2p=>jjx*-Ln_ z_kQYza3rwNgf42OK=dD!N$ir6$hZ$`;no-d&FZP!qdQ*yhG1K(NrM=W9ql{GKHKPP z3z?r^3@b#h*4aAlEdK!}aPo2bNV;~5;sjeE`MX0f^#&LCU%*AwfDiyT9M)0M4?{$>O zRK@(f5c{1PwVVRs6B+9xPjMJCH};aNRE66da*{yD5TgGI7fwpXi6Ym@b|dD4GNP-& z*kV2Z&>yJvEZg+9!N_M(8HVNN3r#b+V-L)~Nhhze7Q6$o-TGZCR=SQ|kUA+PqZ8Pc zFl``mH~m;xFTENKtYk-8* zy1j#a8`;*P<9s#+P5rm-ux>rEt0+Ke@?G;TZM+i^(U}e6+;7>H}6)XK6l+JVoCC(@o4UtNW2vx#aunsPy%qTi|n^{bA zBn(xCU-B{ry%yQ>01YlhS_M>~1f&1A?i5vSmN@4~*>x$V?yo(o;H=_b??NX9_}y~W zl~Nk}kw}3mM=|kjj!|b)C8fNM#WKtNMW2R+ia}{fyiQBF7jcK4qL9Eq`ePDye;JmV z?I-%XVYB5-bcP3la!d|D6+ZTSBRg^Y>Ok5*;`KMnKAaG7?su``I*Z_#%hGGpw_k?n z&u;8@N$i9VS5OW1KsHs}gUggf2ru2hBhuHc)MGwE5AC(vpL#Rcvcny+3ClmYwp;HS z;yInS|18$g7~k0Y-^Ue%)C)#-4tLHeCkrmx2Dn{6cAJ7Ng7tDtrczG#f=h&8Ch@Q} zGbu*nrmH)Xja51bJ8Q0z3gM2_GOy97_2Rg4aX@Mve`0=oNZmi#pS(bd`jGP93{Ej1 z-O_kh%25sYb{V)zKt;yf1v8b!YcKO*&jG|=zU@SWzaj^1z|+xuW&ROIZpj2GxIOj-nZ z*|(8ggbAWfwZct?|3~h5My{y1`EOb=mm{tepUixfe6lg*K|yeBHE+lvG5J!npIV5X zucy@U;-$bqNAL*Q&KN({BhRmP)kw3J>=rzsl)>txuz9!#n2do8VO%ZUAmV|^IdEW~ z_sqfu)1*!d-cGxVFHves7n%9G4blvN2{QaUH2WJdtS!4YnVTYaKml!D>1|O z9iY}$*PAkTC85_ge7n~adsjD5>kv|F&g*9KokPg-tGPaO1o=L8v9!!bo!i-FBBWs+ z+0e6Jq-Ca-Q%WxqJ^X>U-3U{f=Z9vazCjqK{t9jXj^eF8L_qF)nD2}0Ku1oX2{~|ZX62{9mh7U z@tl>9(ubsxG@G5S^zBN!b}R9^^Qo~+Z3C2mUwuc(12D3%4i&~z%kjZqaU^^AdvCde zZOnnbIRgf(^sv5#D+qjr@jP(w5PmV&oiR=HOhI8@9QhbW!J=IPXU7%r6tCl%WdhLd z7*oa4v^n=9f`j`Xvo(kRFjcIkUTnzC(PTQtWtaKhvP0~!VrZ){lO(`o@B7*Y4Yv!? z?!!d2%aj?7x*i<4wRfz%(K})ih^!g87Q^Aw*wT?^Q@Db@2%mz=xjZXeeY7O$vWFe8 z!0{a#DyA>%?!M~59J@s@ZN~^4Xk`=hHOJpRfp$Rw^q;s0v-xjkdFL^tPs2Sz3$wd=`OivrhWcNJ?kbq#N{>)5ZH`)XN! z!qNMmhfgCzx6wPB9C<3EuWPM3)|0QAh-LBdJLc= z{X_%Fm>r*tJqDIdg%?k90Hx_N*rDlG*AbXHA9qb zw5i|SAN5ekmH4*JX+}C4 z5ryRak;NtcxI>p@lodKGCMxEo_p#0yEH zKGcC5c30D`Wb;9MQ&yFlewu#pE{jH2W^kP`d$IAcO2NRUSTlYg)N?~Q%WNkd|4K!t z#yl^El;Xb?R=@R-T8t9uH=7NTW^a`vR1x5hm^Y`98pkFhJ;&MYw{fAo=7$v9FX!5x zIBHeiTJ%vfsGCC;AK{TL+3HWu^M?qujKF%rFc5HMkI6Zdw26bb+67H8KrwLs*11k4 zb^_=iEXWqgAQ-R$KWau-2fWPM-jnC__B;35$PqP_IGwfQbsfW!z&1*}a&}(WT=Or} z6RfsGt1gT(nu| zd(tG9tQ!!+*iA2OOs1x|EnP-5Rgk6ev9Z70`x0NE0XPnZpaHeN`a_6=B+^~VSMr5ZUop0Tl``%*sqqP;#xg+ZIX0uATF`#it}emVjp-oFX)iZ3i_;|!78 z{y$H*A^5Rh$Pl*FNE}Jy+Aw)e!JbCFq@(p*h?cVEKktVdSfG$!=Z)Hexq=XBOTOCD zk0mtM=0huZ2Qp88yrXb!z@s=&O^QO=Nw~Ol^e=)}#oGScYXaV9Xh@fB0eZ7ybc@;UW3=Ve(7Z;hVWyP>M8h$xXPRxO+R^Z7i;b$8@xi zWpqKg&&0`OZWYZ}Vk+`o&sKVZNvF!i=jBOwaASLqoE)S7?#=3XHsb4yrCi|0e&>Wl z$Aam{(WBF}c-R6gmoG-zOzxu*Y1xbSw^LM449v%0n(7SBnZVd#UFmjvD^!Ae0^vVvS!t2moX_ z*{lXU7Xp{uTQ)LSDuLu6{R~~7(GJKGDzMo)+N4nlT31ETKYX`teD>T zv7jX!5w$k!NXd(y$)dNeJG%d{_{SYv3_$=~Z~OkSGn2YDcf~9*qcrDUx;TBVi81KE z-|*Y(qrbQ+{kWjany3qyrWBsY&m%9va9upEu|xgB19o`>;rcv#P^H3a!r^b_kLi(v z6wtDmzWcPu6}Y3sdvQM*yAy|A3JQY62`>5f9k9A&xdZIkyHp3bi7QA)Bx>&Fx-;7~ zxi8JR5lFmiptizxYO|`L?*H6I+$fVqI zA_F!?Af6b^rB^oSzd@8vQqyr=v52f^S9RqQM@^~r474?DTtU*a$t2!!d~7+4nzA?fu?-W)H0{wQXlyI9hUnrQubwtQ<#f*CCIso z>1{|ko&9)i9SsUl^efQ@b^0aV(ef!TCjbdf9S_$2F?iLE)c7cu8!C{>MP%s`302zW z|GS?4CN_WUyFj>`gT;w_JhK!|GGTlnJ)*7enxvr^ByglJ6vdORmS_oMfW6EJO+MSAP?LD5{+H zSo6Et>$4x6d&CAM_s}eCZz4Cg8gRw3@9>kyjk}=PUQn0&kNTR4B4R)Ir!Bc{cL`&T z{!BK>zVg8JwGrjZJ_WZp{U5nce;DC&Us3I%-)pY-1$e$CU(#&Y)di7x;K&t9UhM28 zrYy2B54wd7tNQ4$r6x}ECCXdXbFArRq@#@<>g-qmOU8!lYGPG4ohJTT zpeU=SD*lj4ICqLtf$k-|X?Nhd`g`qjnhUbdnY zoBMZTwKivjuJ*1zO1#~E!cPZp;C>e>4J50#%gEampV7?SR4h<}w!_b0cZvPs+pzD( zN(i7toL5Rg^!(;36aruXx2&AFy(s`s66=Apr~JxL=tGeN4gdW{GTMa}PZek^X-XS} z{*>UB$#uNT5OnJL|8O7-azQ5>*<9}v!GDwR{RjkySI}nR71ADn zKA(p5@d!C20&v()YXy^eew3i#{0=s*e58qIO!(;k0DrECPfTkS=kD zXMM;9ET0_`<#m3w5#F-%+N3nt}@G*mr`CWJHHojfsT z>Az@lESCkm`A&M>z~_wx5kI$aaG`H0DsWlz)g~kk0>i{^z;zhsD2S61vw4G{_1PHD z$9K#_xU;^cWQ4Caa~3KvXcjebA1TUB2QK`oi1_EDxmK54SRikdS|#a)EAAP+O4y(T zMrs=Him?$NKEcU~u&6r)hPB4t@=a4d3f`A>FeJG z@n}_$SPD1r{~9uE-WV@vg*7S%VU8sa#6dsY=#oS!Hxf0+I~~QXx_SM+k*#0Qx60}+ z48HLgfpQ3M{O~da#u%;+2^a5l16KlIvIJ;rQEZnaMPvW7!s2~T=OzChgcep%X(_fi zpy8IAutY;w4|!zdI5ticO2I+nf~|K13D76l18Juw!Xz`4V>qpA?VIddMYUNMeOnt= zsjv9pj1+V_tVPJrmZ_MT6p?M)@yPV7epeZa0h;*Aor2fY~icv42;CeG0}2>=E5pnUi} z?Vd2rTD)gB5O#TvENM9<^*=9ynaH7MA(2-$Tm|NrMu0ln34B7)y7!ArV>e2m2TTB) z7|WyLfMUf|@r?CK+A_I|J|E(Op@DR)veHO1T#(_~fYJEUeaOao^% z5mbPYY!Zrfe#tY~YNV3(N*;OeO|0{=6fiDGLOpUP$&W;fWt(uY6c%OHyoTRJ|rAQ&TT)1UgfkywmVTYG&%~gF87wQf`ODrWHg;)4_2 zFpfSRcz0nX|6C_m!hr%MOuN;q494WJVS~B^=D!e!wP>~7zSN`s#ekB|jWc^WGq|C4Vx9l?%;hQjyG>w_&3c?>;AzXlp5aXs(1{C zRf#tb(-N^#6+Eg9auegfcmgB0I@)N%wfxT69;0G*Z>5|szPwXo&7F(<9j6`@qu zD8Lj1X$8zP7H;HunT|Hm;8AY%@oxrPPCbboOEFS8nTx0@>th)4#~j*_+lt>xAhAI}_5+DKg zOErKfG89f{cf$j;SM1`jth0;V)|`roxFM%o!stbk9E1vZIL082by?*NVjz-cUces+=XGOSeZS9CEL6`7#b^zN}7S|1Fxx@vpa zucw9UBI2fh;A~h4tm7B8EQ5RAMUi>BS9PlDAbu0-KTGd4;3lRuo!lKc@CpTh%jquNb6XqGeHyL)ph=>lQE*5 zF%!T~W%uef-%|N&0*r6^(W>dr zEEMnv%3PNKWR(ahA=Yly6cjsF2c~bjf-x39Esz2XC@4B?NI%+iOe(_kezBzolLz%h288USi62Xp`*Gmz1HEHZq-iOcD`!&RypP7OqbPR^AT>gXgwno^I6!$34!G2z;k3dFhv! zx-0H&?78de7!lp507*c$zW^*fF37Y1*SQ-s8TU=K5||U-!r&B(`?<^&$tREFpK;5D zPwwRrnP$2ElG8lQ5I z^>=9>d>O^R(^Wvcmb7o-L_R~TMak7|`(@lXU1;}1>*uOc9zp+C3t%a#T5L-1H*n-h z`pIRKq@;e~o~Zy0?W!Q{-s+Kx>hxE@ZY+aIqo6RgR16+(f=PF5sKU11Qxf*Jxhw8o z5{2g-^TD}fX@s&NgL6=|E%c$Ji}c^eD9E;KUnWbed~xd1z%Lpmk3I2S&5aYl63ziC zTY(6lVboIYQ|z_&sO!dKgOKfZ+3Ri!jwt)QK}w<^J~e!m8Ba9ne$H*Rl|G8&atDwT zzIu;h4Hc}B7%|ebMf0OIBQdWT8?hW5w_{)C_!EE;N9MD|rJq35;A^3)?qZkUTe+tW zrbjuOSyWDO*{c}xRnoaT=*qyQ;H3!a^AS;e@_Va6ZHYe)(r`1~BB~gF7OzaHal>YW zp54o&|8Sn_!G8N7ZJruKahn6a&Hn@> z9gP000^Ts+n8;TRoX3eQgd=^o1^N*i!WG$+n!o=)ljnAcB2;)%O9F~6z{c6t>B^hy z0|HG~273CcA=tTWj?+KzzB)8B)e4%CJq2DVGb5vu&Eq_FSw<3qP;_Pe33QfY!;eM# ziALzF$57*IptKThcVE{s3gMVkaxtfR9BHB&R~8z%By#!(L7!kfxHD49TjCJlRgQ%h ziZO>9Jz-%wjtR4`!i7({%b8F~B$%x8V<(67UO>5xt-yI^3m;R*WAH|~8RzRZW zKT7doPTVAkFh zK=$$GB3(XPa+o4~S6%fj&BJ*=dHEESEA$P)ai^uIbQAvJzhaP-NxOEnyJ9|!GK!*8 zFJJ7r%pME>(Q~}AR?t8p%Er5nIM)Xx>cmOAdyXKP1kBLgLqVOtDq(p=WcCr_OyUwO%~u?uND*MyO<5sroBd@s!x8gZ2 zdSYEfDS{L8jUuD3qC4&aP+lCg`UuT(aFt;2Olw(RqPO+WTqbv8EJWgW=~+X~tUdSt zPs2kUCg@^N+5{9=ybGK*BWRd&Y?$!a7UaN7Q*%=N&O&3kQU03|lAE`V73^T=tn5x! zQ8Jt4=SaOt;_^TJDE{25YdGw7T!V@1pGacz)GmAbmWi(t2GG&)OOjFaXJD=UAmjSN zf7)j~3Yk~PG+b~yHQE{4NN^O(AG#nwsd};wir%xi=LyAd0X$o^D<|_B?mSM#WjZ1B zAh{>>C9wCL`k(GEF3UoW@T4Z({#(Z*>}$n@o$5p_d`8I)mR=70|Bs>#<{jveu>hvF zmFV84;Y?{=4V+ShH?S zS+?Akcy9V}scJCL{BXNO(2 zB2OO5=r6M6!g&Tq-MEKoOtb<}BvkDv8m@JW;v6-=SPUR%&&FV$_tD$^U6Z%OkV$TN z6L~V!9PEI+wNWOzJ2cS}htoyQ48Fk<6zBPtE&MmJ-7$257KWY5vA;Xo*eE)%zj9nh z{)5&2o2S;Po^m^{rdyGKD;E$CJfWFyw~+rD$kPHS$R21_$jVSsz$Hw`9hyNe9tZBq@DVqV{ADK&$vZ>>i|`K!R{&xs)K zVoFC7zBpUsnRv&dUrWTE3K$25#0$b9$4p;O$KD2jam?~dz(nn$gP?`NeI!qPKi;r1 zdjKAad{LMcQte#=h2b}POb+O+T{2ZBfh9g#A=F{L5e#GbgIx1g6KYX>Nu`t9T)a)`ySNsrYAW%R9ni}HN+l9c&rN+4V?O1= zO(-@{tm#@_&;RlhG-X)RBhq@?aP^x&3Tsm2{W{CxbXUe8*w{RO%@lAKKakC-k(G=SX zalK$;R-P%^mcpKyNFxTYK3s)!^ECtEwf%Qc*HhnI&|9*L1sn~B-m;d2t`1i?P9H*< zbZF0YA2X~;zL;;Q$y#J9PavR4@ge60{5bG_hakpCX&14tpCcLk^fyi6;_UcYEE07t z@58O5pQgm+s#+2wzVx4rh9OBY>4^d}^1w$KVHSA}Y=m?}W7)@B|8uAPqzO|(iQMLN z%vhqU^zKMz*x*3%D0lB!Osn|^r^ggG*L!{kgf@5;bVNmyWoun}o!>ftE-p1h?x&!v z<3+}d^njIs8L1QKt>zidG7SR05_#ae990Ahz$hJ1?D9X~oDs z1nE1*uYSICyZ1WPe5Yl_+1L7SG78*WfhH|;3ce& z4My0#YVwk-@X~f+z!wc}snc94z##%t^)~Brd}&YcQelMjg)-u2{u99d?_$SLK;|Wx zFRSdk3YBVYZxJ2}0zN)pSiQPzYgUQ^Hd5kUH=XSAIN)@9Pxc#!;>QC(ua!H>abeTvR zz!XXn%5A_}09NRZ`QOc&6~gG65{6ut`YdV~Q#n?H&-BH1+aQ+{&uapclqr~9aNp8u zcdNFGcR#aER@U;JFsF{={Kd&rY8{-GgA+&A5_&1E%Sx4Z3HhmDn_2r`NU-}3*sm{!F5ZiCBw~d zs}e`@5hNMO8LED_rTOzrUU*o0b8v-f$vsd3CGUxYIRLJ9PDbnMcEB4V7!+A|jVKvo z--J`@l{n)w9OJHhDKke%iTB?wRaZD@D=MV#C8fNraKqH7r$Uw#N!tzivXjVk0r+nS zvI8dJ0lXr+5>&nwcVJcmzeTvf*VyG{M-gmcv3}_aY0hRZZnsA6;}=P=WF@wEAYjccnSDcyH zlHqxW2RmlCE$r|ibv409oBVQtt5^|w0})T zynD>r&ML)_5A|b=zl#TQ66St%A`=YR{FYdG)ZqJI!5t~+){+?2qeA7Gi=);^jrpmI zyv4W@4qLYIzbj;Sy~S<4>jj=wCqtWn9Oa1&c1>`G^UnB2t1_gfftqkNv;94zwenAetRx z_iJ57XGSQ$ev@3ZavA${icK;DsadBgj zhglprCN*;x#j~ic#yscGfU0S610NZ~S5J?eWn#49|D&`7>X;c#$+swEzgx~7>$_r$ zVG`G)T#vQj%xD{KLuS#xLCCeSf(EQZI~Fxu!4`el{QQ|JrU1OoTwrs*qiZnw+WgQ; zj0_zG1F9L|;8TZANaX0y{VvNCmt~R#jr`7qFNrDH^jHM=umzWKR6FS!kDw5Xp$M;Z zk^^6KJ5Xt&O=P%BA{y~dytPR)fOK;gEl6v*9QDSJo%G|iQ|Wc-t|#>kaF2OTKND*4 zfq7xIf>Tm_wrVm1i7V8t{r)BTaQ9hv$I;fe;m)M`kZem>dRGyMP@@RVkt%2pHG?qz z;agoav=$D@s7DRnLf^W-QX9}5`eDT^uFERg`#JN#ybp6Zhh(iNDc(}8cUd@pycd*S z>5}eiXhZ$^lTB|@T(jP`;oWv%NUJQ7-0>H09;EkNyPqGHl$D1~_K6$Ao7=SpiVV(j zi<@$RypEoFpgPMY;@S2zQJL%yW(YoLU&`SsN8r!!YR(3tH;$eJ=BiSb_t^@Q7~(Je z7<1w7<~fqaZ)Hq+xl}@?v)~&w-9PDqG&+u3`A9-MEe$kp(V>LE#$;w`DC;6M=$1C zD&7KhDVxCXu~&vFKjU!pf*Bj~_6ezEZ+!)dzveLeN%QC8uzNp4#@aNq>jaV7Q)XR<~Rb1FJ(T_(Jnv_tAqR6pzMyXq6xA78v@X=EkzSO*8oVsL$itO%4xMWG!VCJ z@%NV(U1XYA%umEq%lX)7FfT6_)ru2{Kncmy*Z|AH<;JEe0>R+`Kitg9zsvcR=g(ts z<(Qq7xkiLZQqYdd?!DC|(HHwk)Bg9W5Rt$^$#9wNpc?3YxJ_*w*fm7(AGAlYB|%0t ztGw+Xf$oGpocl(=lVJwdN1Bv?J;Omjn%g-y`fF=~*V+IVr^zOI2>2Lqfp=c;eqo)& zuV9y(ZO&Ees2{u_6!FQ0@^`=Ci8{xJ$8z6|t?Q${6!xLd@Q_>&?1Y!G7NVCZrW(js zKEqlVY0#T02xcZTZ3D^?#q0_AhTQihO#3Bs>rmPNqU`wshJx8}1Z;p_54NW+P)SdL z9D4di2ek5#c=-{@o;vP1fLg?)(SkB^RXzQO=>BDc{E)~FT~U82X#Fot7sXRk8Pvh# zG+~$!V(SaotEY>J8`+w3vBiVWSIY19)CO2wW}ON~besacfj=nMr{p$ve~TIRHyneR z1`(2?c&6jQ8R>|U7u*DKM-2-#)`-6}#;ulU#uuImD$2kinD878l>c|C+3nKzk>jhio zcIP*!#4>~>!2-k6e`CnfcpNpv8Oq1q)D~26tQO@fVJMch$P-Pw5reH_d)x#0TKIk` z>C&rSmd9~PQBjvxeLi4JyQc8ypQ?ozU>2t~emEHTCo<-C!g8va=;BvB{5aTFu(xip zo2lkl*i*scy~-woB?aB2@ghbU7{zKCeqR*o9dp~3N0+HyQUu#J$tmK!xoOY^NnZ=R zTj$0It9w4Ys-n;VJwe6g_8rAr2ET$8s1ski@{L8{8DtKTT-A|a%!vbYBrx0#_Tf*w zJ3|>4Y?gV3C+{Q&rOP@{Y0-4J2M%^nB`3?W@konZ(kr~S-H=gUgQQTxgJA8{#1N;` z1tL_LCCU5$p5AQ_6bbUb5PPAV560)Hnt@n+F z`r6fIhCI^!p`nqk8q*$&3~ypR4#}oZOadd?US`a0&=B|hky>35ek-i*z^v76<6WD& zgSzhBk(J+b4&qpH)Z4fcY3PYl#RJev!uAV^I}36&?jQdNqY04J9Pn&ZnZW*kMgP(O zZ5+o+e)YG7Za5PKg^n#ch2+WG{N<0Xr`R1`7etOWL5>WlSYx@CzT6yGA7eT-HCP{{ zX-nFupt7m^T0mHDfpZ6#rLb~Hc!gJ$2R|nQP*1}VTqKkVj|&K)iWlVS2}937P`v|B zk;B~Ysg3KLzYO%b-rku;Sj_5>ad$KueXGoKq-3xSRg&kr_RgWYUpEH9%nYa?HHbq1 zcH?kagAStv3WTr8hBgu}#1VJRm7%pp*fl-TUg8}x>}cbk4^^Y+Ek>K}G}ag}PRA76 z0i;w|5hqz^NyCzq!`TxBW%uBl$eTALQPXYdRW-CYh_#__uDgK|3s-Z+# zI3;l{3WclcrmktfJdXOpcGrOVI2YVezy4hx+OBs3z*xUYM3j`4JQFfzJ`#Q0k<}Urz1$qu#cE+65AA%Lw>(%^R;x^$0@t&U!ohy)J;oRt>t|6*;|p z*!LyRm`4l`4v|MYBFo_4kK+tIOVfgDwb^N!d9oRqVKg?7EvhJ80}-%G)u!#M zY49x{@_!Y6ttN=2^(1KyEpX`j%iCNwO$Ca=LMChtDCe>eVsjiUtO zG@Pr02DAV9m_db}{eOB^G6yDqJ)wZRF4tsFC(&sl@F8Xbaim~pbEhB$hKzb%Re+L{ z9q;0mebiez4G4ehAL|(o=07WbSP&!PbwG$G6fsb)U1r!1y)T%mLAEdrL#K66lcx? ztr5ZyAETGlX5@=oSNR5JQoCu0CP+E?_BrlA0^q@2bJ-o4vH5Z8K6v>kyG8fn+0@7P z?#n!}-QknaN#_kqd|EbNxLEC1A-DBYMH^9+go(wu@oTs)SrLu9Nw{fjnTF$)=#*PE zzZMt5>o7x+0ESZVzJ~4MT1dvy6ye6?vHQh37mJED+d-!B0ir~HXWIaS*(7Zw+W2ar zd?)jqezQbPJf*3c9RY3A6Mv{7 znNeA2kQD}cwz*N@jehK>>1{?95uoQhzCv$5q9HlHU&2QYdsny%`~1r)I4f1tD$#|I ze&`(uc2&!_-bQL25V5=A1Y*iC?!*#4)E3HFR(22oOc3`s#jJP9q^+-RAik(HfOe+7 z!#v*^*yDjND1)mbhy5Pj*XtLr!=A89gPmjagx?JHJq3{YdiHEZzce$Xmx^H4K zWo~o{Bj7c-R}WX0B#-!4_Kc&qU!-jjcbJch-bB&~O&)X=o|az+nRIaxPI1WV(e;?Zk*Dax9G&CG7U@)P`f+9*DJ zfZ7nPZ*~0J)&TU_qsxtNZMwNo$^YfE4q+lPvBrQrGvYZ-XU^vB*7OQbV8DkKHpQ{U@{U9;ibU_B`PDk>RA%qs5nxrIAUiMq{tn%4+#h zQ^Gx-pXMsJ!2iJ2pakqrCX#W7egxa)E1r|1g=)j#A1Cw7!~>}a7-tGoNcK~f52oI} zJ*1X_vHja1>re{+-2>{vCMvgveB>eYGp*g#iGC6h$r#@F0V6Mng8VmcaO-Uatd5eY zZg;HEa@pzi|lm`0NE_JT*Iq9lYyV`#=Z@M4Cw>sRvN^O)9l0 zG@+E3no~g_ea8?ZLi?BkIx%z@ho@%e45Vsj3ygt1m{UEp{7cCJmQ2U{xjAY~IV=VFaQps6NBnN90#c_v$(@^o&Z_hEn~}b%9R$0nQeRWIS->; zu7XYz(b-CWXMY1z{ml^x50{18R(5hOY|Cc5jk?6P)p-zby||?gVaN)(G2}}ccCo-` z!McjPSp)gBFKagC&q#sdTfHqP`N1BOG|fV&4BYTDVTScqKZWL!9@04+&t4+x$u>b;@Xvun^DElfVO|pyH6!5~>%|)Mt-_>EU zD;lGT&)|Y9pFWK{_(^(czxjlLeM`nj-=SV}6LEe32LC)V?vf**RNNl7xg}^I)rbb; zd#GBxqy!Q~iPe=bf54q%U#q7zfts3hT2wwpIie;|EpckXlguZK=XR6d0l%b{Y+0a8 zhLlQY+yroY1vFM4>cMnM@>~;RuLx^`4qQsxi)I8wU^FU>Gw+o|Gi!A_gINdpnwf1^ z>|pqGd97{nR$ClGh!%OI)1{(gLjgHZADHJe>tr$oZJ=)Lpfi=g;~-}m@)VhWW(3eh zrcKg^J-%$Lt^6A-@t^KM&L7-`_X+O5SiMX$c`xYt<@fYxs@-zLtY;tZLE14KIr7eB ztkIn~U>F5KS4t&e>)V}Crf`~V%MMySzdU_MS*`g7n`k5?>uSSA003Pk3DlD~1mE!1g^U5xO($?C^*{>Mu266geaD2@ytowRK}Ns@ z^IFLzj!R#izWdgDYUY^MD1lygv$O#9ESMMXJl?zFtG!`v{_t!|JbZm5+SvUark+Yh z|FKXW@a`YREfpD~VJ#3B(H7uvb0<3TIk4C~dVA9|?v+7#^-(3(+5?Fu;07n*(d#8` z=MW>lxVx)ZNc^5q1o!DiA>T`Pubm$+*kkYPBS-1r-ylO|ZpA>Vb&~u*d2^KqqRRof z&5YxiADUI^;HiKj?r{yk6JsoLKL{A01tfzCBh!?RT8dGPa08f2M2%*ol+=%3c!Hg( z{BS0mH}u=p)>4jhe~ssfDqbaKr~(0Ty||eM;O)*8!0u6jsKBm|B)}*8#E#0lWh?6e zK~!@8NakqrPSR#87bGQk=B%Zh}=@(OKj;!C%Z`yW?S~)+X5xeMe0+ z$mw8?({}ipCuPO}$UnXD?EP1GaU)kHJq#Bp+qt0oAWz|?W>Zd+*=uY!7xyraFDhn84CcM@YU=S!(;ZK57?8#UmX*fn3h)L?Bz%?3MX{V5a z4+SO+>%PGXNSjK5nb3Jh(^vGa#PwgAha*(oa>L`LbYvmB5%&+$3QQ_!dy$N;QDU1@ zz0=h;nn(1{g_6`1lIc9jysrc`rE-eDNyvv}0%}@61|A|LZzPIU0S}o?=uC+pkgaFy zV^Qh8Qy#aGiz%15eTPbg55#T+6&GD}JdH8s+y{1{*Y@-MmEiHt8VNO|g;X2|JDG|bh}CPxq`o&&zDr+?~iu#(Ii z7NOh9ol~?F96qjN{~T6Z7+rgpv3H_O0V*cJlS`d3)fi5Ip~T1^n3Y+c2w`y7eHQuS z1i8^}&~VN0XN8PNFP4~4dd}uIDj26GlcnbB0{ArYFf?6%rq#@C5maU0Jz;_(rK#LQbQ-EApE%-%`cfC9Ixt z`Wk@T+3*)R_6i44Wy+93)!5K8ARCquwMdy7OD*p(g&kSZ%Fj%Z_%qWtNRqP_B*7eK zEo!~6Q>#wPzdLCQG^ZtWlODgsxx*+Z8<%?dFwT@+#Xeito@(2P8OdrDOsnXI zRYHp@e1RR{vrH-l_9YQZLA&=$d`Xf7!CZ?fec}Nn9m&T!EK_locct{|OH08&x=IFN zX6`Z5*mAbM%G>Q?k5b1C=T|DQpqd$8E@+!z~q&!60me z0#iTG(IPZZmL_0Dv)b%^&dW&Sq!ZTfy@SYl3;M_kijl;(;4zBwNPivq0ZQ?)lg!CA z_82C2B)0~r!j{2~m(S!W8w7n9Z)aNdrPlMpjWtxlQn#^3hqHwc{k3>C0UrEJb02*} zyAsKNW>i(p^Vdl(R+8QcBms~z2MtltBMQ_Vbz8iN8KRnWOMp}=JVl2EDjT_sj5omj zoh?JteUXMmi zavo?H_)c$3`sWS?tb$AfeO?>M{HYum-Uop^NOJ_&QmsY6%u+~AEAY2pb_>fI<0mYr zH~T~j*wShZACo<6b*SjPJ&^k8%Z*>0_2Lz61msPMFKvru%hWaM8R zMZk%$cAlxGK%^9nEc^j96>AFM2XWWq$_xM^$G9{J1IFs20g6C&afA=FxLjMfmNl|T zw`cmaE$9Z{xqX2Io`sg>z!Vf20;C{XHH2)pU`qQJ_j}jUAs)MbXg;UX z$Miv%2vgUJrR5snduBi@P78%l+S^!^xH04`z_i6xe$O=W9`7~OcrTv%l$5|(+qJ#A z)jmE>}BG*^D$t4Wt~%5^j!6yBP(~Ga1(LrqNEuw%d>uG z4J%G3pKbV3u^*~gSv*_(24Z5d)!qWEMR0thviy?~>9u!V1H9hFb}e){OPagJA3I#o zI#3a5N@g1zzCDljb)FE{!RpO7b>NuGA?64RjUZYQvyT z@oDyoc6LV}`Hp0GvKH|gMgA|>Ph6CY?QK;~%uU3CKjdLe%m3_}KP2n71WqLKUStBU zV5#f)a>?;M^?@C2nG;UT2iWlr+N%AVzRShA1j>n^Rgtx0h(W>^7z znA%+r86$WY*isq*H+=$nwmahh4fA$R(TiKXaS5~U%kA%G6^D)isSYw(2rc0hd&|fy zM&N`%hv%>nN?w6XEyM3@g)>#4Sh?H6^h-jFB|s}qOGJ!Gu7YU(IN}WIxeq9o{Ofze zi4&(hr$^1FVk?vz66(~*kZpV?WUnu`-&+1T*pCONILhG@tvy^t@K3LJ%2qtaF52am z31r#E4BMO{5(I=PEb$gxf3CRzxo>xiANpT5BZwDo%ks(DkF-G*4yun%8fR4CoWXlY zCz+A>^Vdj1n-idQ^KuAuTT;r@f771;95^Z1rnc%xXo8X~O4dIdfL=@m|Uf|+Xt>#5oz%gTfW?hay!MeIqMgy zY;x`So4b1j@d5g_%LxUr!J^}-E1YNjrr`w{0bI6F93^ zC1;X)QF9w+Ep5e*mxa*EqbDc3)#-ajYh=2^8ngrb?J$Yyc^O2uiBi?>#zap8jPncN z=+k4n?Sz3F|H%Zsu9_74r_n02XUf{`aPyyI?+bjZCIIq;oH@h#`B|Y4^!a`00gzWA z?;h%}m`2ZT4$D1lCW19a0C>GNWSTF{;~OaZ)&D|e>edF{!Iv|)NZ)lhbp%?$Sa4Gx z+uqPz#f#gAtS8F5#}VEcQFiIF{FX187@YPW!I3P^a!ZNvd5G1>-nk7sUdDl2u>U;; z2_NdVt~mTCW(TzFENS64P;dXC9F;Rn}N0749 zO%puQKr4)JE$Nh+Q<4Si4YYpGOKaEUrPRDyN6RYqy`OWOe zk^QiNVm{2YYbKH+E4`&ZhLuJE_3^omg?;wySHC?p)f7lMFb4KwM$wmG9@CVW=p1)x z8NNWr-X0ek!I1q!kPjm~(QQ^-#wqFZbgEYKSkY1 zi!Y8n1wE37WYd_OE3eO1jVJ9gyX@dZEcH~vW+o$9@#;x)(-50p^yH?iTu#M zLfaQh!j?{WMfFtfZrW}7qhOhv>*RhoQ_Ahj3c<6AWG3$H+z<-P^74j!Y?5?Q%6{Z{ zpt^hemSc#!>jaf`dFpI<3mk}tENrZ3A~!kD-#H+Uhte_JTM#i3s%s99$D3oy{q&-I+v2)d)lxF&d zzQc)^Erlz^RlytWnmQ;$puhaAcC0((rS1_hr{$ml+6VbSBv(7Y?;L$V4*+Z5%`r^V z)>=FL?6a;d6r7=-TT)i`0e~T+;nb?EEX^xO=1!CyhPMYwtFqbAPtL~db2mD3Ify4K zaGNTU)$VjcHgP_w(B@w0z`C7!YVbrCAIA0{Gq1xTM*KK66kMoTd`}2=m*-C7e8T}? z4T(9L<%y?Xn0L>`<=TG5Oc0Y5CI;=F1(shVyGbjIA8jo5w=2xk06O%y(9NDAZ3m05 z;Q8Id^79?{hQ8!wbzTL|6ei68AW#rB*1vN;taenz;7*$aRGMhdvwJN)A14T{v~Wnu zX$*aM?a;u+gn=dM@ZI}?0NO7oU{yHVK82<*)IE&?S} zKd6XLccj=X2oOqHpuTa)RvT3k2Q^3~H^A?23L?n-Rp{Y9LV85QMqUn~?I@p-e}$zcTUdeUku#O^Z33FlbZT7t6>G$EwATBKRDZ=| zsaIf$F$XpZbz3^6BO#z z#mcBJKT}j;y@&B!jD2lq+d9e2jLSQp`&;(!E6BpJaGOVI-vNoK-L;<$`;kEojKC<% zX^f<&*BgaMxwP%F%8E?ZoY*d?FRa+52`|MH=zYw*wPOMij-Qc!ekr#z6zY<| z+>;f2@8!If_fZVK{47oYB-t1y zxo}W8(q22b`>{?8Ellm)GTfNtpeseT`1|WY1awyo&b^)H4(mAw3HJDh;{%==F#kc2B@~OHEYOvnE%ZnIpvx}>Hh5C0gW zCLSE;V8)c==2eKn9vws}^K}56{S9+By0+dZ<>-w6^|j35PPNFKe!DW+7*|j$3One9 zp@4*H#--cBFR;a~cL*ox@LLpx+-+?sPd|EXOlD$@hpXiHTj^+-op?32040{dC~0;1 zk2uAVKdoR?pC>bj_h-i~p&LgF2!12!TK_QNf-{ohJMcWWq5pi)kKXSjRefDmw(?eC z@)K6)WKe|?Z#nnL38=6-hX35cIbOBdvQa4(iU?FSr5r$( z%_yzuua8BD9sW!@gSqKuw;Lz41N@R=0h#J5yL&Vc9-vMGHUYe>e6ZXB&z>vn#r#t0 z9*uG@L|75$S|^oOQBy15;=${eNQY2PV)AHQmkY#W-qxFvxYHL6q)C*PZoG z1n*tadt{Fjjq^T>G5{l>5Jgo7Nf!=MyP{)t<~3M{jiS)WOH~y}ZYSSKMbiCx+g-%& z?!9xyxr$xDFK8}~H>_X8OxHV^r+C3e0di| z<6$F@CyrHCwj;E+u0VIkSCf;5VIYB-7T2|B1s#MUXd%r#;kT_`dZqbFaHtsBup`!$ z60v^XxcXJ)xXl$BTlQY>YRj zOZu&+ohrzU*l@)Jnm$$!XYN>TLSt)DN+*2mJ%<2KPs_yS^;X1;zM)(#p*H_Wt5xFY z(x@Y;(;n!#vj(>q^V##op)meqvx^CI659FRu9s= z>M{>6%b~3(tuwe6g|11S+w|1HD$fPAN2=z>+8)?C4Hm?3Aixpof83msJ@s8@af~pD zMrVSj6U*Y>RsXuguW4Vhf+oV?Vx1X`M2zt)psd9){Fa4#o#uO^AyAaHfrMee&bkBE z6WEHay8=}ifW;-sl~~&_JVaiwd0Vwm0l+c)TdLOx0-`!l8RHURae_Qenw+~7XXj(v z+?cynlS5C!SKrBr6Cg&R8{AIQi6L#}8ud#peRL=~NnM6C zmu-0V^Z#m9_uwzOm_tzJTBrV?FGDm{^aaMHz zxzCEZ8;~1P*4rZSIP%?j)2?p_WFH)t>3%*gHg=t;+ZZV+twA=|X9#`0HuxDf_cT?{ zCLFOVPy(h_WPxfoM;Xt_ zFLePOmJyF1RkiOpt?BkgY?bfyqX7Q+0dD5j5$2Bd_0jGmKdP+LH5~j11N!MSq#ZI5 zo=kFrg$Y<>tD(U$`_=eC8X)g2Tts8xEZo>BiR9`$)KUihT5;wDyU&-_TxOw|y;Opt zuIhoi#0S(|>4&>21#_Iu!q6FWqy$3T7g_KtPw<-aR*p2NO|fIn*Wf~)f6)GxnE53q z+xaQOCs2gZRdB4pK`_`Mp=t-Tz^KG<4=xPqu9wkXTIBt}Iy_KVWZ7*$g9nUPH%O1d zG_T%jtiHwpo!S;hE*H4;hF%H?j<|xgmeixUD-Z!eR8FgJ+J*XO^6a7>+gQ^=l0jA+ z?Kr%<&}ZNRijXu!(hqBzxhIH9!9>fjnxy046Yf9-?@{&WK2D>@z;36KpgQT*K66r; zYf>syo}+TC_89(qyXc{t^bIZAB5a`TJB;HL z*UT~{SjLYZjYN$BcP!AEuZJE#FLSIH<-fD*H9ZM#U!$l*xg`8DYY4K;Cnzlzayqws zw?;mbcS-l4zz{w?t&OVi^aDo1?2)0j<(#tmIKc0HZ@=Et+bj>##f;>q#AMVM#FMxg zl$ue;v%2A9TWOQpM+1!TkF=vzR@a5?fpDRbvUW;Z@ieanhi%kb%(NpBOJR*WU3m3n zuung^V7}N`whb=@jVj2?7epB8^2YC6H*c3RT=QS4N>!p!5hbRJ1#8k6pRK^% znw@5F&1W+)1HO46rpT4i8V>n-5#z;sG zvzN9&SZCF0G!x0LXn+RMbgjrx+}sqA)f@^@XF?+saB&xI?iNp)z)DK|-5|!b6Caz&#|w1YMSQ1pkJhx#&BG*ra};%C!9Mym0D|alJH!WqA*!PtUST_3 zd_*@uz>cJiPA>4~EKgQQks#I{%+8tI2`5Gs&KzL}SJGPr`3_purBVAEpLN@OlJ!G z%)pR-9m8mLxc!9lk455#b$KA*yB5U_49Pu>DpfH%JW>;#4ZTEf8C2jEw0D7(K3h(| zxweo?C*!;m9)JSCI)Jj`fr1VU=}gSy_`XQ96~(;JTi zgHr|40)O03J*vvvq=o!`7)3J3HJ6c}L2t1bd-oLH65l$SAY=CqFw5cRmC#rw`vS-7 zT@vfZLdHwsJzQ@AiJpTms2Ja^(Q^Jr%;;{9NCKre=Q22xMb=8U7&G7Id zaLr(jqlXkx*Jv^BrxxrVPwKdgM$jMTkVxoS|JupIB2OVTevbLP$!TQ8CVXpGx~DZ9ICvpG1t z$@2Z9$A%801{Phli|RDpRr_`sVs~NLe9z#K0R7!1em0#ryH+z0Ke%>#l&X_(pul{N zyGTGCLx;1j9~oS;*c~A%1~1npSF^Gt)lr4O9$ZMShf|tY@e;?1gvqYFrgZK2QQBqf z21c~ZexeJyVQl{9|B{ak8mQ`ej=NsWh2MsQhd`EPv^x138|Ok!GaeFt2CfUr45J_Z zb+KtBQF6eSdi?T`k&0)%>BeS#^A6$J`M}tRAwFlhJLu6tr<7S>m8US0d>&a1XG1^+ z7Ak^t?T{+LUGNYfCiO~*Js>dChb>=*4J`+$0j9dLSs}~^JJ?Te(~f=IV|%Sl{olgsoE7NI>tuHBf%WM4xE}1Z?Cam8q5Cu1 zZ5acoTG;?#aU-)z{c|)+WWRicldm@ceFTiY4Vt6JD7#LIycOjL$Jd+ccVwy&KR9os z4?FjZ81A^BX;B1U+F#-=YCTwjOCW@%qcfNgunObqcB)FF;V2er1{aS*pHaBztLdJN zg6$s#0SqNz~M_)b&l9ziWc%~fu3#aLAvFf zhud!pS73S<-_*Tr>!PMbpAoI##RLpVp&>Ts_w)9N=HiT=XV zy~q3>1h{u=U##5%=4;T*q%@ms8K@(;FDdb-^$wb;S#0Ar{6~DP=?DtOs`=kJY5i>@ z{JC#s@B2YU>_W5L+ySC{_izD_uO)>nRpp2nhlDe$7S#Z)cP&)d~>on3Qyy0r8h>;_#waFp=Ji zuEg|?7fPI5oBdy4ZHG^n*@+;M;b*t;s-T|Rs?Qi{nQ=l1D=`zvCirHw2T0ClUET^) zv4z%AezmeAvr&8NWn_X@8wQdr^MoLT-^>{jqaze_#$9c79ernN|DnLB=I@3vpBX>o$QJ}tKC#$MUIPCvfE-Qgjh;&NE__)MY<*Avpl;CW_pG% z47bS&rvSxlRbxgT%e5PN#Q$8&2(o+K*+z6T2obf z0JRxb+YlHa1C1O@$hSgdz4my_I6KC4eRqGfvR+>DURxk+cwalFb10E#BM|F7KF_zz zww$Vs?nTm*UbZiW#4s^@KP=xc)nr5%UCO}!E}kAmk&RTsmf`h$9{IjbIKDSC8dn z=WrC+(Vw*7#}aGM9zJP9Ram1Au&~926?rcLts=Y%lKKh8y4pI0nf&S#ok46homPE5~xNo8jj*p0xizh@K94M6ycIE z8f#X;&~gcB$2(h~5@oi4zyJUP06iANvNs0(@O(cs%9Qd(Z8rPDX-7HAR_d;G8b#k7 zP2&+KS6)nBuUzmPY1~PRw!~+s(~x|CB@Z%)z1zu}B$mF7Oyvgyq7B+09s|8)VH2IU@L+&jpaMP0qN} z=Al4O{9CTVMv0gn5wX)hFaTOyS9k-|0z4knjAMlw37y3y>H}BeZ~Z1p_t{5 z*z^a8M@__^fYyKj+mTHGl~namGZ9?iL2oy)KfTD2fdBv>3IU#_DG;9k06SR}K$feP zXe4X57Mc+JIM&l@j^l`j;CkCpBMQODE}e`M%F_J)t4Z5B06XQRq}=d<^QXl58NVcW5WxC+OJY>qzIn8<+zXc{|-F?cR!%k#~9S_Ec<;hgxtuS9}f@uyAo|PrT znQ6YCkG4x#=ji)b9R2z%ciA&Rl4!Ntqr@|$OufWI3Hu7=-ZN8tOZr-=UZI~7-w0`% z24w9(C*WaQO#P>l)V4FCe3?q~8Mp!}$<>d4^mxXmUj-XS7%__z_fEmaE>X#Hs@g$h z16Ze9yMu#gxc!@9Eg8m%jg`l4Coatv~~$)W%rqrvQeW@{&76P^w=I; zjdnhlF%D7ROoL>M{{w=-|aWZkcqGGp57}ZfbrA7oP7=A=5CN z0+U8p9QtmvTO~SQf6Vh87K9^$>2K!czx2g0py4_C)GQl{zZzGra!jB;dHZO1xL@PB zwB};;WYG4$+Obw6Td$*7E74~yq-@WPZKysT;-s6l=bB~^K*)-i?-(t) zE*Nd^34*bK5KxLh23+inUm=e0l01DyM~Ht+U%=c@tHOehMJBZcO&GJy*dV5R8EAW1erE>tV#B~pJ7$;^TdyOgL8FBIt^4 z72v@-HyRRGjwdTrUcl^u+aMj|o1_D=#HRUAM#f3*9&n^P)?G!?$}8M^+6g9}bl4A> z+ZKOrp+OlkAsj z>2xm)h`7-3e~nVl2I?v+Khtz|ptYm)zcA`IBiM#3JX_$WX-}`~9CgE z6FmwSjM<4VJcp&s=lprdw5`;yF_A9Edo9Xuv+!|I3Ro9H@St>ALm^>B;V>5cD@3&` zkfYrcYRCxJje4EKq;@H!N<52skAzE^P$)ZDqQ}n{X1~FLns3xG| zS2P_e8EueZy_BP&L~vBY_akMW0A8 zX=DLTLMjOT-Vu+xMp`#`KY?%)bZy+26yRE87L$M*1#$KH=H@wNGWl<#O<@m#s&b@q zCy033IUguC9%|m~eu)`7be@z!n4kXapWUP^jTP^22?h|i^7I5N1B*D-K ztpXlC?L`lbritiXO1&Pp5B5r{))j~TA#Ixw7UF%B%`(B(eDNOc04E5I$JcQla()qX zm%M;c%q{kMgi-~3lQ2|%&wsQGoR2oVBmT3O4|b$&VpTSP41GmfhCSolXUkN#tlY2s zV~LjUEF{0!XMi1{Pc=qV)7NXKikA67U7y|`_?<;jA*7yQir`VQDOf%qgh;< z2??7z}-1^6xNS zZkD=qsITP*A&(K~csalsJ{={c8(f~jn4F<9(BJZRkKPldMpF~5C|KJFhamEAnmVQH zsHDr6Ej6%gT)&35i-rfh0^+3}|2o~^I#PjwcC^$x) zo@mZ5qz#C@0S>K(*9K5(I1xL1BjRx1E3>qQ8L4L1I6y`Brtv~TA=rTS>zW$ZITKd9fRXW^^}+y{ zX#Tw*b{3@o9zhPZ9%M2PcWjdIr}7EnUzrSG{WrGApXu6GOdYg5B8{zWx-X0ez}PLHItvO=ApP3-9*=QdM*p}x4XDKPO@zbwl4tqFZl*nt(P8{ zZ`GHvq7?A1?EjVjU%F1!@IP+dYpw19T!w}mVQZQu)OSbD{*yb7<_Q%`Is%KCd7-Jv z?w1ZtJHv+~dZ3PbnlmSl)ik^+UMMEv|xCx=tW*}d);DV?}o86D6+ zK*+*-cE9iL-LSt#K^wfR2ah(KHWDyxAYT#0(!MMv7r`eP)`s4~)$D|g9qy3nczatd zTZUX?f9}JYW$`>$&ZJoGemdaad;U%NrRi(%>0|oVXlUcyjS*%}tCIS;YSa}8Siy&Q>ox!!ms-?e|qPoW>a`blqfN_MSqWjGx} z!-`q>HZ2XF1C4*or(Au1c_Q-BqJEjy;~uKy-J2M&%KXnJGr>V}6CMf?^dr+yc1F+o z=}JG^N`E?1M7kEC(hvD6CWLEGrAC|+_`@wfmG(u{0wQXMi#6<7k1{sdQQi9RNzeP* zYXDW8LpSi4%{g7$b?vXlbKxG#M-*CoSCe6}EocIREwtioyi!8?*b}W%ys>>q=b~!j zgosPYyNI18IxMirD? zrWzZJvXzEe?eOgPtO)h|z=}ehPE{E_wl^nrtmcEymQ++P@nKqCI)m0z;kvv$rer$8v9 z*F0+lSUukv3csSe}%5}*IC&{#niS>maapWklg-`-F`c8G6M?D^PB|MC^JI%M%7@!cLzlXPeVsKhoWi^UU&zE`~2)H%ZW)8gw9Y zh>iV?C5LKL>6AuyMhJI0QfD7wbL8COZ#%rwpM^TBxjnV)6Nz*mh@g&p^wP|D!D3wJ zmZGu97NwQ~>(o5(gd@vn9ry=>PKW$Gqe~^{`^S9## zV5;XRngnyVEUuFI2j{YY(PIPh&-Z|dztMg-as2vmyW5B|b=+r*d_z5i5f79J8&ouy z6udKDD@hoa4#gCo85H^4#k>2+pi8~EZ?(Hfn}k+0rhX#KT6(pbshT{HKIW@G?UESQ zZMLw@1no|Ql*l(8=+gHQLeJPt3@1a<8+hWbb=RwEwK*m))95y6|3eIiMX=+*J|^rrcx8%U$V#jE)x5HjTZ}GW{%Es~&fV6w-C1Guee*zOHl>pD zWk=0a%waSJe%=p&Pl~pNepEYRX|R4N%p&%!Olao4S9UUD;C>%GE^Hqcy6o z9N-izceg^CX1ymp)O{jslnk#SY4xPh^p@3Cm$de#ua#j=5L4t@{Ts1I1ep-1+Qo(~ zenZVf5^zgoimaw1V$`|b91s%h9q2K9L?od{Qn`)epwY1pjW4hB#AH0?PSK~juywmSBAwg=S5k!&-kvH$&?pXTnuup6CE#3eGmKDNNhGC=E4p#k z5DG{BoQp(?I#!XFTW{HR66$iq%9VoD0(BnGL=L&}VGZC5B%p!pXXMt7|3ha!CRkp6BK{6!hY#CaA|uf)EI80opTst|1nB+x#l4$-n#&wp z^CD9@C#+|?TvoWXVDXg!SA!6^y5BF{I3c~v^ZuyUAg`ne98}YUFqN?C&YeG)TufhZ zkk_u$yrWOT1`rvV!bH5!&(q@$Ru5{44qQekJ)?H~rh69TbHTpb|LH=ZSB`C`KVcKj z82lE1ze}wX>gBoXw;C47093pB=>vad_{u#>FymvharCH{1{BAH;-tm_RzJeadBeh=IRrz}j;sWTV+rF>G;I)-#q)_|J*RxPx97 zv-6EJ4s`wV0TMKv7@g&~D~_KGl->D1+ItbQBWPM-$@JcjJ7sfEF@7A*Ra)6p3nEeK zsLeNHpg6tHl2#kyuqJGeiye)yJk{)dfzM>a6M@HDRP28; z0`QESDdt2R@!Mi2e_KC+ra8QZDu7sL4^;=^uM) z2t72mv~TPl5OCNcrE-oCXjPebJ8f`1ku5CB8aBVZ7-tU$D8O#;*?P_ErcraYLE-*Z~*=2~&pvvF?RBFf4|XZIRWjSC-p@%BT5TCkC^lXc5Mj zyJU+UXL71~_*IL-w6NofOP&1Du>lTnRJ=YWj;_-e93420s&hfS;YSCJr~{f{Ib5Er zdVl4DD*Bp!Qs)0XV*e@S)7dh^`fwE*KFMl zkILi~dO6cFF{L~PnY*wjGKICF&bkX8)9NG>cd@}a*34#IMRtU2m;ys+`Hl=;Rf*R$ zB5W+!DWY(t-tc*0ji^M(@U{QvD4A;as zyI9{ss$QN)sTiHs%Fan=ID;5Yg2is5#H=sZ4ECKX7j1Li?uUN2d7H6*-1#B?<8?*X zz!7m1fg;43N}`$?45}CW3Ddk*JC()jABwcRY2E+efB!;QjD)a6HEr8mWB6&^Me;Kx zLSX(uremU?VY=Dl{-aFx7Z%5lI!Z|z$iZP3VS>%{AG)s7cYavNH#K%)8FbU zrWmYAO0{F)9Q>dEE@%pNwfZ{vDakHxG5g;YH#YCOgA&%wDRr%CI>`HAor@%^of zSQF29<1w*&g~4q7jg`)_+n`o>s4}K8fwwv^d_tcvX*6@S|EvM`8INjheztLrEBz3J za-$%%dh21rH616xE{-wk;I*`+d=k;E%WsQSUmRr)+@z*(FZd`eUgqpT0@s~noJNlu zdETZb#g?kWe+@1j`j7J$Y{+kV@?&@VT(lN4SSkoWQ*mewdITNQ**Hm6a^nEzjBDYo zHFF@aK$ZL{IN+{_I;%$#x4Dm(Zs`K%@a}S&nC+GpYEAflv?G#nwwKByXEQ+$cDx|& z1r)46uk+8ntRFKbl08wP!8L)b_GXpUFl}r!j|E_F3@=I>!JGy78mU(2pTpxXAQq_% zAJj@wX)>#(C>`t83kBpENBkM{Pis)G=p4qn-TsIGMR!o_IsNs3p+y<+H|x2uZjxDt z=_Nkg=3Hg!!jc)fg8#vse==jrOD90YMM;E8-(Zk;u*ZbB&mlj?+M z2*9_1L{QB?umWNe(x}^uk|7~6)Ug-x&iJE}%Q{O%w^YWQjhno?%O_wuSC4k%(RXm8 zsf59cSFJAX7%%RqQSE)j;{@;_G1seid-5B2KO-E4$D?Bx+-U@}cBEP%nI<@WU=vGK zk9MZ0h{E}AmzbB}NQ7I_(7n@^F8L8wXJP|Tv~f6a%2&H@nOc5O@a{1IOdQps>n{4M^pLl+z<_ zFhS&Y#9Cu8qkPXlrobJuZ~d$({#8l;+G=TgSY44cU4!jV{{++ltF8YstgW-##iky3 ztbSWGk)J+G@iP!9&!6$+C-y3bbr*cxfD}OX_mY$JMfh0(xI>u|kKO4r89#e00zy4m zz=(sn-lG4hNt&Ib?>ul}J?Cp5L*JtUaytz`)9{F$Z#Sn}Ypw)dML;yt+o%?g{h4Wb zkq8ovsk`NX2kZ0j!|cVm-MIX>H=Br%nBfMnG4GyK8@dI`)r`@_JKdY(Ib-6c{EU>T zuT%1=7OCK`!T*7^_{`uu6$ij1MdKe=$)6*43?9|Tr8I&gNc<07S1EyJe*n|&$??&d z+7~j;fCG?^8o3Lp$A7*J&mJGxx#Ncr-zJOdeojP6H6hk^{07W5e-@^-ZK4W8?gf=(bUzRGQKs4-yayDLgz`AT91k))CG*q{d$ zssF>+u)P)$O;jr=*zydt#vu<3fm2J6{ID%C066?^lVw#JiJcUmHFq-XDq3Iod76oW z-m#Tp>j2MGpOibU^;Q7O2ByQ(!R!2<)Q|Z?d}kAh_R6yfNP_fXbB<-|xaRdy7$4ET zqEfU)0u5=t;)%E0Qj;mjk6{-{a7Tdz72LsRovPewP@ke12f?USdH!v9Y_p_G|5R=b z075-GH23#EAPMOcv##yBqThEfp$oAuX)yd!s)44+VFo=r;8nC8(25bgfqQ2~_9wMM z^9(0tknfirq~cgVKXMZ}D!Q%kjnocrM<1@|>m$f_AWqj7DQp?h5POcifIR&Bh{SHh zZZI}~j_ORC<~Qe!C+XrC-7wdX35uL{wQK7ViELUCIg$u*4JBufF;>p)vIhV0Jr3us^(}x6IX1F-8i=WiTb&vew$Pe zbsaIRu+B!o79ol2s~no#8u|kxgpQf_gu1j23e2WzobjU|IN{IZA7@9d%3R~#^wZxT zEs8M&>3*LPx_+I91Icsi2Xz7^VHQj8>LlLB?c24#kaLoCb7z!Pn)bgviWD!eTJgZ+3+A}pq@Ks9Dwy3HmPo*?6`U!U~{$b`c#L#=7jj?4b*xNU?n ztCbp$G(c$o^d7fBo2&5OoODVzPi&8V+pgnQ<14#2%p(s-SWnYyh;j4iQP;p)8EAxi z2J0MeG$|(Mw+&dzBG!Q>PlhDFH--?amQ>KQ;31%l000?rJXU`{z%vcV4Aq+bKcV*y zR!Q7Mp4gl;2>}j_E|Mk6c$U(#vx%fIpz4as#iHtl)vaC5{^0lj zlVqb`spbaGc=h+T<96>_Z7zTqJKzFH%kh72imIOy8=RE~=IdBl@h9)_2zyq^42+pC z%;E@0>R)xCrzj5yl-Q@ra^DsOZgMIfKI+xgZyoX=1mY~(mc^GS>_J)d8|F+5?CI8i z2}95L62H$29N3MnvNJC#@e4mecEQBmc$SMpr2Wn@UH|}gK3K1ln;$3W%GgK2N&qWY z)KsyJD0Klf4iNlLaDm#M<%}?6#rCSjKo)TT02%`Uo~Ld?e*geapgBd$;*)Dt47VJF zQ-Y?%c~2c-gppw3{pTL_fCpq#AjHdnM&jgV?3<8~#Q=;IyHRpnBlMFa?Q=dN4y;~d z?bARlQmf>+i4mmfonC(W>_<3ZW9>I$iuUT^q9!0it2jEx&n22~_PPEK zgQ?CWX8!%EgxidIJ>+TYjGe+o_P9nZLA!SBosKdzC-(Az`7HNu^%UvV{-AtDKJ+9R zz(9&6tWF9ZUcLkrVm%u}tVuYIfc1`VYu>$F%@)8+dgjMc5Vn96RTvC+2U0?fM^cC2tQ*Ts#|1+8_E9UIl!C0%$A!rOxoo zruF|zpK%^#zgg+vn!S>Q21M`O#ojQ6ZRkH2&VmJj7eHb~4Y1N!&xtYniN9wDS!MVP z)eRvsJe(ATKY#ijOPKAaSrEW68blVVjTqheK)A3p=Xis(a0fDf4YO!2)zel1 zDT`c;v!3?e1#p;aPgZzwXY8#H8xLwKQvv?8Uo+H}aO_kQD`t>~Gzzx)TGDVoT3Fkw zyICz6%>B-U>cKZr@6JLPa81)unF7L-Ap?YFOR(U1yW|F{q0Xw>d>d;ka&#=+9aW(&2}>wXmM6V>p)(y9CgyOruEuBg-zkSuaun;O2_iWhf&PrAh@SU{A)ryr@y>S8` zHOK7a!8_?I`rgKM`4sUn2>S+V>5{|ns_A6cmRB>Xr>0S*?~-rSN)O&&0XHuWh7VS? z9&;Kmj3DAChC{`9#<(Msh=!Vn#B1@04;0xnt+|tmmI2~bZ!Ij%?C9XQJLXh*=&W75 z_`jc=-HF=w_^Q32669|`xLv_>kc?^&;o!X@A%ZDEgnpp4v?MhDEI10f;c)+QU-ieU zHxdNJRc~VoId|tgTjZ0u`?{!W?Ae33L-%~LI_blSK6Rn&Q&ee?@;&)MO&m(tEDY$> zH(}JA5cQvU;k(-d@b91H2$Th^r(>j<+-M1H0oON&8^|4dk~pCs2r_@2+RmIGO{Imb zs2fKNxR!TV+z%{cMp61Fv)0%>%Xz^Q zXBPo7z!BQ(Ml*4#_u5{4YU!U&@TUQbJM)E6s+=4ne!`k~MYXEMy|@~UCJRdL_hY)d zx_i?@F5qjF&jM__`u0%{UOhEv+QO-_op8R#Zor;|hF%XSrVO{ja11#q^8F*)aixx`BKK1GAC0fAYBa}B3h6NN*Awk&t}QDF%i%7UY8j{rh#_PHiwk%?b#Mi@!4#HVY_d=yG25&KdEB7^ zfiGjP{wb1wa9!%~4qYAf5BA%=bdPG&|C%gH!G~f;LM?BAaUxxT7{i5&uCr%NPcW~8zED$3HfRnTZJCpMuMfX#W{2ImU@bJuFKd>gb z{1ELR@i=^3aF%*y&Ee)hkK^`%VRkNLP_;fe(#>uL(><4Fr^u$j))&D@cyk^f?nV#P z+#pXh5E1)5;6iYt0b6P%dL?+le?uP z%o8b=r%_#@>gf4fiv1Osxn~ez%7<*Z0ATQOz0+g478WotD+ zXSYVg!=@@NfV0GTYYBbk`nMGrg{f!r6Mn4pDJGvDsJlfReGD z^Q!+bUVe$f-Wow?>d>L(nHJ0X^OC#NjFt(!U{Ij zdo@8JUsfn3;Zfw5d;|6K??`iT;yL3`Nm)2}r5~`db9Fk)ABFnZbR3L}6ovFda>6XT z|HHt*0zsv|?IZ@!# z`0K467SwuxA^#e+rtX}pXY4f{sENV*Z3-M;d70BND(gR6(IAEH*bx#})*CtrqBQ_^ zM@Z=-sGG6DMgO!5(B+D~{2Eu|Gmvu8=*mC)tstPV;dmFZdOcJY%nYNDCa0LSi5;k2 zlnA~Qn2B+~Pu0DlsI-*P$*uCwBpd{|i(k`GF?`|O?$rYW0g)ekc%)9^?e-OWz1 z%O@DeY=RhGIPI5pFhBqrATIGs^PJ&mZKI_RvAa=Y&V#ZjIU3Sg>g~}IEHpY|DA(;O z-C-|3vvy#Ghs1Cp$kBurf+!(Xe}a*vZGG-S^AH7v<)ETv2Cqr-+&i0NVmSj{=@qC@ zmUBV#MIyIERL+fYc#FgpMn)bkQ&kx5Pzi{Z8au6C)}wLoI_eT{38z-d#3ObIj!<#) z2^N+}h$cn)cN1LMe4j9q&WFob3@;pLmdxTwGj8PQi@xChQS*&J7RSosHXE&y5Uu8c z`2Z)((!RJ>S|xjgAB9K?>*J7mc*4Zq2pK>TmMu}rbyN>{z!|sT9k@h3K|wRqPyal8 z#bHZ?6SKyhi=7eNBuXk=OOIio!^(NQ^-XR-?WQGNRJ5VwmWB%6P=LX;0R2zS-!(D8 zT=j2?0k@VT?k%I}6cCy2or!+{-D(SFPFKsd%=#060+YJt{{!wNQ6=Jp*8{iAzG%%s z$M2+EVb$z(4Ih0EXU`C@P>8&yMPj=hzu17t`|w~9Ck_+|Z5-36BX@zXB!i7ShO}<` zs{p*AGkPh&8ar~wc}Hp`2~j@m_TcmB(3L<=Vh$9)X|*8X^?5hxHn!sKRmeKs{@=`l9j%t~XoloAI!o`z zcPEj75QpgPj!}$sxgSkNHRysOs@?RV!JV?EEsc}FVM41 zX+`|Hto;`%q6`4c8@{w8N+KZj>G64a@X=@~(0lMapR#jd{?%uMe&3jtnjCaiN>gh{ zL^L4SImIZL#1-8^4FPFLPsHUils8MN&-B}napPDAY;};zr=^J+^4{AN}*#e$=i?KUQdzZ5NHWCMf3wC8lO zr2ORwNz^KL*e_rYEb{25d`5aKbwZ z-m4NlF(-f;jhLBR6AYC%+jVdbqKZ?(3b?l{L;GFY(`8V2ar9miYw+!yF{ZUm^Mi{- zK8tQ=dD-IwfH~ZGFrF;Qc1vuv4-G+aUGy3B8k2wUChNOfO>W@xb#w4+v}V2{6- z_va4%8^)@6VypE_1!i&a8ah9qx*VZC*f28q8%rpTZp;*T!W*ra#q6fF{=Lx1RB!uC z_b6`zL5jRz0tCX~o-v?%2201vXj*Ai#ER`Y@>>xr>mkkrAWD2cWgKDD?6;k^HI8#~ zCR=3vl0>qk<4;bZQvk}@aQ%;X0L_`{Jexzs{wv9A8PwSRDOY2k;=hf}5`NC>qt?)4 z`-!j{fQ=>}_eLqv#Pjfq$f-n>^Hh-FG1i`_gZPKI1rw4bmh`>uo_a55LnNQJO)e|; zK7+&kI~_&SjwSqDo&KIO&NX4^d#^ON%i23qL{rzKExzNDueMYGabbQOdb(3%B z&S9>hZF)B8`?A{6{`;V+j=+Co7?wL!8-?&zBC%F|wCp zQoIWkP@@U^vWGGC$>zbLR*eMTznud3;yD+nHA^p3(j!(w&M2Ft5NYU#BDR?E4qdit z(=*vj{$cyG+LeY5F2!t?*=71YM5BsEy(Qns(U~ECO%*wU4@fc07r$0*jjnpd>@W3>FAgO+|3GZ6w%SAc`cqK~oBe+~SLq&Z+&_H@KzFxV+ zLHom67+gYTC}8yS7Rl0+xb0qEfXnD{!ZW%pj`|}aZvlW0o3kEUx12Vb$2HfAROLTf z?$awwvJ{n*03_bT)gJb4M!Ws;@;L}qZQaBe`~;`zvHfWTDbc_xq8;khQ)kOQNHT|6 zZa6$=A)BF-K+JGEKY$5nWgm1^>!o_(E7*?>ff3_4g3M*%+|KtIZ6NwAhN$=s9&;rI z*c?~o-6%G}TxNiZw_gu;MRz>xDOW!UyaxWfR6dVhIAiU3EH@+J{m*(ihIv^wE{?wh zW@9;bWZ9c?mu1dPnDFNdv!>Su4YAOx*$S>V!VDEXr<=o*lk0&hb`Fe@;$hs0K<;D@ zASbU5_43rt4YmT;2{YW(13pz9jL&jOWzNz2N<4e?4J4o`aqXiC__KO>=#VFyb8>YM zFP18p&5Vfqnl zZP-vnm68j8zvL;hSP`vZV$yZQuTkoV535xHselKAxF^BjSUnJLDnkK=qKwu5vw46q zy7y0644aa{&tV^6WrYK+FYT{b{iM4QN#?Mkx-m;~B?E3``~b<7pVKW(H0%O;asI&r zOaI#}+yoTg%qf8R+DiOfF7r6aarw7ORp8Y=b_A|K;(Ke7o{cdtNy)bCXJSL@yHQWd zN6X%gSa+oERSu-HLtelg>`m0Z5{nquxnUs^Rm7xUjM%;C2 z`f)75td2Rovfa%1#s9bG3s39p)~5iy^ARC4Dl}1x+~KW8`(rAf@g%yxObM$*x!HG! zp|&FFnCVnJbf3{Tpt-Rnz*P>_RtahlfV7RcPb{7dh3=Nk(%B7Dr7zNiLYr`~lg^X| zO35nbGdRPS37VY4|LQuVVkQKP=U=~cz{5dCOTZ4VJ z%cgMzXtVhDmD`kc5Z3v|^-7xEwIB1|Gb<7v&jg}-E6K;8owEr3GG7ei)}i#9(v04v zL>VkqNkktJw!*aeAjG{ZUR2J`y20_Wtw6}gl6d=UTLiQ!qrG9*)cDYvrC_@_T78A~ zZKn_xRFxe9`zQ^iA6zbJNV06IX@6xIVBmC*B@YH^tu7IM273HB6d^1Kn7=%qHvEIB zPpaQ*08{no#&eu?T9M-;OJvZBOOX%e4Q=88Z=CUrH?K^fz@JnMfWh+b_l-FUeTwy9 zj<>?-n*iLj9z=7^6e_C|YfV=uqrpe{=Un>4A|V7&U~GCncWwJW4uh>VHzYY^dfD(3 zFJe3m5w@W$$Avi8zbLvw!;X5?F_=Ha=}muvo@lQcwwfxrlqpQJBExuE9mh7b0@-%B zOT31vwbH`kv=vo13#t;VQKLZ-eO^DMD6!;~y%pylaJA>}?bamMCjmb5kRW-kflD}B zUZea7ck|s-K2%)XN!Y-!0g+>zqoHeo?$Q7t(qVZtcS`UJj19TjT>5aLu)$*Y?lHVH z>%=#?k0xyEdtHUCT>v*ZCwx9YQQ%jLssv0CF!Tox$qL7s;vtCE34h*tUy*lJ#>A0j z_q_LBS$mMWY*d1Qnr`EfypZRpU}xt1Zn#KwtJ#4LcEBj}G{B?Ts~{W=DTiDZNheFS zANwHG$WA0FZL4CKSjMdaO=9=<$S&~6U|LAXVowkox7S&$1KK31Kl8~5jg z^xtPJgYBBgA8HyIdAGnvWFEFp%n=BHlu3nX_qRA)0B-trAiN1Ln9QnCC;i z?Nf6Sohb8~HIEYFWwB7{h<){mX1YZ`PZTD+>V^Q;ss(s?wSWhrs-h)NUL2 zi5c4CaxO>^COBpbJA4hWigqTLAjm;3`%h=^rWnS<6Iod(>m>%naOXOF?zhv@LU(z?7x*&&oM}`Gs z%zPh(#(895n;SzK*X;g-2DZl4L4!5DW?ry^vNEZhC7hqPrNg9Waf4r4T-6UetFYl@ z0~EmV3_?7C-PNsAE-fav)&ar77#1(tKs zRR91EPrWjh7J#n+6SvMr4zLkt=Le`9he}6#tR*XC`TQ=aH~2=U&!O)w-q5s#-1u(M zch#pXkO4i_3@AwBg$uS`_vgnq3^_vrb;%;#So79N8C1J?4PaSc`e79CM}2va+!s$j za{8<8zF>qR=9%a=RZ&9d5IM`&4{(_Rl%)Q@1OB&S4ZC6YCUGX)?4>D8h)h@BU91S* zOFs8Lg1I4oBQQxNp9_M3PcoJ*!Y2sK$O*umx-N78cl1jX3F|Gb3ugvQg23kEi*~@g*h| zW{g_Ba0yRv1ejMUS|>t~ddWl{qynT+7U`4}C-d{jAwEf9W)GgyX#q&MJj&FIP24(KRx9fZ*3nU$9JC@wYvtcVi}1llC9aX`U1MY z+xe1C5Wa_58|;1dW)Ze@SHjd$0fClC(YtK#h7WFv&G=c%{D%P&vxu-|XJMUfg>z9~R&h z{l^lr6i;j;8j4Gc(xZ7-@p|fKQSz7`pZJ)84wBaYNzCmZs1RH9tEz?ese9X?m7zH9 z3*?J&!$_X4midIHP8R2V{IIp+r|`9Tl9iaCK|EfWwyWPUxW(KD4wy9Ko4uTRlzoE( z#9Klkq!H&w@TcOaOf7p^{dGkvATTgI;+2YG6uDIpe@%kxmCZWnv*6@Ey`!4lT54sY zUeBnW=SrAE*1p^vq5w+W-1>w+WJL{A-2qrl=L-- zw;mTrR~0MrKjG9+*xjj+kg=T5GeBRa5-HR|wR_{75@m(aB^g{9J%(E*KT!=TAK#-& zyiwpsY1DDzED+m7nD?Zx%SW9#m4Nf-^gVU?Q*5$hXXnz#Ry-1hLC{~caa%99tvR#L zJPJr~-VKm49C?0&{ER*<9VbPt2XG_FBulOd$u*E-HpLiO&(d7+%tmGK`(jM|JB}&o za?$m5TLc#!jw;U~VP#O?AAshefVy|`69nk3T4nb$eI&6;4cocR8~CL7?Ek_b)f;vJ z4p0C+K*GQ33*Wy!Vxsp=j)%UX(6E-^W)P1_n-}Qa=lL#_eU4gs%>`)Gs)7_%AGWDU zr?*5kLPy}E`0q~qV|+ymSNx#1{`F0F8bd`~-lR)G1;tDW-kU%E+yCdwiJ7`W z9)gdWtsw@Pa##P|=I7k0UY>k+K`=Wbk2ux^Wq5yA-Yqn#70xGT9&VXxIA1nT+=X3$ ziA@vUb!s^tpe3@#=RQ`eVFnO3HWg-R`Z7zrr)DC?@jvAMi{W!-pKSj9E7Hhp z;JNa9qz+knZw){0l|uDT*zd18dvuObHT0aOc&LPX;1$OFTzeDGOMMVA*}QUUM9mXQ zx3GSiBE!sI6Q^IiP|4oza*bV=e97y{PFi-Y@C8)rMMWHZ6 z+eDD$KHs_WQBBpQ4sY4ya6)oZ8t(k6zCO6~6iMaKEzcg)j42uw-nB}fg~tx-%JXBv zj|n%uQ<`m>mtpUaKmsZLvyDg+5gtY6cum+!A;K=@2;3NCI75YU%+z7NjjB=_ye2@s zgE~u&g>3r(e$WoHEiXVo)0d8i0ga!lxR&=K6)GXf1_w3V{8F1Vv{JPBVChp92Quvn zQ|!o!mWWRd*_f97jGf&^Y7bL)*gsFanE`+uu+%Y}4x9}E@nSs{s>a6oRAH**$*&2T zyyL_B9M+Qo|6osOXi8;fd)OgUF~_j31`xTv(_RQkD4QFK4gbfbITg z#g4W=r2j~vRJgmKo(4D%HPK@|lt=#_34;E=DO&9Mx#tvKhEGnn{BA8(Q%eahK9@_? z`KG|$+!T^Rrh?xlX4lngRdiJ+REOUtsYOi#ksSB|&$wqyt<)eS{QUQk|~N6mlL742P~Jrx@^Z)o`#p4tTjlNtUKkj-X7UqBmeCri%DB58JTyZ=+td z9|mN3o;wMdzUoe2B-YjG`)h^%*Vj3Iyj1vPEJE4KQcy=4_Ssp4Cw7UYCw+mbe11U^ zSt66l?0<|1t^X{C-(1dR74VUUkipd$sC*ySzP}m}4G^qaP@_LoTQ-jFp8CLmY zXWGL2y!HW&|8}`GQG@CW`M6mh1aM{+_d=^E_knnlRuOFxfqyl!O~esv3*1=dI4x6a zLXI$9YEiL7=N3M|MQ&WO1a35R{6}-OqAQ6J_&;y+pGo^|D*?G{os23|TWm-wuea$Y z(Ekr5W1#IK0z+nooAh+dvbaWFSI7Y*4CuvgNQcB7>Q`KRm?$_6%8gTpC2sm_twJ&Q zyrlLC%##0fI&He%L&Or)^!y9{??^;tNrbxZUTo;J9#UzZr-fd{C;^!DoG)ow{<0ou zorFnNII@$E3(lc*?uoyayE2^8;lreX3fnK8_xB?)p~Nj%@RU{_zKc{D)WQpgcF#u3 zLx(tpDRCE8b84=)g5J%o&a$j(zRJP>YXBpuAwN^3U%MYnF$aSU*0h!8mR_egj<0uK zV~&(52>~a?GGh+U7YCz_FF?P!;xh$F4RcrMM%wj=YR-KAj7jk( zM^HeLTcp{%ek=&*^7Tt^gQdyiJS zsiGwkju*acy?+e9Nl?Q1v7na zmAUa6*aMs3p#Nv(L5iueLRMracx?h&p}gSz)%vO$>gwI>F;4YxWaGDeTeJ>=2Dg5J}ZUqwrQYj{k z^MBJGB$^F4cHQ7HIKng+tj=|b&xOyp;+>hRo#C5;Ksnnf2aEuJb(!qcoLPD4=Q9YsU;JEnn|zgpbWh0i_u1To%~XYI=;}h{4Z- zW)tJ9ft&UxT+8qeZTwOUZpm&>4=w10bOhcy%w~B*y4fD<^QlPa8WODHsx?m5UO7xi zxy&9d$ySeg;0k20>fubF_@_S;b@wm^%@_@>mqQdTEi~VAwh{h1 z>w3*I=k;Y^8w&B2gQ1*W$(%SpNz>J@Xbo~w2?hrA9_ITZ)G+kl9n^7PCvP>ZsX8RE z0J)B1hK5Wmd)@e4RlNV0Y{=_OF^DG6qmb-T!h1QN(_sznGmZNCr#uAqZ~n;Xusm56 zF4|khigaZ=i)dbcVT%q1;LpT}3AwM#2WRB1Q~lL=1A^S}(ukkHh5K(c{zP)w=~S!T z7Z*!4BwbB;Mul;Rb1DF9d9O zyVttBs%v}no6XHK(5^Q5^>bSq9kF2G7bVDxL`UIvC5_7=k7jdUPkVQcSr@*d0V?%G}Y%lc%n-A2a-=I-(3!TB@MWw>B-==mTXlyFWCnA z+S8uE9UWP zF{9|htTVt++llLat ztVRlD60?wF3;jXiH^6kH&m;9A-Z&{u%lHpu zI{L)E_pmNzuXDKnit#P(6awubU*I)D3zg`-8&f)&B-0D?Z#dyfZ1dg_h70E~C=;y@ zppe)c;JG_KD)7|P-pZNk#AK2l>- z&mNp4e8R-C0&5S13_f@B>5Kf`hhdmWZn&Ej|K8m(?5(@W^n0J6_N}3zPO#FyP&TfK zOT|D6bL;)-fg4dSq?m0gIi)a)s^YcfsbAm`X`n)Q~Nm1@{^|^qM>YCW_q!8bieRep(kz_J;3-3;0?kLA%33lPrm1h zPu`{g{7FZ_khr@M z2@!OzybNpS96t`1Z%!@WvI2Am(twYb;X3Yn!y?&6?{H}qI7SJeVL7Tg1hY|MiD5Z1 ziAM0pviNLC876tv;w`r}Kh5Plil_uP6*WwK?s^xz7M08HOpI(FhK)7pfFwj3v*038 zvyZa0eFo04){x-OdF}*>w3<3lF;6oKLoPQn07fi*#V853nYO7CCb2p)m$xGV3!<$j zP!1wr)pqG!9jgo3iWXA7qA}+=;onOCT}GIE+#~XANi8?T0Pr9(>4(3>fD3W-&SWH- zmFAmFSX0$ctfk3i8)HL~_}IS@k=Mca;}_KXVzdO%-}=T%%J!j`GYz}u$I^9Al}^E4 z9Ntlt3m;SbE+gIa48v@kEL8v^p=}TrtJDHDpa>by;z*JGcxK4Lt^|OSeTO%xu*+dA zCp04*0+sl2@)+F{M+eq0?rwxv%YOC9`+}V{%t5f(*K3rrQ{=enPWJDD@YoO?6+lQV zHIL|WVz|X^iH=B-veUhINQkSy0RONnNRszf)pB>xH>0_aGZ|r}*@%z!PPVOm6Le-D&Y!p>C*$JnFDA37C z(dAOMm+Zf1Cuk6sj=zZ2M*E(iK7muc4G5ork0Q<@s(LI3RVuV28ALEwxhE z3=WG;{vuM09X(UlxALHbh!ngY790BW$TtDD*&qdvTZ?Gd`8`kP_-b;X3qBqakK~fb z`W7I+?@1?GWb0!W6^@h)YDQkDmv+mE+FaVdrFl9JKJw|PB}0CI#aDTn?`x#6@(gf3 zr^o}J6CK8bz4>qUZ3YaTli1qrY>h)6zIkZ76O;iQ-muB;u11k7Zam!uH9AA2nUVF_ z&!nYwu;O5*9z@&}`a!ZeTAWtRkerA#WM+f`P=@d!v*kMA=n&^h&`i#D+f|Rz1ed_bIcpy;QEp< zB!#&!U%HU)7tm?HC}3LN;}|{A0zuNgS3m#O4Gi;*zuJiF9*42M5-mJ`IkLs&OCk?o z1J#ub-;XN-3CE_Qn|b+$Ozrq{Ewt)H>O49k*$#J%W)AAeforu5daC>`K7KfQgv#uZ zGVw?D+4nK}lZA}Qk*SLq-^{Ch!N$%*_M!RSQ0cTttjg`r!zZI9`*^Fn&SN^un!XeE6fG-!E&6e1Q0mriVl@uEP*Zz{HD=R&%~9Q9bq5c!lRHwG zT^^Kl-qAlL)W{y%c(x*66DM7v4#bHT0oS($Rlb#OruOA;5&aojpyH$+0My;LQT@eW zs-kF)l^50;(cy1w%0w~XgIP53~=Dym`0{k`cpMURaBF4!LW$IdVBNd%s zMWv3E$^Xr`S;w=NT%Ca@p$_tclC1=O?@ zK4e*u@sDcJfF;KL)(|`*jMwn^4|@`VvErwnKOY(AzC%R~!2y4vi)N>tM!6HBKNQ=m zKW~fYYYllagHp!sKE_40!z+h=Hx4bwrun(JM}hZP(W`GV5=(xva{-bKO_S{V?LV4o zZ|Gcj*rp}nz?zur{QQI9%Pv%4^VN{|zEjk}+mq5D%l>_fTUgMxM%f3o>1p%%6kvjv z;3KVG6T6^>zkO*$7>dZg1ulcXfN7Ey(o1Bnl-EGVr;ro zTxO0;`nIs9`FprW4eaqIp6v`wSdPK_e5msw?CP^C@44jlxxFqFEa&(z7n(<|7i09JK_7B*E_emVbxhN}8j5{m;F;^I zd?YSHCI=wBkuwAx7BFhdFd#`u!N=huuV(6Ed_C<|>*rD3*CQDiH6H?j4m-;R=A9!7 z?Q~tILKiW1b2#CXOvmbLIv6dqU~%^&Gr037Cik7gw!Bd@nYW><35~(eoNxc|%rt zRd1>WNGsOIIJqmQW=B?)HjzuAEGa!W*uSw!e~e}mGKi1g{Z4rwfqG`10BK=oEFw0W zKA5cB661xf)YAJ)@2S)D9jnm(KPF%vd%Loj_=jU#5$a}Zsmd%b*tF>IH_ANWOjYgb zlmp7W67Q-n651Geq-*wTlI{6x?*jbB_dSmq7BO8>-D+F>hp|SDdhn6f|0?LRELdDu z0g3=Ua+Is?1((TEEWI}YKDJx-ZK#ZOoP+)ntf5iQvDr9%{!EwmF=js z)rtuHzI5*L{jaBUjX|@F^6`E~MS~F|Kli!9F3qNQq|SNA2Zs_(v0--l^*!*wKE&cr zcej&7jeO$di{(!ywzIh(Sc&xM)>Z7hI66i04QO1XEQC#d#yOkkk*+xMMH-m4X@U6e z3cEiic+~uO49nvI4X%mmc&A)_k>CE)3!9!xAu{zJUnl4~uOtn_AM=__9^po>JBM=X zy+NQp17l5(o7lrQ`E>(&B=az65Y00y_b-2-`~r_ekcWyN><(nl#zYNst@F-WNsyM13hpW#FAYy#N*0_n4a5 zCrj)_ftRP(1eUq#czbN36>>_44x*^f{5%|9qDYL;T8n3pi@arbxUZmV6P)SX=I<$XN0)e(|~{|8#QO!aVVTO8eU z{x{r>6L5N|@Bnf|U27{?rrjKjU|JRES^(SImP)=@YsFK*i1W~#+fxNd$=8?)@{G7* z3 zBiw zWxy2?l0boaJPp+IoU;9NEdVT!&v8e)x3UOu>C;n77KJM8TeNVU!K3sO z)pP?!m9mzy+DljOBJF8A2N1r|eO->qQ#O?_*};&I6X6WA668acE%lD@ls*}DFZyLS zi?eD8L;|`n(O~%_^P=3Rr$Hd*bE2$dVIwHIDu;d!d~;OO%D-X*Y(RlW>43HwgAXiV z_+kPDNX{KZ_3$4E>{)IZ=Kph8Fa@9aH2O>i?BCfd)Fg6794DD&zm3Y$k*C=m(7^)2 zanI51kJF6fw8o)zrH=AorSn^h8q@*Bu_j95QQsq_SOxsn^Og;>L&ynmg94mwm>@*% z9T^YRMm1FwYjbyhKn$xnv~%5@85uZMnZ4L|SB)A2PG0I$B<9&4qNqIr_rByp@^F~B zox={uk_lokUXlh~SS~QqcLH4|ss|YKe4VRkaQQVE#}9m70va=aupzu38L+)g>nP}a zBRF4QPe`+5#9u*QF~z{8Jq#esmO<&N9bV*0H=&E^5bEI39_cf1nVx!G!plKu)&QQWM}Xxl2Y8pQJ%I%iX_&XH>|Gh2U%*4bc@a@s z@_DShR;{ls$=7RjQpIa{c7Ou>=2R)40pZ}uP)hINGGLi%C)z}Txhk9_uiUef!Gge{ z<{duxeb&C6F|M~|ETw4;o~=~pDxg;2ezk*V;&nK$Ino{PGd=s#{#E)Rb3`w3f7y-S z3dJlaLjTI%nFS@#M*2V)K9t4T6`P&%Q&}!b5#W418Xknofp^R(ZfH|>+%lUZRpETu zQp}-%6~OFVhlLF|MRe1x{o9($mSBQuge9pv927^l!rs@n{i;BQdtYHzs-B7E2E;{Sr5NrKQ>&G@XRge*hMr08yCNyEmX z9EGgc=r{a3Nq$=ev#YxY>vuAlXzF+Gs^!tt#C4ksi%5p@c^Y)_0(CPqcJJEbEI7Z3 z`k*uk2*Ovs&kN0Hq}8*f;ds$}L$Yu<_0%4K?_P_&xNMDCggy+Ms_Q+#m|}DU<+>t{ zf_3ZJ82W7QarryHb21DNFJMMk0c_jS%~mwBTf0!9D6oX74I%I`9cp01g32Ok;_1<1 zrX{^rXV_BJ-W=KgRLC&Rc*1KUZnrqc=ClM&GtFERz^x`soM2koud);N0b<7jNrwI_ zRpU{!KGFb6!0DXtPS}VcDX=KDV_K_o3EvreJPl2sh>?m*8HI%nziRR+^jZ$afzfy1 ziYNmhI?2!Yl&9Pj02RrqR%6f)wya4ul+h)!c~!{C*Y4^US`fUXE`~l~O6E$h%`ic9 ziW;nW`S|3q?2DQ@5oxIK&Y5~tK;ShldFe+aIBCtAW0=9?SGvPNjNwGA4t>T#6dZV9 zLNn>8rh`Sn=|7dJ3yQ%f#6fe&iv-_MPDKqJZRyjTA0h~Dv)T-hdxeWq6c^m#-}h6$ zW^y~yp61N7C<*?;;ictds}M`$QZQ+5u}n75Qg`?>M{AKAzQvC$O9M^Rw>h^P-z%r# zn@VdbzO)F2Aw%2bS)E9ndV6tNSsK7|c z_PQG>@_7+}Jzv)L8iB*m9DYH?hmH*E?Idab#VtedUQETc$+g*F-y+sd&Ft1I5F?K! zt{bV-B~nu?3g$4?{9`yt#d2E*uAj_WCJJ;J?5Woao+aO6SR^0dh8j}_R*c>W=>|IB zFaG8i|4aWD;qnNZE7eMB=!4-Ubti7Y;mH)1OC@9}g1BmG}yyY%7j@T@*9@mJz-ZeU_M{8jX4dwfuU$FG{js*7;(Hj30b6b;ewz+R<^qlyoc>9 zk+(4g(NSh$n=NL@P11ifW<|E65lJ$9S9@{)1F6LX?!#qk1kt{c6P_QvTuovxZcN($b=9rX@D`zG4URF@CaE%WYO?4anZ zchZdPzpe;heq`b2SD?`=C2|Bab8UioQ$W9m!guKC`aYALRx*o81^X3+#G2e3nJgnl zY2RYBjOW8li#iz^_t9wS9F=?Yx@U%xOTnOsvU@axoa8>=@A9anG!yie3VGyk4_7-= z57V%Hl(-VG`UpjK0_0X=GaV`uI=>QxXy3g;64X$-)tK z!Wr$rXX0x_7LP{`byxM%Kx?~s{L5GGvY(0qV37-PBj23pZ6K>V&myn;i_|_I3x&_} zP8k%)oT5~GgYuNu;%xU<3HuM1*2pNj!o9yEE0?|h3Ppa!RC=imGJ4B^@nc`olKY-? zhcKg`Wkl}pS%Uhan#*2-l~QAQ42Ei(^}#9S+zJ`ddNG_`TomO|ee)V(?~yHdpYL(6 z&w(k{fkW_K;jV<_(&@%WIF@M*waNsIhoYG1+ud6<%MrFXaNX|gKI@0j}3vXNFb6qHz!!HG1aNu+>Tg+~0) zm3jA?V^13Idna9W~$WhBbkoa#QxDZs@)00=I!Ji{Z&!-A!D)+#CZ1BfTQ`hm#JMbh~l&*0bcj$V8u-v|U^TZf>1N12Zn06Gen zEVa(>aEH3WGdnHSPXFyC>3t5UiGq?j&Df{|#ZzGxt-QaMPDCO}RZfeEYC!+ji89bn z&H$9WYr~!T!`*O)fdlwaz#rfvY=yt+uUcPHj&?Ot5Fl*rJ+d?+KLbvS zlQ9ld;2l%|xhX@lYfcpc+imjOe=D5w%!QmbaiiTfmRQtca)of;a>dBOC_qY=AQ`Q`KAM zMTO1%!a@^dcCBk3u^NpTWG%i@pa9dQP_5g1CfJ2H-{Vflu=%lQ2wfHqEA6I+VCKeb z@%>Boc{4h1c-{90rRh@#pX2pnNXS*UO!N$Qpu+?ISuxfU<*}qj%0n2!a#dBSunq7a z9-=h;d#OKwF2Cv7G`+A^p8y~zdVnnl?xL=s2~u%6$s-DbU}ZMeT2rAE)?ZySLzN`3 zPu)Q2KlOuk)i?5`+r-!WI7mX85%f5Z+X2HQ}QdF=0$>yW?e-Dwqn@!J|Zl2lBNw<;U4CI8|kZ%qnZzb9| z-r{ViFaP$DS@fHhLM6^Bya}xt@_=gQc62sBkXR6S=$IGXz!TdM3;X~FmV2Ieyo5ZS zGlzRgJZp&{$MUQmKh^|I0re|POjDnb0O#j^DN`EQxzA zc`j#2u7Cgm2MHm=X@vTfrDe&8h#%Ky%MskG2PMiz`8y@W*&|x^0OHcZtU@JdmbeVV z!Jmtc7oJFc$Xif1sBRmlC*ClXNQdMbaGMwMYrz-O%^si_7PkGF+{v82((eoX-WY5Q>iWh4{x|d zs*%Eq0XPlc8UVlvs;qTKcEG+aa{0{^s_)4e`ifEg6|^--+Yt5Dcrim8^7<@aMni32t@PWz10jtTmAOW1J zG0HvqhH@PNr|VG8PC@)M1TREb-S^1 z>JmzSR9J3JnI&JW6`T1}P@1;h+=%o*q3mJCFdlyB9&? zbZ!KRE$Ylui#2b5QVw%;zLW5qyw({FPTir*?G7o3o^As2qo@r0iXRo=cc)Oos@L6^ zYnV@ea8wwG!B?J$?0mxNZB8zHQ8*(|u=7^J>>R`F)sG#(QYJ2w%Zdj@?mFzgqgs zr%?-nI}mXIxTm%lg`z=VMtyTvg%1h(ac3YXEqU+(Lv|Ii=K7>OO5pfZ9|%HrskDZ+ z=vECKStL5c9H`ZlEEjsbAHSBkHibvV@*;rX+Tluj6)al+$kT&pvjUvGUHA%;9j(?! z%2gL#QE=NfV#Z`RF#&639$C05GNW)*?zwv8=i_~xP#Hv-SfyEdG!+Xwp-fpGb1pt{ zPhQ5Oz{IIYq5Bv>xjz1M`LYO+?}{K+eVLyL66&=_6)ph8Za-TbP=MgKE$z8(<=hdQ z6y?}XyVCHFVOTFk#--Mzg`G-#2_kKeV>I#7q+ZAkw%A`tp@s?=TcK~{Q5MArPAOte zt5Dac>Vf)0@!ioF1~X5o3z@eeM+oPHe`k1aD{cz@E(h-!=w0qJI<(c%n|Z?~$7z8s z1vr@IhR4J+4?>)jn>5W-WnZC zu0H?U^>B23733C#I9^UeL^|n@Ba}V>jS}HI17h2!>|@|YeI;`&!4CAyX0cjxjXz3` z!=@XMeb|r2;^>6P_l24)iPLbJ=e>0b>A!?uZGEHYT|Z^ZeTFK1Zxg*;-@(VLraha~fqcKNr6Nan|M^|he%#PwHJfMsnF+-3gZJ)yNl(pb zN&}48a1$(j8djH;#&vz{FJy(?QIZI3%_>oV(MAr?yHL|3J+Bo1;N<~>hdbgb7cmxyDtm@Ju`vDO&oCGW_wKn^j@}cR0y?y{JL`ipFt{tmy3- zSOjX1W6pU6Zz?X^b490biofIJ;z#MJ;aZDZ<`DsFyj(s_-k(S5En0@-LcY;#UW$2v zxSUi;t!Z4m&FZC8MD`n9qrzp87#3oQ-J>Vv@kb@EO99ZhlM9CFu>>8~ zHNuROLW_5nLGf-Vf@sXHMFM5Z&ycu*KFj#hThQE+^&ng|VqHi0KU=QuSLb*#G34xrHiId^z ztgU+D&)Mk9CgnU4Z^`p;C7_IDn<0JaFxg75(6yd5hDPbaCHFjog<4i8cJ;Z&X-k4Y zPvVoX@z@@(eAtTZ@NQG&<5D(A^^C=-{NfKTw2D1B5*GmM(PyT-x`p%yR}|(6+%OeI z#DpZ22rSP#MeBI^ZIN^nvj`S=fch=UgS1dSl`~e_(wz)ND+`MY)QoO~0+Z@W2Q3|^ z6WSJ1Pa;K?3uD$2UDgOsgyW|O8c8hs9eG2ezF#~*Ef(75zAe~`QVbc)wg92h7(2bf z1$@J;UI)3>6QMU${W&*8$SS&OCeB)WTbZ9jR%z<)fS+#^0i`XZe_3jOgJB1LDG9 zb}_|g*}#Q3F)6S6>07m!>md_iME}zppD*~Y@0Ie*Q`jy)5 zU|HnX{D)D-4EW^C{aOLX(-SXUx&{-a6kC{YCM$qZB@yyl?oiFDfg?28uE%~I^1xg&oKo;-ossYjnZy1%0PH zS}p1EW>8VfO^9w~$j|-N<=;cpstG{FtHB+?AqdPLkREwwZ|baw3ECs;Zup0;OE}w) z?q+Ma{sd{`+*CW?D2Lk-9@`1jzq}x1DuUj%(yntkf2VIpvxa#Tkj=WhXp-!V0nzqn zhSrVH8wgh?gm@E6@$Z21GE}_Lr^@$PGKr4rJ8R~7bKrY!{!QQt{ONuZqlIKp*&;KB zntfIgwmR;??m?CQ_!hltL$@PK9Q_l*TETpokAS#zEwn6jN(Q4BKvou+&3~gE5({^{ zSte24HojDAVf&dc4n~&{#F4SNlZ!PXJU_rQDe4&An$H=;%syY7mF3qJLhN7(9UaIWB+L&Hm4&7iYb^jCD*NrvJd0+6GZux#7olm2{|Z{>*@0Utib z^`;?q*R|b$K$9K4UIdKStFza{ZF1`o7TcJP%d#)0gmZGfdNwT>5OQx?`s^}FTxB%* zQ(%Ijxwtvd(mS|YYw@~r3ehtK+!~;k*QdKLewGAlB`&!0=H;xm zJ+&~Z6P52XvAK?uttz~UojpPF(KRG4F)x>l=l<)wvfYEUW~=ZEjciiP-uXe7D67J6 z&#zy@bYEPfZOZdHU8Jl|YvaMG<$I33piQO2$)U?`W6cwA|cxU({cid*zy6wMHK z-rr}&Z)FMGfKWq5P!_YY#Gw5}ZwGDL>wt{E3Yj^8x-*grn<#2UWDd3+L~v-V3erFUwAv}?pllj={#+X(Ih99;CLm30tKZ>2OK4dNQO=qV|INXg zX88%O`^gTyvOkJw$AB|D&WJCq&O(iCX`GZGV2=?Mpm?!igB}l~)xGXHdT z;@?}G+98yb+!WCgj#3^+Ik5%95g8|Z^ibjwQuJb>(as`O9Qc}Xw zafnyj^#NPMwfAOG`IK@+RnM45`D=r1E;BA*+te8c$<@k#V%&`Eyefs6vgf(FEKpdp zG4?8|o)2tL_dU(Nt++MoDvJJY+4`Xme{>vI1##dEiToy^)7WywCm7@sniPFPZTlwx ztHC@+t=(~I@1sr$fa^|88LC`H<4%SPrahRE+VOKOR9M*g4?fqAW-m;XI*XEFF40coJD>;;Df>lPrD!9lgk)G1;+P<8;MSUIl2c?*_+cU2c&0 z8&yb#S=-kB$noTV@fsHlGDKz55Dhmz6hgYEOM=tGN%gr9I#UDZ7QE{lF*G1;Vl`fI z(fYs|UQGTFyr+&}W$z>G|KTSTf2o(&yJ{VdGt_SaQD}%@iuC99dLkrLq`4He-;o{V zNT?x)=Yg9S+&PWNLwBH*S%tQck=ipu1dq?ZB+3#Zw4D5jlDT#?4q;`WNIYk6|5nizrSV*>QHdeO@KAxQOuqW+TJ|#%Z3B`jcuLVr#iV zJN;J(t|bOMcQ(fFx4PrNOR#`_s05ZJ!9(Lfh6(ftW2Gk+Nt}}jU{!qQA8$Q(u(+?w z;4oB}+;9?NoPePk4yFnsBkslJS^oU$VXZH3PsZS5V;>FOX}m>{y%Uv1!QAe;Wd)0d z7zX=;za^H%FXF7Vzu+ty*}@iddoAJGSCoX$x;c&^CH}wi=dU?9;9Z6p9N=p-TEW>; z!YP{4?J(wjRoPdAfXydscEyd!v}eQ}xl?llHfR1E87Uo!UlNm4a`)hl5UJdtZVk7z zoDu}RWg@+4LX-;nUvA=jyo~sdd)y)!oa0v$9`46h->ipVkQ_dJ-mK+=P#fP)RmM>Z zw5X#Q<%0A+-gPI(8`&V(>0M}AM;ReXBZ~j_nLK5k0N(%BQ~f=*yG2qH4c=~*P3q9h z#9AfwtjNLB3-N+cR$F&d%^uQ=VrW50=zlIvi5^gQ$W*Cu4@Ms^t$sR``#Y5YsP#w;G)W4=gszp%-rtpCqZf!AwEBj54G3MNPqpFaIS@NU$~3) zO2;&|2Uva#y-a>F!)svHK8gTZ-sifZJ?v8l&WKoW3aHqXj8lgPjj5p#61_kNv-a>P z$TuKDqgW`A)4VJ&v2RtJ^a1FsU=iUe-JvM~JLHwBGs_JmHa$M-F5XZ$`!0Ox`rZ-K zDttyAZjlkIcSg|M#wHcn6pK>yH2<`r_rOu^q_fcG1anp=L>YxFMjp zk(O7r4;zrrd$Q2dmx{A4&i2r5f1c2$3yq3A0D1@sCaEso-dYVVW(x7scje+kUfo48 zd5k@||A3y06PtHXm;vcsWcU<7?4MXl4@k+-k2Vb_)9c6%{ULq8B)pZ}VB7AA_1w6_ z?u7;UxX8cmhLlCrRA5^SR~I;1B^gQM9IrMFR)o)a^rRY(s%-FmVKEE9!f&sJQAp3Kq&xSOsg~f+#Ny)iA zvlRF$F!6FshApN&KEO0Zrc-{(KpuQ|4oqR~em%UWr-3e~`ZP?b z+|d#F?~w5NU^XzHdG=Q=?YiQkAS#<%$8pcXr#W86IIcfMzgDS;4~Ya6$cy%$cNy$C zbQpz-s(nP%WWOnm3OX7<;T{^X5`X9w>{{ke_UT-Ecs)_aG;+DXw9+-nW*goiT`(@3qDH~Zl`mBsW}-kRA$ zW}@bYylAvPY3p^k_`)-|mL$41t0|<0MJyD2cAW8UtuVuOkR4XDKib=THHX_^EQhRN zqqWJx8*)G(JX-egh)P*ksklRI%}mIl?5|<)oM0Ad#^wmn`tgs*{Wvp;8VglqL72-~ zpbc1@&ACmQo2g4hNzJ{)g15!)VD%I{FC$P`Ak`a^l@+5=U^9d)Q(_E?PKsA6JR;7| z3_!iVNpB!wzW8U1rD-&m;(69^89g`oy{=)p_Veq+ImfWUfs+0ajKYT*3+q91QTMe0 z71J(&j)1|i)T@SovF?s;QoRg{1jb$M+-MGR;&Li&_8+0U<1)0)L;H9=9Lv5ZB3g&!Hy zrldcbj)_wx{4!c=%eS++NjoHsW~ok26Xb3C0$E^-bD|0C-s#TYJmc629Lp;9w${;Y zK?AuQ%K$8Ygzych1s~h~k%7E>m3f{i0=JHWg;f;~t9;r{-e0RjzNa6x*rLN z`TJo-mA_7I0^T+rfcTQ|sh5PEc8@2m7XAUERJFjC!W3uSX6&m&GMs>Q&G*?Eq#KBs z;&Bc|)kCtR=!!Zh+~xXG>PnywM5W?GvyTZSea7xEWeLzM^ySofuw)0bdjmw{UMo&3 zJ2c?E9=t~s(k(3)udPXP=S6da2lW*@$Ve?WFx86ey&g)rQd@&4cM-^KP1&0C3ea-` zU~SyZ0s_54NU%E-ZAN(A9&E^HdtDpn>|Rj}s7;2j3$-->$Z;uJAB2l#kKkzhe+ zez{50&D57PZpOpe1%>@X)Y|m`08>D$zg1u@a0AyFj*1LxmIOIuan8|Vy77FFQxEWe zJJy*r#*g}uZn20ALxzS2mDfSWr|p?LEkhZR131b&>vx}979(%siyhteT-l}w?HaFP zHi;fw;U-2}vkhc74r4bXRP`{6(FSrl%#C>WQqCvS>FFK7Cvtn5Kmnwt3k7^Tstpzm zO@{z8I4KpP?ABd5i5lfUY)KvZ4gp%s-M5>lZ>TqHn`eN9RYWCVdguP$YZrzWg2$p4 zvdlDq0S4WwTLhq!pC$XXORXpBM!qf_d?GQ8hkQ6|;UOats=%d9sW{5eg_COM}hx>u2Z2e33VHQj6L6QPtIF!F*J^%p4%q;L5a1d@8h^D&3=`u!ZUbtJskIQI~XKd;?YHGCPE z(=!@`4*D1Xew#nu3b#K{a$1$SDl5DXpW5FWpXPcgFb#2YRVh^=Z*txG+EpgH!E_$DiDJyPw*&jeOd0QrF-Hm=)F&cBd0IqtaLb!vA7Sntc`AKvFbiL$H+%rt_?*&0w4!ocTq>?A|u&FwJDG z2KnfA-*F$>6-gm)azz#yb?;8#54@WGRp~mF+=9g5B5frQgSv;->|brmtny_TcXip% zFoood!KLbEgE+C}$(pQ=ksX>8*Q9GdYZqu^8G4&wtn zmI&eMkiu�ehR(X_M>Q_7mXV0%$hsDR?>?K&rkO&zUE{oXE{5CeM>9C?lAAw>diM z)J2*H`i32hp>i(Vx-}9-rx3(+n~Km5?&F2Q^*(bk2~2%+_AR-K9<1JKya315v_wD$ zMqYRY`s%aE8F#8VgOgKZ*D2KGFT1oxjcnQ0nJG*7ZX?G{qHCkAT2cMg>Hk&Ze2p%H zCZd^eNkXx*EUI-dgW{Hd(9vanMulJCu()`HbX1%V0P3jUCu7uB_V1nyQl?bZye^(k z%R-SNTWJ!>dE)lFLJdCtTy{18^zhJBHl)^wXPUi%%2 zB7mR!D%%`4MKwE=(8U~akp0~9eJNNK2FjSGYOjk=NN`wQk%b#U5r%SG2_FblXMVAF|^tP-TJK7$1{a;WUD(divtdsBj z|85NXrl)d6xg693qWh|%qQnl&oO4XXMiStytpLm0IsW~`NKPtK=0IzQ_-K?-DH^_Y zeu(bZ6R_=mTitpvOyqVF03#=A7j3!m3>tlUMke5lmj(;Sw6o|nZz$Hha_NJRdKAbWV|qQiwp)*eO-gxw-ehAzi3qIY16R|&rEzOv=!7`XH`ElpN+X`B z_1l8R!VBB4du5|}R96>KGYb2?y6L4M39{3w*O~Z7K$SRIMnK{r2n#I3-0Uu!NY*>J25^Nrh1decM&Jh>Uv4$ud3_`w`rwgPAU(3U_sdKD@Xm}s;iPS&~-!p zyO$^o^psYH3a=QMJfydtP6b( zW0ECPj#Sl$9ag}R=E|&>+Q}UM#OLeyC{7U_)APD(6-#Fp&MsG#N(*)avB$hyu$J#R z&yx_kar&7dJVIbz@R&fz0@K_d%HyT$K)ZBVu-wNnB?7Z0MHVS;6)Zf{!mH4WuWZo} zNnIHPNdRrA;uUs9YOtvLIpsGb1}?q-Z7=sBXM326Al`+*0&Y@dw6pW`bgCko<@p_` zrlINSK&jM#3FsIR#(4n*^<62Ibu|eXSGsa=KmFqvhw;JCL8-oJ$%OATGCs%!O1H77 zfGGJx8{y&0N}vs_Z!}n02X(M-OZVFy?wi-`=#B(249pB!$$wKDeehgESBpJuYF*z` zb1bqL=`UO4%uTiIyv)Xd*uyv72*reN$(8`=V#b>8|2$L(P;Cm#+fjfKGw^BY33{Hu zu5hsc027b_p6O{2p8x<)j~!s`@Ltod3AlM%{RSqsRhXCmsJ=Q_aDXRHxfPzf{}#30 zj@dc-pz&V71=fMx@qXwCU?W6EJGMt%PIEP=d(%nn9JWww`M@W*C?W{W8vDOTZYpXm zq4(oG4O1Y#-tncGNw**tS>xy}bPf-Gr!F>dskJ(zT8%j}Kxo^5BTX~-_r~KfL7w-= zL*y2=yrxL&u@gXBnzYkRta(ugu9vg&*%TGZAH)9{ zV@EXTfIZX7;Px(qG=8w!sW)lAOkxOso{vnw&!Xi+e?$`kvKqyS={KR;nvPA!N0Lyu zb5Fof;(&BZsI_10ANHkB>T7J`<8&r{vuZOfcW8s);1e0#9w*q_EEAa2v zs&tM1L&o(>o=bX)Dw9b>a8@_N)cI$IHzdpxqvt&7iRgHcs*&?;H9&v2j`};SK5fkJ zu>MB<8y{SV_};iEQ&lga+^`+02vBh+J!${KIV6GSgnT^^R)8JhMI39V!fRk|Zg?(f zwCpY0I`G!R#eB;X(-}kgF0XKtE1I9~JD;5voLM1hXLLdtR96O%gK#_26fAC!2`5(l z_7d%LX_q`eNT%h|?%+dk_N1&nr<-i3Ql+AO^MYDvFurQAEk?MCaykjZ*Uy zWv!gI+QJpi>m4iGEn#G?_CEgp<^_XCyMy-R6bSS+7&FZ77|zhTn$OjW-i|B1R6tbe zZfg%WOlGEjhz4ENIUx@`aurU#seHoi%MRO)F1$X|3Q$)o6oF-5QF5cFcO^+Uj_3>V2x^pg-Bf_L#U0#>5{rX?B?9;C-+xuBqgL^B>iztFLNeg( zQ~t~fxT?q(v3?#08$&!P5*25UP7o0elzl9Yfm(^CvlcCFF*AC>^pL(sn=q=E#f=p_ zT34|0hu&26v|R4m0u+#SPQ@wxxc`Ff$)<2+TnC(m3|Q`!^F-5DP6b9ngnT>$i~V`FtGT~-*fs@wAy`Y5GY;015zSxJaAJ0D_v zUtYk6geGB8ey7_iN@W7aQ+%!kb{4WAz8F9=>KhI&h3ID+Y2!8k@PU@-_b`CVviFX)Zb#Wjp{OGja<)QBi-m&DM>>ZF4l@Q?Nj65jjE$d#F;0>7 zXxB|O77d3g?n39xdz;Jf^E@iHh>>UpT^5?5$??*Y6I2hW}|r&8&93wbNP**2`^qq~hfUmPl!NQVd#L zPp|PH4R0hg%Rqooe~t+=pN13`X*J^G#OdrVacdqxAu?orAR%|xgExsTlCM$KYMpmy zdu0dbrFw}3WfXkfpdFjkH!%og%X8IfG-9&ig|0l7q1Rw)H{c(#4*Em*L*ThBKUr{M zo^l70-c>gQT@L`7IBTQ2gnrdeLmtqe+N|jJ%_CEl5d2bw%3ZvRsWMANTpuW%haiA~ z?N6+6-?TPnidVh!b4(K_6apaJH=4*&g{3I?|3xWU02Yg41H;8?)ki zB5Q?kwV&6}AZt--2?euPeNSr2j}>EgyWvlW#0ySR?Sy?qQ<_Xkf9InZigR9OXbu$qNt?m=lc0nxZTC;Iwld~ zP|TsAqK5NNel9zRec0>AQSQ2zj&qH$ek0b!M!Uk1cuwvfIiw{=y+tAAv`j$&W4_7Y zRs@f$s*%x3CF`#a!BE!+;3BW>y#8Lh^%JM}^%Nqc!dF3jU%%kkQX{{Q$=5R23bWum zLj}*7WSqDXdqB5_%+r)`^>#XQ2A>)z*}B*gpG&+9jy(h#ysVZF13YH32;IW@C}(XD zTq-hQUtErx(%LYfmn3_Slww+HO)|#)+3t~+nR6SH1k$?CIvC}_C4c?dq~EF%wjb@I z#!?8Khv|=*-P@!?o?Got{-&^=7<#<&MF?MJU6ViE5;S`33tcuZC5@!r%1FuPyD)!gG70?a9T7dPhPx=5Ern1Ftm_8+5Ld>2!))X!PwU!6{gdxKUZK zi*hQx1sPf6ts3{TjQ6EKH7O$(7Ft|d5lYz~7Y5q3?GGa4dtNZ0>vJ1u;^fkL;EDXr z*oxVkPMZ057xtb}BF!llJj0Qzrp=lUY@C>r4Q#&)grqsT>cI;U76wj(A>k#Bg;Gk4 z^v}AIiHEAYxW^&wR|$?EAz8Y*6DrY>QE@dfzG-wYqNZ5z?R}oZOwEPULA8yl`#uT( zno=>K10G_o>`QqC`~ZTVAHHbx+tqLQLhLe>ws@6dhBfOhNo8Fv+(iyG;)*#wm1OVe zvi$a(wdc3oL`|z}hf*7E=@lB(nGyenScI>#FS^+AMm=;=3yw|^)u2!oRLi&xsiKOx z8?i(ek*Mp6cUe@EE+M^sI#r4Y;1f$g*?N50_fY7xAa4bVv3(lujo%_Aj#6YVJTIPvpsA&j&VzPCf$L`m zZ&2To=!2>egxLZz7F0qa#_Khd5!;hDJ9EIc9q3imSjj7<9 zEJ+V)R#Qjo|9+xhss2~{wAgy=LUE{lDob8*4(Zy%6yd~TG&?0ekJKkwGLM)X!bK)& zIBu1=PO^tv&hfUfaO8a4)}f~91aO#4(a@D`I~e0kn-1ZW#~s>C@ui+f%k>Xl@Pu4{ zqt~r=B`3=YD=!vA_G*FSFj@+O>KL64$k=U=eAhaXZF$GaywY}&ec9<_!GB3o_lnWA z5q$XK)b9;fZQ3Pia)_e_!OB6@zyepP7jvTX0aD6PfyR~WKHVEANMtxKdK-}8YNI{>$^K6mz!R2an|h4sxq7Fky8xe%Ss{Mu#|-m5GlQ2DnrAr zu(8~@?i&5Spu!1IQAb#}w#bTswO0%@E$_g>nn$o{g(ljXR~0ll{}J2saexRsca?Mx z*-P7EgjRw_vk29i%-Cxp+AK-F7`qnR1fUl_S~#n6C@l1B-3Ilyrb|m4Y}jQfL|+cG`W$oGEI3k z;*a~Pr620;4*=e9h%_Qb`5O1`O|?vCqM#i4RF34s?+YUj0~q!qYF~$<30rU7_YUVW zk!Y8ocZ9Fq*w~=%Iw>%8jhs<_$hAmSq{zKLci4Q0X1?u2Ln%iP$7B^s)#mOApwOj? zohh|%$py5{aBv@_5C8y7e^InYwGh#0AZnjHZxT=ZXGH6Pn-c#XdM7k!0PR)UvrG#c z$`L;sK@lZAPwT>m&zn>a=A5Jyc)DWdfhz2QDc&O=)cS1T`Z6`ETD!9*d}Dv(?sK-) zvwTnGUiss1;@2}J5-%OeH_mu^kvAok7IWBhHut#HolW@Y+Th5>C*&EeR+KIn2$fp< z>YfY;h$Vu7LH;`Zs@S5Z=-p{?!E+r+cXlX!5AE`s{e&Q_F#r$_F!#!bC25n|R9LzD zMX@@4@d>I}lry7~7k4pqz3A$?Xd~60Bw8dq;|Bh3-x^+ztAOSpj~P%aNiHA0f7F!T z<-T=xaBF2=mp~t}6qJlE0W4ksa2)Ue01;6Ep6hNxe*geapgG~WLe6Fh?gYop1k^lu zLMrkz@w_1HUSWTEG(ZiC%J@N=IqBF}><8Df)dkuKShP?BTyumqO_6kpzdz=O{{SuA z29W3Tp@Mm}sy9e`^AW2aWDZahW+U0X+a+Jicv^Wr78P|r@T#OgEIlshqjkM7^ zung6@-NJ+={F!U%H6fg7KjRicWSx>IqrQ4%2om)T-wyY7J#<3HbIpTKw4CKmbcRWf zLZ~kr^@J<2-B2E+tu2A{r0Q5M%)J~RVvI!@gy^l!4AZuu0)#AsD;yfS-!DCu7%)vz zpBW)Qzj9Tdizt$cf%1au7It@&i-dUU1WS9K0MAXMjaHB@DCfL&n(o+$(6NJle@+#M z(%eNGdpC-%vZZekvWt3K?-)%%v0WG$po=c>sI-^Ox2*Nn40Dd28ThoK*?7a6zd0a$ z0tg<?Q)U>!kV-t^sVig;qt~bB&Pp(^h10cO4I5`N4Hj*kr8NGkG zHuNOp256=zkPba&S2n2PhN;}HHo&pCc{KkQj&XA%=0nzWnQelTnKN`8CIK{pO@W8p z!3k1fymg)y`?wI9=6gHTQoR^L7YD)w9dYu z=oAgr{|CL4556RV#O;r=hr@ZKvXnV{x?rJW$9lhjPXKE~|MVSYcFb-mADVTGTE_7>0Klf=$l(%kK%5v*? zeyBltR&?@|EYod-FHOOs9Hn6{P`XvqGAm%(SWWe4`-o)OSnhnYKYXD|kdm5DQA`@I zqU;EELHw3a-C{hIc>nG1Fb-@1o^My$TVUR{s}m-{q>-Ux>ewfT`1~0RDbTNJn*1(W zrTc66wysqiU%g%c{Kwl|d-8xso`l8jvTB!s%GR2zKeVT=G*H{5Bln3|CijNeH)dJ& zf|x%Nnj;JZ$CN9k)AsIFlHa|U0YpzyjZcCsEzHZ2?E0HzF?F8B<1f6!9D#Dih-+oS z*A0;1%RVa@k_YRc;nxTRC+;?%KZ@>EeBV&8{m@f(GEjSI?eu&9Z?B#c0PAB!;4`bW zr_Uin^g6m`ihJPvtfTE+uF|%aD(g2>ew!5grM@**A&ycEB0LnCcY`xx4 zMqDx7npmT}Oe=UA# zr1OxE60SLQ(B1^P$VtR@;${=N@|GU`Dr^0F-)~YGl7NA#jtxFH=qSmb136qLbeqQDQ=y66G)oWpvlA1EPAVA|yCP za(S?Ac=OXVW{jkRX<*CwXQJr~lLdVna%?el`*=gn#S;&~Q)6iRCU^SK%X9-0^DUr$ zlT>blfh$DeS?s+0!h6(!vR-#g#RwplHNMy-C3CLMb=6BHgXON|>P%3#v(eM|z_QR| zWUN?O59h_N`BQo88RBSRAurVvc3SA=3mg-HPv(xlL@B{=xQNQkm7!IpbXtVgQe5O( zRJXs}QSr4xv`P%EEpKpj0D5^=L;$QlzD{G-Tfp1O9hj9JmlV+3b-Sq?qDt**dUTkX zK}XVGjd9glYlmp9p04tuP38MK{TxaSTfpP@qG(y#{2XzW0k$AfW&_>uGnKWZ-LIH0 zdSNbKzfJqf4EZ!#1U)TS(erUnbR!mJp{z9WH+;_)DsxD_7cc?@#>kt;1-Rn~MU?cr zy@J^$fcR@)ZGse)F{q!bVBX{9w)23s8=tfk$1V;Y*86ZF)(O_y>RRe{a^-b_&p=4; z88fdgv5g7_Awp8H3Fr)lt2g-h=TKd+9R6VoO|6jaq;_eAg^yJDV?B;}jn|9B7T%5X zs|$=nekE3FZ;&5FWQku)i{C^F8*ncC$`sz~la6Q>kVVGeCpn!M^1G1_OY=w(%zsQt z^Z>yVbpgg>Xun2wu8B(a)EkEuu!(nIqw17Z6U8Bvb!B64gfN!>v37p27@O|)B*XdkZ-2{|oGCV}? zG7B|KY_hs(ol7wMH07PeF)o+1|1mIrPZv8SEi}~6B$f>K+bSIT>VPNpKS#EjD9Igf z&22SbR`IBCbeSkl2R?t)e_#QX|NI+{f-B-^AiXHTH--@>@HVy+2q=YD@}=fAk6c3u-2LOLNX-`KeI11&K{|;=>?8plQfxXv4xGwE;#%E`QjSJRY{t+q`J9M(KGN zl({q6`XZc&Y7HZN^ZIBBH<$9}SOA&GejWhsQB;TN;|W-U-UF99*HkV66&w&)GRTb$SKW?RGP#63jLhhg(r zPYz@DC|M=>z|m{{1*;(>y3XO+2x-_DF5A+rClom0gknO!m1@+zx)e--S)ypTfS=Ip zPqSReUtph<9#3X5)7eXx6T8_Regfia%~u@HsNGe~VH2fGdCQ#|%TwiRhZt#EOw%?# zooi;G?wK!r2p|cW9#HAZ@a{J^=dEa1LuvXOdjQkJV>p`vuT0!(r7THV0!dCAA0$zQmzW%hE%MeJXGB}h?fMF2K>UR$ zKKM;GUDp~eUYqF;Ob0Zmwqd-o3v%7l*4w8fDgEDglCpaN=^(^L$v&Yy2~u|-(KBTO zSPNht=m_K-y%@A4`NScRMWVlUil{6U<#Nq4-PKJiQM=Ell&yTB!>m;p|2i884X!)APoZ&7g`)Hxa=qMUfun$# z-+OUEuxXd+>e!h_JM#X5x(Navqx_j_{!k>WbI$`K>bsmnp9D%bvz1^hsRvPo+g0z! z(So4^U^X@<%#QqxO;Ic2PzB8^#DNvo(hSTi>b@VW%2u3rqMKob(4h@v-0;8VI4rlA zWIrc-*yQB3c|6b!EIo8=gt|H|9jvC;i=>KpnqRtkT=RKDQJm}bjPJu z_LBlWYNebdG!E?9t=YZvqfn<_D4hNGyyBDMk|}gGE&$zuQIiYJIu%m#dMA#W%L|IF(cKk z4Xic)%AYg0v}J3&2YJJ|J$xDCf1)CmP5$z2W{?L2CCIfyJ?t8Lb9Tvb z7ah~_8vZVyg(8c*un>JRJ#Op?84bdCymxz_xQ)xm z`_Q4oB<}YRD)mmlwO{>R#1%B)kxp=jY@WTFmuLEzp(cI4;A{3e&;9~k5w!>6ag^@x zC&MRS!5_1H96_6UbpDFGfp-g7#e!367acp`GKx)w>Cj$XTQJn*E#sD{Y{1{~X(5-L zGg!EsBaI9Vlw4hr8=@Ee+W>^B%0qDD1!cf>h^_1V7e*Z1I}GCnU1ob3|6pO3>q^Z~ zps&-TuO7)IRrv9C@{pg3{;I5W!ZPwx{F^)v;eSos4&AY^0!dF^rcG56Yi| z1m~lghGnlriqt8!Uso(61+!Q6olVkA|C|=#v6~lW>m}td^%~q?fHR*A0mx5_hO(Sn zDk8;=x`L(jT>Q;v-ZR&}?YsL1Q+cO75T&XHK-`O%K_x`wwpWn3(MMvV*XazgRNLB86w$Cdjs~4)fxjS8{mSQl^0Q3K!DC2`c{fRM3 ztZShw;zv&uSr~}u%%VWApXy;bEn>t}&H;nUUcDo396JA}oLqxK8wsX5#lE1imOtj@ z7)oiJdHw?NwpH=DlNE>vPc!osCRGGB6tiMU93>9M(8oj51}0KKR{ z-y1vyN-E%iZ_ADd0Ej|^>YA^Pp;v3#zJ^;KP|Q&ON(|3j412k8ws!20vk1k^%sW`4 z%omNW(%Si-YN=Qml2E9;`dH-+=q}D=_0urJ=8@5`2QY(jH*!teh~R7ICEE}r|Lwpp ztnH#{bkT~N?Dps@m%%HNcAwf#fJ4Y~q}m+3V5c!qc)C3os7-&xR;$+V6!)erPB@3n zZ#8AQ5`%YxQdB7cq&Ohg`te$APq+XJL4Q^xE1#NbLHm_I)RBw_SUzSp-8GF+ zZ=I_vm6Jf37xev;39i~4_^UGUj^h(P6wRR@^^ojcn6KzUik(|;P!*J6t@U&x| z&1F5^0-UiO1v!Y;uFJ10F>^WH+6p!`%k$53b$vH}3o2WQtK(1Cw**krt zr%`c0AY=uTPZ}q9%u5}-c0n1K#nbuR@&K?3m|@=dpKY1-E)2k zt0EmiE>v>OY8Z<>W&Son$9=sym*$K@*Pi2?Zm;Mp6=#zpWDRiGQ-LIcUPw5)S{g3>l)T^$L z`;p(n9nTe6=HEEPc0di()Xk~Kl z?lYWW^k99LZ%`#m3ds+(pk}QGu_f_0_ufahTNo_vD2{JE?F5F(cNlC%RQHs)zaJAp zRq_C&)Q15(Bh)9IC&;4z)RvhdKA4eLe&hBu!KnKmWBnGuF1SLz7RXe5&mMYP4LFNb z9^t>!KB&Ov6(XmvXRB&cUn0zfYzbpJ$y(8y$a$N{&mCTIwY3N{wo4Ig5bM^nb(f01 z3mFCGof*0@Owqts#fPi}crPcGdCsBEv{`>RKzv#ooyg#eXtxHQR{R9pe(G_tdj>~O zW^(GaE@FVZP*_Zi8@D}#oWX6C8C-uf#`E~(Eu9R}^)qo^k08tODUt0S)j=!0qg)7J z%1(#15uSdx=JKBQJ2ca=X>Kvr?bjRxg?~7F{PFW1R>4jsY?5XYf*A!ifDj(guhbW9 z)6za_?g9(jnVRC~n6HIq)RoPwqRUbt`b(+*X(46yT@t3eTq%0tR^{GhF(T-Li|#L< zWLFp~a#$marWe0|O(SJGrQeA5>m~1J0&6kdJa>Vi+e!SONO&G{LkS>BoMKcze~865 zn6EzX7!MZ1yPV5B@-(D}sn6#`f1CJQL5IzsaMh*O6~GC_f`3Tjx&jo`^|5idNdkX( zx?G@B(a?0HG=`YD%5c}VCT3W^XJk6nTT{0YpN^Ot7loy8G(9gnFpPfkrH$#fFfd2O z$vPBfR%k1IE)L&4aPVN#%MIW&c_jsoTFSskT7E-Of*M_;2v97Q&xTBx#CJbU$=&A-QJEYZy*x$fTO4U zk^ZWU;8;n=&HS%L<6!FYJa#3fiL@zWiJavA6lO^Ozw6m0`v)BY{Gc6RDwxrgyBEAF z#&_;dMB+mO;PpA)-?ve~r0NUN>@M?dhlY@xFRhdAnTwY=T!%X=787!pEYEF`(|Ubt zfnTnfl4>*aD1mzMbC(o0oxrW^x`JsaWNb^)NW!W?bKF%|z4b;C;D_&OqyxLj_hkXH zRXE;eW=VQ$#Vev+>B}EluX|}}eWUt1br!u78rsDUfPL=#kDGWr##SFx3NzEYiWnta zkN{0;3s%1!1QtCG-(Wa;eg{%!UntVSz%cZqHwZTVb+m8Y1-HiR4~H~hA8dMy>4M@# zYboflMIFpOoH2KJgumwIhh4`df)5m_k935VL`B9W2whtnf(mWu$9cih?MXjUOxH$p zSD4r{-q8RDv42*aA~yIDxR)NJet~2%WY;?XNAD~Yo{$B^uz@|#AE8Gcx;sQ5vm)I4RQQz8#iOMtm%I@QK%y? zBs5w<#;=S>Dsik1gjC8%OGq9pJ9<7br&nB65hhTW9-zu~)!PL% z@zUdq!5!1r-qYB$j=)i8bPO5?_1F!H!4_cdw7p2BlogSTl)7oV&5_w`0^92WhX0~- z&8Iye>TclAA`kQVTs54xrLDS`&qM$+=6wpV!)#>>p)kVq&Vlpnk9nFJYNx27$U{Hk zTYTWqQQK4+J*uzy9*?7;k8Rm!?8JjPg2rk=dX;veIy>hl;b7M?R;^I_{2oRh+9U| z++MJNEBD5GnQ8dm2Ld|I=b5n8o)B*%d!bX=N;nbqKBVLlU$Xn&BE5w{0?{n%>+s(` z2cAla#_gBfocAUe$FRbE0}JkZI{8r}Rw-fIsM$I`)RKVNow-Paa>%(R*NOOdeF6YO z9^T5nIa2+@oHG+C>pT9e0igSp9@LkzwujLn)61#>N&0JC!r>m8fe2T@R(N%0U7K_) zFowV+>3Au#^Hsa z3H2xaRC;R+`*gGd{XQ>9`@-OW)3s?rz{dLFC>i%(Q$Xm##vN$E=;M9O6V)p>53Wu?ke zY9gvUB4ry91|j7Pn;)NW5*6%xvaxyjlyjAcv{d5wp350y)QVju5&fw|Vj#!pjw>8u zK6|ss_pMYSoi4p#H_e4+V)fQ=n7wizENqM`O6Db=n!Tnc^g;Bu6&;c;>15jGDz723 zuWSeg*piBsVmZU5rHY8yFU)-BWt8Nfml47f|ak1|0ueXXc97M zyUY#zofb5bMw5-k^=u$=k$fG2gplV`(E<5BX&r!y1aq?jM02mB%c1P>bv!`9hIG1B zucOX4^dxB)!7Aoq(3Dz*KNTdZV@-_Dv0(N2+OzYbxaxhh@4aw?3_9FhyqiMKz|{8NQ|z!J){M#_LdJ;!HIB|MCrw^)wWr6kGblw}ZyT>19@tgcXf}RaepAC1 zlEWhOLdaR4>UuFiURl`E;--J@*&MmY-)h948$obATRJ#!ua|YxRH@x@%O>*YAE>eGqt^5Ly{s178NDX1qrm>iuj!?~blpWovjr{&u$bMflE{1)Wgy=b$k9G@`6- z!FO{EqWad3kGJ6~O z3)=GGXBaai&HOQqt>SWIWKZTCT4zY;h;&L4iQ5F}6J-*z{SVJ65)yQ1+|b!|1lPmw z()Tk#@Tx!?^`FMr`Z-eso&Pyu|7(Y;(!$9+v{eXE$%V+o1`t z*_k!S1M2O%Iq_aJBs?iRUN7B-G6bk3m#omja`)0q9KHs=9zG{Iv`Cy7;m~t_v9>-( z&B*?MMj>Y|F^x$L`J-l7to^4I2c{`Zkan1#wf?dg=|MgpRQRSo6CFm5Bk`XYPXR`o z^I4kjX+n#xGT|SjFF#HU{V%Cg+hm9Vu)q}3rM_I2BG>(ZI`g*n4yJOQ%SO_c>~FvS zl!F`K+<0wB8nY^+z>RTA`8|L6thU#RZ2&kn&e0-t>ZJ%@I%+@%E>Ne7J6FEP4d$Yp zZBAmXhL9j_W~vl{4F;l`LdF~x=hNh6aQSYpG^)UUU<;rq!H1L?Tm1dl71!&VQWA%~ z)Z7?HS4E*Mr1oBV~xd%9j0#ES6)3+dPx*KkB9j zTFaKr26nzc6)-n|47n8Wq#>Xmt6TB~tohlNruUU4@-b)1ET$xvJ<*Wc=}ktAR0`~P zeIok#6X>K!nW8Ga!lxO7MJQY@3$JJ>i>7N>nAJp1{F7PR^KO#c_^huiIwf*&I}&vu5NCwGpj zP2~hZn#P{**alPr8ne^1mk6LJoPBfZso3k zyN2`gOq5}$gK4)X?knVz78)(Pl&4^9IB#t}<*B!iTtR(q?}Ox3GZX-NB=03^_0pp) zG4@fPiAIk%-a7pqDhq>C*rbu1R*CMfWcH_J@O1$qGesW18UBxU5z0p_=63?&kk1H5`p5?aaMp|vu^`BrweFg1)hP?hapO5z@8|m5 zI!MG@fE{&GEGX)n^+9*i&yH+mLYPRC=ZVr!>5A3ZgXD z2?%Bhp28cD&#+K3LS%ZLBSpu(Ye%~;^Jtqg!`R!;mI}mb6Je6X4&0^+{&*U$QKF>e032WcG#1>z;YhEyI(*^K&?b*Hu4 z8uQWYc15KKI&@mngN!bV9oh3P*y96|?Hw5nBNGHA?4lQ0%1|<)wm(Rr_ zX0KVgcMs#ceKb0g136R@HR=(5Nw)iz#Ob-xl2^Mq!(}y}O^m~=Dm}O5L@YqVl3d7< zCnj|tov|y1F7A#PZ}ZAyX|jGqO;s_Mj>FxXZyQR0`Os7n_xxT3c>>58n^J^J&H}L( zeO3V@*}Q-J`Ke;&8L<&lQY^j@2sPSb%>FZo?WxgGRnw>pK4F+|^+N4?ao$ieSJu_G zTO2dsLb=`r08~J$zq{JO)dT_+3;$`ZpAwQNv=bf|jZfzqg#M(Iyu^tE8rD=x#~l=m zN9&p++i(cXb-u$Rh2_jwH9@-l&@$3@OCmXLya!?((oZv>dw7^3=BHh~qIFzm?H#B) zA5|9$L;o%G(?7J6_XCZiEm6XLAmVDKYl!oXvJcps@BjwRP867yGq^b_^xuUvQKRL| zO~_Df1sGL0M;k2p*A}LAz&9xY+^G?!c^(Zp)O0df&`WllVU8Quq~+ng9mb=lK|V6; zzueyjRTMj%&WDDPA6nzGnQwHN?M1=DHl8COa>N4p88sUHu+FgDdESO~xYA1)%>J3$ zl2PG#ab2xr`WHM0#8~Dp6Z%P6^9%uOIJlsz78YXo$3bzw5YQ z>hg*SPm39+o)UH7bP>XI4{2c>gnnRedZ`|25Oq`~;;`Fk<-gi7P6HV2UG%Sm@KEKx zsdKoOl0e7Di}o&6z?s_bLCTOefu3Zf5#zn8C`m@SFA_R%|0_-8iWlf~W8z>TftryJ zoiWVgoaS@VVG00h!ss9;3{b5T{}>7|jd`i233($67~@50Gl{fDKx^kBX>K~~%v0ly z*rV$6<%Am;-9)9a^v$A1+yyK6j)?k*%RK4!v);FboFcnI_UNbMGbHu_p zoV|cnRQQR;YNZazCv%GomAM@@pDFl)-W74;c3n z#3&?MPOXomL~UrP&ae9y?IftGPuDs!dA6FtlW!{kPMQN(g;-lVH&S`j@0n_={#j_p71;l+92v~W8Zx;P}JNa-waL;(xX`@s*v95tXpaOjOG+JB8bo%WWTe0Qirz^ z{11t5n;rxddZl{3Hn4p!-Qi$^V(QW;HHWkaxmPVmJ@YvjhBCyZAe%CQs)^s37R^E?`ZoH@<8Eq|HzsG%cBZIq+oQHS_hhjKkRz z;{*ewkD;Ior;SsC$gnl?aaxdc5^&RDE>{`hPO-><4ljvMzPf!1eIy3jCR~fINk-cM zUkipYjp3-rtm?io=Gea45N=BE7oWqD&dLnja zm8ygk)~$pGi;FA&VQfJo_y~q#q60h#?LVc>`r53DHBuO0hc=M!}_$*nH^J z81bub>vq&_JCPuSd%N+5UTxocVJX}xtYwA&hOE6u`c#@0|hep zwzPRH-L@}78cLP|&(kbi9UC!mZ+lZI=Yf4oVO!5n+d(iHvHGmS+I??R#|BS)F@?@& z#)k^TBJPJ;yNv3n%LYJly9=j|q0fj2X$2g~Wz zCl!h!gk+b@dH(n7^3Xq~ZO`OL&VPEnL!Hx6?_%&EJ!RRnKM_{(0BGp)rKG(t_Ujht z>jKEuG;;dq{YH*Um6>{NmCefCv$SnyU^k0HsZssbkQ?el@5{_sn9=~aCeb_T2r48r zyW9&@l$UqRAe68~f&e^DewycRik75sBL_PFU|#O4i5?AN`btU7*KVlU?`4Tvc&!KR z*oHZEc=>68S=0=_l5@v4*DaoeB`DXXuG8%NyQ~+_fI619#~vPx;!pyawSyEXE9OPx zB8fNigb~97`nqX~Xa5B)Jn6JxIs?gt>48d`;WI?+77BFOh5KB1xmr%kl6u9eA8JPd!9y~bfYIShE z@~&12a^|-ZcEXyAmy%BYIT0z=o%WTRQW6efc$J)83S9jq>M28#O}>8Rjf352nb2ta zZQ9Xb41pbDmRO}6vG?}c438AFVen-WA%We1H*@wYypmK;B%Hpl{ssUPyuvPy-1Hr> zBE6ADRrATlqtg40@@cJKD>U6-*M_b3psH$soywR8Rw3Nn=ER5OO9!7MCtsaplp_qI zvHzv0uG@p`WVs|ZZtWh6E3h^wyyjQE&sQggPMAM%skNm7J{i;nAUa-a}_Qu?G;Ocn(q3grDPmG*o+ytEW+4+ z%Z!!~PtIN+&$B~rzGr=PkvOCf+egGmAHByzJ;Bq_gv9KDHBHUaku2&A8o2N(dgMf0 zz2|dw_0(l+Uiw_G1<|};7}+ZV!mQ~@=LM?`3v(K}Ii8qxQfsk7-B~@vhU&P$qF~&m zK|9JBZvdI!WL8g>nffcIZ$YY6H0fh=+oIi=0wOYf!A}1dQ@Sx$wP&s!$^yVxFc>qB)Oa{UOm>7~>N{DA( ziblOoTp4oKgyg*rYiE}Y*A>-kqq>OW%X2^auWS$%0C27AMkHc28beyr zUVsP4azK9TVj-fbYn@af7=N&25MCKGG98u7v!)y}Fw9jcuW+$*tV<V-SyLuxO*bso8=% zSU8|&bq9qB%bv*xp>ORX%{bXx)YrQJYz1l7A_hS+)X&9_)e9b?A$=df8-eG4k;flI zZujVMzelbbszc?0pQ%!#17pqz^6QjQy*iLcJS#g`!#O#(&T$grbaUy3bsxw_zi^%M zfEcgqD1*Q`NxWM22^V?YauN~#UI@w|5MUp`3rgG+TX*1gxxeHv8%sn_jT$z~_PzB+6hNqcUR(EYYmp@3&{` z#yS4~G5%GmJcIb=hf>r8tmpY4Q5xDq2DyDTK~@GlZj7gQnBOlv7D;$4mS7y%4Ox_g30Z&%iA)v$!Y>b?@+%h;6W_TngQti2_P8)2;Mu^jnKI~Q zT!Cz$9ugP4DC=LpI&^LoEv%gFLErLYo5R4nVgu_K9bW;!J!_%BLO*#SEtC+l&B9{E zNwqkAg+zI}ag`@AAzF;)BedQHBvX811V~qD4swU9>PsH)gaohpX z{2eKxfG0u%qR2qhGaSW`r!2aEWYi2&tp*4!Z#cb+kM8w%=`JQpnz;hepW&3Dc)c@i@uZ5vA3HX0UZS zx12f98<60?%F`AgGl@UEhBGxM=&4#1*F7UPM2&53TkO{p-F15T!iz^5h&AQ>P=PG?t8(K9%I%>*b=ch zd@Fd@?lSnV>X~d`fvJlgMIM#15M!1P0lO*tbJWV(6KIBlpo%rsn)^7?z4TGfQtAC- zc|#Ez&K8WDriohK9h{cf=~&^3B;zwTf6`E((EXqX#zOejRSOr~W069f{%38V>t)S( z4M#c7G(D&Y+rRx`mX# zHXWq+g`?twyy$O~FWs!EN0#0J4-%*>8JlZQ(Ha4vr?RIZpn_cQLJ~jGv@UhoL{p{K z@~XkDA1bn7*N&#Q8eK}f{tD{+`lktSuWz2eX|V3@X;iPRmR&xulK0GdoI&`u9GXRo-;WJGjGF zeG&@)q_F6^_uES`*kxJ`*F1W9R2l-&1?i>glxE0jLFs!jSf(=L^r~54H+wX7+N3{g z*%S5R{ue2CHlbVMC;Q|hKf@CUHYJ1Cg^PNatB__YOalDu-Mv%rkb#4yh;kRfR{B=P zN#E5P=+J32+0ANT>wy+pc5D%bK*8B#^_-?~^^%I0SpKHb0Qil{I$rDeyDg?@=)Kxu z^f`q!I!os6Q5)_}7y(gYnCV$!Y%T3B!Ju4#*C+t@76xJ+Rmos}NTL*CG&!!@NlzVT zCjV*GqC-+Ht$1(S3d8tx&N$P_;vd8kUFtE`huMhQ9>qHiBFHa)ug5w=RP2gG0@3_!F0>ffXl+O3f~Z%LqKM+xxw8fJ%@Kr+dPZgsatY6^EE zVOG64ageCmQm!r+wlgSWg7|EKQGTZ2alFFUBNkCVcOrTH*q?6ZzL53ki#UBVVVWOw zZ0@A~u4YLRB2p_aNrEC>*SHGRbqTIwh~(=ESL)0~X{9-@@Xw=5u@ipMA?)AW#H~83 z#UCY@$jb(GavgV)3lt>rzZmdS{qNUcdF0*?Y9GyMrf7?Zr};$#^6GyKOF~F@Vu~cHVXFF8ZTKpV(BxfM>Tf-)0GwlRrCSt8RA6nm2}}t+tQ{Si?IZ0tf90)3DR6ND0-eWu1?N)-sdi88g1+N0@x@&}|X zetnQ&rPnr^Gl7riNp}=$&Vwcjj0$$mvMFsc!vg+@SIeHb%=}ackqs5!U#KbpiipS( zI^@!34VROjv6+8sIIFiV*tKKAkECqYGAAuJ@3q z?{R+L6bMj#Aht@X2fBMxn`?*5ebrv&55A35|}@+0~#r@|?S@am5w97P|Z^ezp3^b@I53(62sqWBS9OxRFOm8~=S zpGcP1y@1b@Li3*RfhbcVr@35Q0ag4v*~T!gM3LOlALiH^3Zv`&J*L~o+~nFKtlRiR zFq7Tim9~Ex)45#KzesdzlR;#*ZrQcb}ul(ByRH~AUFBEzZSRSUiSkI^%E5N09RDV3@lz|wGRxy%+BnId+#c~ zI~WF{gWQ%#`Vs|c`U(riuaCvyYJcUZ%_WV4E_=y<^o4W8HH5^Qx=xDxxq-zmb4#2-Ik1xibw1|THNNFh z__Tq6rkdyE#~!0lbY1sZlC*kEvpWROR?lr`(EOkbhNhtZV>7CoXcvI+kCbovFz6BM z-O7YcTa!*RB9t~EgrT0<+B6Wsz>9i(meidoy*Ay|&s8NYP~EklecIQUp448jew$h& z%dqp}D!rTShN|k5%g5}lp_rMu>1|A_@>3zl{B?-!2_JcQoRDL#QBsM ztC72VtL6=H;ndmoh^J%)7Km$j8x!bX0{`Y6QI$B3)^H$GY>Ln>vf^Osrdnm~GVfru zSaV-$2(NE^3JdI&+(Q}0jP?9=c2II5yg+4+yX$ULl-g1aRdn&luL}pa7ry$Ns5N{i z7=9s9B1eZB;=iITaIx_8@PRbfi!}@*iZJK~pi+Y%J}LI!1Q|ww{-y4amV|h2iM=5x zYr-?vc$mxL8^|mv362!wFIZ4_w;49r&&CgPmQJHSR-qVR`m0~&#!#8|4A4~=3V2QM zSH&uC72G;^w-vCfJscN&`$*4_?0}?`?BLK)Yjna>c;pY9VDy^0cciu=VG z`$@4LtI2t~C!(LJVaH`Y*R#{^<;m6@pX8vHubMptU4Y7qI0z}a4+??nyH<8lpDxt% z?pVIK%3R)G-^({)o(`VKSOYZGWI($>Ryj+3rS@)SdYHC|oa0zfG#aUiWCzks-C_UMeIn5-sKHF19h+G8z_+^LIyiecO4}Kpwi_ zr7Tgf#juKP@+(#tMprE&4cr44_4~}-+y|2vQ9FT%f0VX#Zk`7^EwX`=w$hOLy>E)&4@4 z2el-&L0ZWhgFPGSZpCxoDWvwRMSZOh=gNIb^#rzQm4n^RP zjvA6z>)4_FEUD}`IxNa$KU))OeKimLIt6%%EC^R6Bkn}8M7}6l76xi3J;IxQrU?iG zNHPi@?^EQx6BllD7XBB>cPBm1%y`fHN`%IACZ}?}bX(X5B+n1|gdbIQTr+&MCpkxA zS)(^Y2N)t=x1C1$G2W?;JYC42V3zW1AMERn8XMTR<1jjlk?*t;fsxsx5R${hE`js# zIbSo{=Q!!zQkuFcJQeBKdToEn)DH;h-;bQNjmkL&0r1x4*Y8t6)}=-41z z0wQr_f7ChJJQNph*ojwLsi5-`fB-5UTK5DIt{#p1mQotWg8)Fn7{dfDY_$EVR{L z(&ReqWsPEyWtDxiK$T+zP;8~R4tUSQcDt@-Rp-8azfk_x5JpO(uo1?X=9H9#q6SNl z$UXEnCWK9Qk|^_l2n+l5#u)^+HQB43_>EO(0$|i4gl88eug@ab_}HI07Djkw9>bOG z@EUV0wLRXN39z1?T_Uo6L8qdPvf%p!@FjOB=_JdSIRZ{R-TuYrn(nfVU^2E; zNzJPDeZMNQV?QYF!;_xOi}D58p2AsBgRLu<$O! zOyMCXb|m-x?na(SRVO?97~k&){~-chfHQX$9e57PXZ4UJNOB8lgL4kmKx#EfA3+Z> zV1r>Fpd|Vkcv1m)ca75a8}{2T3T2=ts84#pQm>;(MI#+meEZ{{04RpBjdBtZo+Xw{ z4($VL6BHAhJJ2v7`;+_cb_u;2-^Tw+wPKF_D0GjFp>n5Fi z*a{Z5)aopOn|pqBYNkzCNJ#5OC@;__$6f>0f{Ov3%A|Ucs0H!L%j$RP^C>cN1&$kf zw2sGaN7OAwnYiFOYnflelz&WA1DO%P=pCc%_-}`Yj5tpf9XRhCm^xValHUmaD6U9= z22A9|)L1;Ha3@QuOr+@i7+wXy)Vj}lf>-4lx-D6Vn5>*CuTx~hKa>k>6QUCgr8sU^ zw*A@(TK$N6vpzxo2u1rQ3@50+2#i6So?qD-26UvtyH%cC@vE-o0AcS8uSg?9a!B2vS7Qmp#`iBHRllvjGLtPlqC$={onR@`uzmiYz^F z#djS}8%eC6Ap#WuBXcOu448@guX|t5i~&t4dfph60M<|m`IM#7fpzqouNam#LIyz= zk@OMe^E^?^e?8g4JRXKZ*`$29nP_+`U-W;s%L!$Z$l)T(O;%;TGcMDEw}rmHn-zvv z`L>m5vxJ~HW)JEu#JCdY)wcIzMFY6YhS^+h7c*dIZO7!`r^Ftd3!sdKt>yb8HcoEz z5nPeyy~xF(mpZcO`_)eQ*y^OPdJ%EoO3pOI_hrKT5TRxmQT?ed=J}(gXP4&9#$zE| z9bL?+viN#Z@Oo-!k8?fQRfEjGv$g9=dxcGZ3PRZRtJYgTxscuifJ5z1ZX$;@g-t+1 zy1n_L+jTt>aiEd+>4Fp=IE9ghbhz@X_NPRZHU{(Yg3VqJp=MjK6_YrbFHIjlg&dv5 ztn*r53?{&})6Gou!b)5Q)V|nSjh>%R@RkYx$0=lk=65Mc-w=WDsU~d|d!!Gu9rja! z=+AUi@N@!*oz>mpYREYfQjQ4)ZtY>UWm;G?B$hfSHE@L9?*E<~J#wlU&_YRIQ3{=p zhYn|Th9NF6ctR&%$Q(&x3#?{P9}bPo_j@_=+i;-kxKfjPx2@mN`w$>ZAXACc$T%pD zeEdckY1lSm1trv^+}piHzK8d{IvTac*$lbaluM?AVa(|Bkb}}zsd={-@x0UsIS)BH z@k!I^@lO1E;%z`K*cZl4?HT34Y(|`oHVbixrS#srNM$ZXZ%WoWGH3e$0a*FVAni^3 z{)r#OgJjH(PFdxeM7K-&9RKu!%-H;ZD9gY38JUR^>z;_PB}A~9b}lVfiZG{3ytl~m z65{vVCe1v*CyfMpw4+@3)x)sGCGtp#i(-~Kro6l*}vcdvGMyPz&A)`AIm$2b@8;4^91KIbDEQk*f5Afr;8Tr#4?-HOAuNSt1 zqMqWyjN4y0rkD_-X}MY3JHOY4;m&TZ?l$;YbJ_Y$BYBNeG>i z&}}mzX!>b94vC-U_%{aj^q`&BUt$nWO_cZn1_Ol0OnM_Dnu85oP zm)XUqvSxs{n+?c%JP=w zKd>6Wqb9{bs_8?%t2`_{HlIk4R$a@81=@GBW}gIoF%ia$M~mo>O1;NaM#Q8UwA;p! zF;tL1L85!(`a|6T-(nfM^X#AkE^1GYe^We-_wz6O>y!+Lbld*^^6N+bBlQzDV8=WD zO?>@l>q=sL={aCsWit%YsmB7?K$P(?IoO3t*#U1VgVr0u=L)(9f&#brRNDQrH^%hg z0a5(krZ?+xVQftg0W-s;@=NM;p&p`(sjfK;AI@|c^}U$r~n03)+}upoe(Dh(sQ(bmc( z&!_hvQFR})2GF;K9}g8zSHr2iwGdM^-HbSd&-%R{;dAB)Wo^Gb>d%2J zhD#2s21*hZ&1>i+MIE99NSXjb>{4@liYeFyx(73j+#rTy8jXDCVT_-7z`e(c9=Pw-<Qj$!!kvd6W|kO*VGb zZM5zw?a3^$K%BkmGJD+tgIt^7j^`UkB!0g*)Kxb*|841apn*G%dl+r6x; zMlqunsV?`<3rk@nCmZT+bL;{&SGZ-EM@vZnb5^#p+BVHON3LT@POW2fU(?PTWI{5f zJcf!BDgwpE>ZshQWnk*~mFmBw+%%8ycv6kevrjKVHd~1FQ2$lqb8o7g~k#**%5g&WG+>o z`Ku1`De_xAh4%y-N>n=b(-SS%8s6XZN-7|Gw-2m9nGwemGnb$I?n2@`>KADk)!K;zZa_)9~BdS|=k{fRkE7Oi&KFs^KaAJ3O|irwb}_TgImG|y@V zla>xJ?RrSEc(b~o;$xjG_8iqmDMf?XyxT8uZY})C z%ma6i@Fy!5%dFm3E#x1w(8_mNX7$1?CNLOPg?mg)odwd{0CdA-< z7r8R0=d#F+4%%PnTQ|f*AaRQPjZci5QK_S)$j7@^CM~s{PE{3Z z&f+ybpGg?7d$CYtE8nhIXn89@#ypCePz4Kp@TSkKPxBI0m6g^R=uxx)^6UCYl4AP; z(50e}1@cJhS8zi7hGk`y3!Mlo^EBP4d# z?p0{{-uhKas_BR{uQO$uzrjgYUYdCQWv7=8)dkiDQ6!Dzl~#5^2#2t&NiM|i+O+G!z?=v# z82Y>0~ zKLhAT#}K)dRZ;2asC~i~Mc5v+kXAU3EC~!zoGcR)Ec>5y)^=geAE`pj*wV#r5b!_a zXXKb}0O7A9l|U+&@Ip4vZYdJw4+U~zAVOFvLhCiORyp1fu*rD>ernO!hmt)LrLNbd z(K8l<+S+`7*U90-aNwONUX9UPO+Heqe1vI_H+OJJOc)ttF_gCobzLp|f=w%ywiXz3 zeIkvNtv~^~)amogpd6aiuLh{9HlJ)Tq#BjpOJab6aOQ;V^CV`pIVB9V?z%QR9xWs= z!l)zr_RtPsvf@+b&xNh9wc0o^e>f?Z!;6D^jG!j}h$n`C5X-(i``^MLgJfhJ3~lMv z*jeq2b%HSxVi$!Tm5n z6pj2*sac=(=W(0vE$$8CpuRcVCx;5;ycz4LzetU0|_8J;dhIu*-a1FSJfSUSenXw#1x7c$v1M{Q}e zz4ngAwnk;ksH(~>Nluzrk`!r7OqjGw{e~<oH;N}y#5HhfbubTN zT!~=8NRC+Hkbw$!_&+%>GYa!5?LNk`3BNmCvM&dh3F@ z&<|GHkY!`ZapLaKyt~SzcyhX5XRhg5Nv_*3IWkPg+k8iLUZ2Z7o8#Jg^~@zS!}Wei zocg<5h}3jhUD3cKKm?zSRIQMYt@ot|r8eIBfG}Gk&cRnj+a|-prY8>J!+$#=x)*Jy zd_k%IVmu9_ceh7O75c2?Z}=Sq$uIi!&ft+u#QvNna0Wi#pZ?$YwDTdgi&{V(e9Lv) zy$`W{@pBscNCG;@ROdcjH#MKkaM#;bY%l?1QJ1^t9h76Fmvz8o>o`-wLpgPGOgUnUGL?t_Iv z_IGUyO0?VcT#kRKfZq1n8X)B9TbM9gL&(;GUdk8|$KrBc&@Wj&SU`QSU!==6*=ZMP zD4K|e45rsjKo#2;r;UnOq#ZF90^1Xh3hMr#wYzWGl5-M@ZTZW=_4 zA#IK8cun}f@QYp@q9dqTjOIhW3Vt zh$(QPV?`a|sE-1cKu!-Bcs&QxbFO|Sh$BzgKlpIbxb#*cC2%?wfU{OOTdX@Li4}}> z`U0j6w_?yM+jdt{p*Izu1k7@C)m|&K`%!+N*!4_Nr6{&ysEV(zKkv!?k?;C0h9suM03Dg(rR zbbNN8HLxMLc+AXu)vJ32cC)o<4k z(;d`~Ff%3N*o+xy+G{28Q~-cr&G*wRgQRaBT7yBHCF#8DRMMI;919Iwa#V-+QQ!>G z6+g4Y1`I5qIsCp3$xMfBff0azULaD893|BH4?{(CKdrRWgBUXHYeerMxRyfNGXCI3 z;6dyHK>GExlWuHL6#xGrZ=xMEhHx+Y$=Ut~!K+bAG1-L+hlx)PfysBBeYJEXY)Ehx zzywMqnH2i#{`Su^{Jlmx18Ulk(J_yG>9Tv*&uB)#Z<}zk2?M?$YK*spx}NiPSPdw0 zX1^Lt_l&_n=BhdhjXJm4HA|p4bEnaF*blO`~_(@;E@63NM)-`>ve6c{Z8ir6Jqr5MVh0!^Aszqa*`hV=2L zA&pI_dqT^}C4{07=F8D``x=bVOSeWff}s9W4r2_UAovd)wct4Cf~2KZNA&d_ce>V) z0NiD?OIj;rIu5fa?qq6y;|q9-Qa-G9GHY$(c73%$e1Ji~jUMxtyZF$Syi};4=pt$i z%W`_VA@nL^qb2Q^yPtoJIK>3Th*7@-v>Y(x3xEvZT2D!>ECXQt{E3LG zSnevyUI{nHwh%qBpCc4}-ato1_ z4|x9j&OU0HcOSiB=E9MWHPUDRI|*@Uu!*MshF%*hy^XA1HemegKz*}#TtPKf}hMpT9b>p=RU4|VI&^88amh`qzoAA3|cfH zU+YY=soHP!G?t~rAiSz7((m0@Qx_j;e#O9wbPfuad#&3v8T_v0g)7yC}o zJHxv+e!B49Br48hZoBZj|9Die^}i#aaOn+)0|P2W>C*n5IA3jbTi7mv*CX~V+9!z~ zzpQj~dt}xe5XnFHw`DPwyIKEMqgwzi_yckivN6%OxhwgBWw4P$>dLVnk%1hfsp-G> zDl9Ho)HG<6EAXy}UlKV8?p$Q!iH~m0SKsMZ5SxB1pGwNY$@- z`SOPU+RX4Al7IdQOujewxQjQ252RT^Nf)_=E|_*h&fc$Jo+y90*N^Id+VZNGK)-t( zCE@N5SP@@C_lC1INKS_@MWF{M829=u-oc^`KzJdKVpXCv*9ro*3jl3DKiqEf;n(#u z^dlOs3=Dd?gkrnRPVkyIuNKBK5J=mARR`5}@t>1JvcxnouUJhd)RO}iB>{Zg-(-PG zz-}KG!p7S%QCiA`sr-K^ zGyKzUmS!~WFLZrS@cIpc2b-(9cJIu-;R1G!m=)%HRkjp7pUtOfmO~v%JUAo}^}zsG z!;`wEkFz=M#>&8e&7@yK0BJX-l8~qg9!uZs@}fC%l>5x2OEU$B2`F1^3b2heWqG7B zH%16=iBk1jA?a7`FDFv(ltp~V47|`l`jZfH{;KXWH0#w(8VKK;aldDa89S951fB^o zGTL9?KCa8gVwWcW%F}mS_CNw%oa&1Sp%jT#zitp9MqA zX{AZW^BfpU$TOE264?7cR+6GK>3m|?Z`cE1A*=0~&2J-Ij@r01bqYCo?J5dyP>xFJ z4?nlxgjCE?$VZ3{+n#)d1ujKo=EFnW2j;ahi^eJnA_siSxlV-eb18>|Z|*_^-<^5I z;v`LHxb%%K8x=bhWV|y@6#x%}D5`yCeY2)N-slV`F+F+U{+t=^LUEC{@jEu4^DKQ{ zR6~6U8JO)>@u1|%=5HKN*gKvg66zqwRETVaTu`lsE+Fh#snIk)R0)n==h z*Csk}*xUyfQs0K4n;g$M*hU3O_@SlR5*X>*?sFx(kVE$&|Kt{RdVpy(K% zJFTk&cLgqkoZXu|J@vEdJ`1Oe_?mNrGuxoRpj}tAu&EPRRK+H(zp~lGJfVRe&{k%N zKRPS;o;fX}ov&QPuWxf&J?E#}$;pWivMO>YRO(Ce^2j$E&KKHupdQ_qu}ifwa(Z$P z7j|`ll1?7wPDiwuMmBvVQe~Y#V*?~7RS<)*_ngq{6RI&qG$NNumeE;CVMI49xJhV| z-ifK2fVLH{G|!_MD^3gjBjT{ZGOb7aBBGA`yve_mbvl9$=*|Yd{wVRQ=j%`zk0y3a zka^CrXJ2jgT8%S+=|rMM)XJ`V#ETz#OLe29Eq{2pM=ZLLK?)M6j>gYBM74A+hZh6@ zcy-hx#%6k_qM$W8b*tuyq8qORGH`W_IVIAmJwCPT2I*LCKe?Aitsi^^3!?mYaVffX zn&RkUK}q%o|4?-&qKc_YKOz&^(0CE^3O&YL$SDsOH_|A;ZD;$oe%ZMQ&*nN?wao3| zEWOZI5V{l1tWziq;d*6H@I~~s3Nb5M!8#GEjY*LESqI*Sn6Qx@y!{VC47F)eOKS|> zjf<3Uc_>$Q|1_ybpvd!Hb<6Jst%y>`*m$!qV}9>ve} z)-?zl2~LfGy2rx4Y5?ATiDQI71}Ae}_rTd~v94!1%k#A0tAP)=0|=fUHj2}1gcP@4lB!Ev!I41 zc$jPM46L!3a*?N{{`+G!GrnebrB(b0cl)@(4oAZ1=dkYcZ=Tu8c5X9AvVGeB*uHNU zK#8M(RK#91T?dZq(w5vL9L-ywZEZL2V9bul!3>*TDXts7NJ&M#%o%j?7bLrp zk!#+H<6!7JiAQIYw>0#Jy?>3sO~+N)eOK?hhcHT$=<6IOlh=D~Wa&8CC7H6dMJmwM z|7BCXz7tLyZG_Xbn~wFzUP*lAKXuY^S&G<`CPyXwUj62JzLuDgk-0FnfXONg?}Hx4 zJG7-pdOq;Ew?bB0pT7%szYfpLxcW$@^qfP-XmpD78*Vc+J?SEmHW7)t z?r5zxy{7=*31CQ!S3SmW+An zA%mM9+<1kLDXip0_g>_Tg3~8lh<6Npbu~gBkybU_K29>s;Q8wXn`2REN}I$i-I@9$ z;~@Q*moh*VPevbrSK^j4k}=n#LXV5_pHOp`YxAkPYY_Q2y^-}8wcf;gNe+$KoVf_g zsgW()Yju6|C1h45SsN(LNpt@{P@tviL_YCxDC@SUT$CV)FBe{i3gTOWTV~^0UnU$z z)`JVOX4j(KOo}){Q>!trP6z@6^4i0mvT$It%Io_#)kXrJIG;;J-;`0Rtj(*KL^+?2 ztnfS*dtq?Bq}a7KRnotv%uF~27S6ZeLQAaqatDW@pRzK5NZ)}j8ve+O);~;fV4YI& zLead8JZBdLaDn>wmTgLGvA8-Z`8b61z0R!_9#;C<%O0l{9b&@0QDlaDkh`4SoKvah zZb-;*vuOu!lgLYfdJ-5ydLF~!uk>a^_Zka$VwpoV{04Y_4h0e1Ktb}Ytn`4F-&xaJ zwro3NDV0NyVJlnT5~6Ja{cX4EHs4EMJ%1get{=sXm#;y@1qd^xDXacjsfoUPg}_k>Nvk)A@*j(f^H0xI4YH6H!@FzfQ$OB z-GPou>pRURfq6qgenfjLv{T9hZmd5QrEfil~Ikwk^!C?pk{4thH~lXP9b{C17fx1 zq6v9d^T6tqGFn_7$cQ51@HT~%gmNGJ=z)9eo8V^|WG?44>eD&;Fw4!n+*na%*Z@;N ztiLuo>B=-Yv6b&%ah+G&((FT#Zk0j_+&H`k>X>rkIp zvV$a&XVfJ<&~0j!zfdI*x@yvmWhRDBm05jU9m{0Y!ZIgoF&5 zd0xQ-myf#NhU-@g>~@F~wru3pQS;G!S>bdRB~6@01V222Vg)5cozhSFE_{Pob@s8wiWuc$Ui9o?2jof5zpjBx3bEt z;P{Z27IEMuU3LFPIYZJAHSdoS?oS@AZP{BZ{C#{YAplAUtg{+g&pR$y#B8&Z=Su0e z*R6t#EAXE*3Fuw}p!^FJP%;@cBW8C`XNeX1kyZ!#rM%IEeeK95J+k8I5tEHODo^~? zc9+R=HJeKXy7C}P`A%=l#Ai3}_nlyrL<**j9&YP>Qp|79!FgxG7*E$=hTL>6LhcbrUpR?$W^)A%L1%^#+IV?o<$t?$d@{0mqC}NePv(^*<($iKPKNY@hRY?$7Rrph;@;KDoc** zXFMrEwc&U=O&L_vb7+I0+?aUp{U-OtGfcT`cXZ!<45p16_TksEdeFshJNz@wzQIH0 zpUYdjO^4FJA%1K=B*lWRbz)F-5qdeE9#-EIDxe!pJ-=RS>s3nkzBK9t^b0TmVa6TZ zvW$Ql#W>yo1M!C7IFszcoN~o)EMTt_47{NcN2mbOMNifxoA3f!-LSV=im?ANc$>cl z`|6qDzAZw7K6nKl>cH=otC@r+&9|tL2u|)&C#{O@loG1W;R7}+|MP9jtS16Cj3I^C~oPL4}+eI;Nb|v*C%_&|*C-QStB!i^` z=c7Uby;A&wI&)guBrSm%k%_vF-4EwHY>M*S=F9osHZkha9g@ zA!i(h9Wut8pLs&MW_cuIaUXL=N$ngeIB#rfWbuQc3p>Cc;S73Vv43756<^aSZ9DomBUxrPW#Eyi?3!n^E=ip1XPe zL&LB~{)Zs2wH!ANiIC*KEh*dOhyzIl__~i_lY0#=|9+Ha)W7xys9cMsbm&56!Qo2< z;AeH=`f;fs83jg!Pt3l21EIC5psOCs5#R(8kZnU1_ zmk@TI%FXW_!2Wv3;1c~&t}UFVjXh9OEhap1Hjj6E>2-acWo}757tsiVgzKqKTgbr> zFYKBHDcq~@Xb!jTC z3Bf~cX)*u%I`3!qx7iCGA&p$qWaXjN3bboZDy3{kX^Hf=A7ABs9FfxIZDCgt55ka? zV-Qv+MLY5LpmrZ}uq`GMpPzIft~`+E{>JZ>^4KF6F|h5~3Y;Dl@wy_I*fO?X;Amov zgCB;KG7Bdn{@DyRoRn}YFl~Yv8*y|HQ-Gc{QIhc-95da zHdl3XlyY$M>6Lny<}}<4Gf3?U2%%W7`+zQH)*Ti3xDsq(pDi=?aOOH;CipE0)7=l< zcV|mbtJ5AIqs#IWQ91A3tXiqfnKD6Am!N-xX}J`i-y3>lfZHn)g?j#-h5O0Vo-*x= z*{4v#%zrmAF4adj%;H({`sz)gpDKm>p*3rqvO!XmE+7|iKiMcb@STJ#g4D<6s6|OL zIJC5Z^)>UFgggPNpwNN;e|`H@s4&<;CK}-@ct_=-hq8#iP$>8rH!thLgikAKydxdj zER`oEeR_LtUw(3JF}Wt(E+GA~95M@-d}a~2q&J=cu(zKDQl4o@s+zK~?G`{8`~`bD=p}O$ z=)WFyeN=-wFHM1Gm*SuHkJ063bAqO1JJiyF(puu)ks-dE-tQD}nqqX?VUGUS>QSMH zs{=U&;FgNpdtXG&Zz1nAzq&207Pcjini!WRbDvOca~DH@a&A0iM639cw*+9UqRPT@ zSz~UTIC_GU7i_g=uGUA~cz*2qM}#*opDlbW$4F(A7dU(qyf7NCx_>1^dTxpZ8g*6o z^ta*Fv9Wn0yXa<1_ub5Ls}W#x2)uztkfEw#5sB^JhjTVzUxJ;}&?**_js&;y`tXf+ ziiuZ3CgSD9a%MtzY>fD-ZPCK63fbT zn^z0Thlt;XYQ^zN{&HEqY9vvzTdK(3A513Ss}FY8b)2sUTnWxW$2I7-zrvgiMF=IO zw3)mQ(nmx_TyZI|^sENbU8FHDz=W|#PMSOut>^Xaj$I0w!F54v>p zc-YBRw4(j41ad=PiQ2gnb@g1~5*?{kjm_{~dl2f&!{;8H_4z$Q0}a!idtQ#rZR%t& zHzo1=jR~|C2IB2)#B^POx;E99mmGcf)eM@8!3ah#Wi!3zf}P}$KjlR{mlDBjMv`VD z^RlxUMl%lz zjCT)fe#L%Uz-63dcN4smk*WvkK>c&A^xB(3%?zdU@$C@QZCvd2KH+bl`jPM;&XDSW ztoN7yv#c2~SflqRKsp5ZPHVOBCB-6}s^cuuH69M0S?c30`}gR|r$WC)ungR;Op^fY z`r4E=o14Fo>aTTOKfKR0L7u-DVzKhqC0Rcv6!bpTqmY|t8|ySD!F@KjDYulP#y*1YOgt&5IQz=DYZ{&TaEWhB}P>Ip}*2_ zBAc1tmIw3It^C1ulTBd;wpOPXxgbIJ5VV`tY@S%WTle5n{~tL7ieL$Ulf4#Zc=C8w zlz-1wU`#-7jrVwp9R6->t}7PBxzwBxwC~A85{VdnCWE{dGjAn>BHGIbH+`c|9+rQQ zRhBQ_&nX&QtT6=bXze?)gi0I-FRq&)@iYsSRoIfd&iSWzW`0ZjU-2;5-YM_%R#tam z5Iy#K*FQl+#b2@xHmyk@3flE|C)L8aDp;&jmJx#pWGY4nb1ouv7iaGObnfTYh!m*xTw?@yRmTI3KR; zjDcv6=?iLZov4kiK`x}!BEsxjJwykdrk<*CzU z&OggyK|18{XyA4$?Sxu5*(NU1?Sr&At~G73-1yr4E$g?G|E2VGrvHrGR!^B&`FPYp zH^?|8yFz9#*fqitjRddbj^5<4*+6QDhP7EM5vUcY~07TCa zWX9sHJs^oulO|(j35~MgHgQ=(_5ln_J4Su637;AC^Vo3^%94`Kbo|WJ=#H7Ejxp=y zDeT%0`YW#d5$PgqZra|1#v_p~*zzqvD|2(QJFiV$UkgM}&~JrB!uyaV0&huCRUYcd zSS&i0ta;r#DT`1UK+LFwM@0JXsMwE6+Q4?rseH2D`txb9@`;kw<=R&)8+2CwsP z&0hPG6}UNOc-xGJcOo_|=j(<`EYUG3P0AJ6VT&pXEo-naaH)&E+1JTo@WeNX!M~v%LCbt`qN*ZFifV znC`938+nqLz_;=f7VgFuz(`c|XVcWyEfXLhxicIC@>fOEQsq^fV+daR#DhAuOW;_B zR(KB@hHGuJK4`*)x08%qxpAxiM))5(=XhFC>N<60Z``2$hMi{RHXhx7q=TDusDy7$ z{CO|nt3++a^t_;H8K7sq=y5-K9=~ol2HCT}R4-6RcHBe(xYJg_TM)CK4CYYFpJd)H z$`oiF1D|ZL8o7nId|3RPp*I*A4yQwNRimh5hrBdL*cd4VxqN>Gjj2IBSEJ>}q#bk7 zz?ZDH3@us+rP_;bN1x`^4F&Uo2Jkpe$flnE0#$^~!h~{U$zR!w%HhY(EE$5l2yLvK z2WHB*u2szz=c}QR4&IH!jt+yueWUO`PyUghB;EKt&iJt9&3nN4@UJ!|vfafz-w)ao z%Cp`PUwM)XA9gd9d6a4e1P2xPN!T3S%S5=iNj3n)N+!64j|0{YASeIT@+wcLavl7l z#4^x!mS-Mw9I-V2Cgt+lt~1ejb#X%v1obDNmJu>Z5aa}V3&SRvfIjjn;)35Hq*WZC z^A(EnJ!86k&j<%!KQ?6A=71!<6#-`Fc@5CvVP__X-#fe<(BJ`$CrANQY8@eP4uEYF zEb4!hB(d%w`7D4wYqJ#@Fg8y1&l)RrmAPekA!RV&cZQ*yIMOyH&u~VED0~^kMo+)X zSop8V_=OmFl$)e7E8hZL$G!KL3arS-NtCYcW-;i7+fUDBQsh|RS9~CUGJ{miW0O{R973#{AX_M_3I!cs>QH6*(|txmJgD9iGydOm9sKJ z)BKvhveROcLT6J2Q7)W8YJ_C(ZOzlf;(bRe4G_9}NppfdZSWbZn856*S=$y%HCMWU zJpuYV#kdTiNy^;#z^}WK&PS1`mU~dbygsf`*BE`)){JRoz|}m||B)m;)GIJ;6si*-8syg`_a^ zh92txB80&U+XEMvbJQ_}J4srzG`E?PMI{I{PKkm2!y6Iq*FelQxqt`9)@!?rs}Dhh&?{*`>u2ytg87?$5>!KU(z zawRT57p-_nG0bsuxaDK?=uu1~C(8@IW^cBly%jhvxASyyY2~v=Y3qx{eks)ee8hcX z$$)CZ85&`nG|Uk!ZlqY8*$N*vJM)sKb;(n(>Ctw3{5r#*Sehav}Q>} z1g*v1{|_t`Iq&gCI|VhuKv{<{!A&&|LhC%qNFDp@Qi`1o*T(vl3Ka46yB^=%9^{aw zM2m(HpX;>=k`S~--%9Ht4RsgXYJ4s{AR$-sWx+H)R=hrFrZk2}R|nv){;s{80oDm& z9zArfUMN>kR1wd65-7Y~{Bd;xXKhToX~{uqsQO>gZtcN?}jt;uXXNJ3rTI4@))t{8j`Wq`;Nr43#0oCE0tPMnJV6j z4)idh*@f6f-VC3K7J>ySBbH)67zPp@kKM8AGZJgmtpjfoKuN>)ba~);G@Bi(IQAn) zjP$No9Z&`TD!dn>tx0m46oyjHrPT`zw;*9}p_(7YCdK9R6ljC`A8pY+W#8Sp4Kg(3 zP~sf?2EjO$+n)a*dHn>;o-LDL<9i1>lNeXhe?b4iYi1#yQk*AcBj8E0FK1b!JJ7CR zW^`jGx?Z}_00Db1jtJZS04B5k>B2N?ON~#FPAg{U50D3Q+7-I90fO;Z1y0%rVcmso ztCd*OZ?a8pS%FKSAm{{m=O#)C000&70iQ2! zLVo}NPoO#8!{!_o4E?+W+X@1hMqgMA-1hAQpaRVB4$GLMk;43d18{Hvc10`I4Y$R+ z=ulF;JoJA~+?GmaVUYDiHgUSR{#cj>qMq~WA__O89U!q2Gh+9ia8 zoaV21dL4OMjm_r+)ncycyqx&Hb!9eaCNPy4web}Pded(6 z#W>J^%{)Ze{;X}2i$fO%?Jc+4wyp`YqurJ(GwSO8I!>sH&LYsmC=TRPi1k$3Ub57g?9>ePjN?5I*raU;ts5d`p)( zDfZE|J-K7)eoMD?-yzRZWY}CcAA`1w)`how*!;6*uzlrG(i_>>2_=B%OAa$p+$; zAm|fO0r&ve(| zJ+EP1BMr)nV)KaV1Q`C(N1kT1My|YKyiSxBfDtW%$9acXuxCd2?j3}mV|dB|9?fY1 zV9R0_yrp0c7=A_+HWrr#yi#Ey4jNhUZ^@qp8G3x*q#LFPt95I5pY|gy!nO&-2mTeP zi&ZjD-cS3g3NAzaSpOp_YHc|Ki5gUXeP%@&U;9%z?4gQKnd*kv4Qz!B&CLt7jYJz= zzi1}&4IQvaXedwN5BJ<#-2+>LQ5+32!cos!8!+qN9|-5Ae_o&%xF+(G^-f0H&&j%* z&d<)0B4m^0iuKhbx}l>IenMxc_LyGJLt ztNY^4e@iGbN{v=7H!Us+hpqCkXBrj!E8+;~?Q%=qT`~E|U(_ee8i-?`gC4N}kvdt~ z3GsRE{V3X4-0fr;HyCHW0a2Is$@GUb+I;@OR%$8_g(hO9w0NZm2x&OskbmrmfH`xdwqOKh4L!j(v=x;8Ym|C1IHquSZhrb)yoRbc1UQ8>HieR# z5aUqvv+sez%r6~d`n>4ajs~F=Lbg+RRzB`2(bGJcq-Rfl-BY60*d=%q5C1th%6n6H z2U?YDE%iURZNN#Pd+uWg&DohJIAC!|Ag6xw5p}sGxAIb3;0G*kwcAKCboM>w@06iuQuon? zo8XmL^9+YNvSj}&9XYwK$MN1C$Q5nY!$sFggIt#GAwwY+CsDHg|5)hU@mUfb{u6li zdzjy~DvmWFc2TRQXLUdHx{d4aa%VfA?6!51`Bh6)qFhBz>HT(*s#Doj4>Ew+ImB>J zyT2_nkaq&|kT(1d=>C<1c@g=$IZti<+T(995XABfz zwINN@-umQB$$S^{Okq?oyUjB!XMk`N-h(qu;%LApV^ZToo5d1AUf*(+d96&K!OIXo zkTzK*OJk$#aG!u}+0|>4i1-!zxz;*U4o^(lB!wHi#%<6E3+0fZt(JXUz-eMJCv`sr zbr^?He~pfRM6E1gTmN_q`B&c+pQ%`%;~+*ztjXno5)wm)!gl*jk>~Ek%>vpsm;Dxz z1bkcou6o?ZSSo8oC*fDB3iv$x?l+L<(E6_?6l`$b8{;h+~x;Mb3e4{{@{6oneF%)d-oSfTJBitldM!Y7_TR3T*-o`Av3Y`K-s!}nMx+}mH0(ca)w&nRs zu*`!UAewh3CT$tR7Z3mQYS10}kzxX5o1bHpu0N?#h!R7(C~#)2?U<`U|Ap;>Ca2!j zbllv^@?lf2aWx|ClAyvCx09_(2Yz!cfjY13|D2ZoJ&j7NDk`R&)7OzqS(PZBH$@(Q zLCn_6?e;l)BqVuxZfrvue2mnDWTwN5Q8JR++$s2No~NB7;FHs=ASl$~)L@qo0op6k z2e=>G$vs(OtQ(swS6oN@MnGdVn|u)_SVY~d7R38S5WhwjB^(58x;A>RdW3pPC0^Gg z0J6SPG^S74H=6;I4C=B)j&}2+A1Ruz2(0L`1E-Q#4LZ6$KPt2&&7P0FS*vPv8}K>m%Q)*sqqgbJahW;;*5?5y9r*P|q7RoAu$GMJ2w9 z5w5crx`>-=0dH#dW~^|zAs%vf;ZX!9!!yr{3&ZHKdihmj0NDYnE+a52OcXsmQ!{|a zc`GNxf0_tQbhVqghFd~)@NQzK``ILZH!f=?rs^rWf1W~= zEvyJrkWk;tYS;An>Z5gzKD>%5eKuvt z`KW@em?NHFO}{;xqG?z4)OZ6!Ycb_rfA0~xQi@rBbB5HHcm0q2mSbGm2bRgLvS3v# z%Tt7gXp;{P(zAMFe`v$*#6B5qQySU%q3(t_q>nUcDPt^j$xuYMQRsVp_|pEvE_!=L zWh}-iA%6qPG>NsFYvx`OBsxf*-ipe^0)c3+1D+9yB7tn4V8rkr7ivH$^w3a-!4Pka}I5l7``9m6T)JD$s_COm8k_8l@7!4;LGNF0tC zUa)c>w>ptFH{?qGJ9gLN&hY3-zgyNU<091(#e@)YxUeSQ1}qlr%7hmdJA7BI$~{#PLFJ4(xUvz;cs>|BvT%i3i6nmYZ? z_i#{~b{wk0bvHdyO^sb99+Uh1^@&s;TOCR<#RM1+| z1w`u%?;j@{SjDhWy}sm^Wx1uFy+{9^^7Ys2Hly=^lrDi*?+LDaCaI5YtPR zw=LLk_HVOvLO#@N9P@Q4=!)WIFSe_{6aBY%oYPq6M2C=6w?rPYeuG+5c;@yd-DsRZ zFYhGl3jtPTQVCpFFJgN%to+eOr0TRjPL#10xVuX?d1$xfm4}HV91@myOci#hD3N}O zui%rW|CyL53GV7g7#QGp^4CIwtN>VnbbdIoFTtE*`Xw=ASz#QOA0ba6h#aQM;NN+r!+X0VH-)Z zYq-t!q7F0APd`3r48{ojHnT@o-VHw&7(Ah)8Q+-3iwS-@aJ&q zHdtwQ{=+Xl%7^SLhKep*XGFa`W-rbl01^jTiH#;>YZh>Oc8K%>ecrY^Ry!uV8?Q>m zw_+?=!X$>V8w&PlorYMh9t zy1=N!m>~vS4NA*tvGE}){UTz|(kifKS>@5{&6y^nkMNOYx;ivZ8XPjWQn{gg>p$_EEBmzwS@V`HLWFWtsd1l0O!!J84B!9A6*JmTk6QL%NEYsTNmV&Ufs+hj|hPqoBV#Gf!U5%;l)MWPHM zqjuHmO_$H2YZGY3-y@qie3hWeYtCD|SMecb3%Vurwp)#{_wU zZg6Ym#6EG3-0wi}iRo6%^sbU)J**bP@p6G@+xs-U45Su1n~X|S{d#yriAKuO%dSMa z1iR$Bi-fnU#6RW^NQ>a0LeJ61Vtu2JCPwH6BNTM5Nqp9fpx6Ximgcy%V^A_q`^oFS zYAF+HG$1W8L|XHD3<3Zu5u{a9);OF=6Q)zejM42{%lZp`D{o<`%L#;IS3TbGLWC}+ zSNh))IoxFX~9fIpyGoar+1^)2t-PCg3I!Ww0h|K=&O6p*NBK<$I+Nyn^M zm3>rcwZ#&mpF3U1!cRf-YNja-bKd;&;S*8{60Vf|4mj?%yzb27!-}o(eMlgmf6C+Uofo-L~Ek3WCBcD zjY2r-#UqME(A?#@D0`vLb0q$~rtkUs-pnCn38$WnIx7sRezZ{R@>^4}s9>;4Y5pGe zE%S46iTEAwh`?8jmhK37cxi|s&PJ>^_*yPoZoc;5x?#uV=_EBTl>-5dG!BvH^Pi`z zSB(*qDN0r_SKJ*k{@9p(pILg1xb2OBQ@P&vMrRVz@dmcW0YDrXtE)p0+l-?8MrqK;Wz01eO8>rGc*xFzSBfrrG8{zGo=7l8tb# z#J{*K_IWR<3M+UM(v|=a&OwQ%JwIu((^6pt=SHvm|IzC8AqY@p7N;Gq;HI+HppNn! zvl2NRHV9B61yF5|kpzd5lv~caI$XkMn`*Ml0bw6A%!`{x&2UXO%BZc|%H77lzbUzf znBQ;j{p9tR1n6{1vYhXvE?B10`31sG-hpZ7(zOH7GF=EUDIw$rNfeaZN&i*ox*h5N zJGPXvUFjf&E{F$$BOYZch%)vlR(EA`IM|avD50QOhtlz}P6>0@s1I|6kBn|sbeK-h zOWj;EIVξ12}Y@C<)^rrid72wdK?t^|iDycZ40Q(#gMk%9E`SMnB{sU`BQ{wff( z;n`a!Ua}rjMbk zK0?(ZTk}ft*wgFU%C_Y&}u6kvjM?w+t zoR7$ux!@HK;C?BLDqwwA*yT^@WNE;FJgfnTprz`)Sg~e@UO5m(S2Cdtr;WUc^A!Vf zgyrvvZ+1YhVb1jGz+1**y|l9H%(~U*>|7O{ZrWueOe8X51(#sq(t<+j zn*Ax>&FfKvJ^;>cNvBEwIN15YWzo9dKxo*tXsUOjJUyO^iFR=r$HuwYYojB*;Uvb> zO*4F!cr|ZtdHVXK;Je1KFJ!kmT_J}po<$(_b0^ds05At>R}#RRH?e3*DEp+vewy{{k!8>KM4i4sJQPuI7f@bhgBuWQIx3WTw3 zzaq-srqc|8In9)08~V?Or3ebM3!;ci$54fk5Ekzu&QOOUVHmJi5r1*xJIWQv_5_LJ z`A6cz0YGdHfpbv^6}%AH7r+!ZmZD9BsA@%b^i0tDPGang4)6AF8a$)NmpI%=iJ7~B zN*_ArOI9s}(>Z?&<~>Zp#ZMuXQjqd0fB*p7vu~~dE5Rv3Tx!9P?G(8HqY~^qW-~L5 zDa1&T=_by0_nejlRVJTPh{&* z5^n*=KrBq*I$)3&P+reZ&Q9((!>7p$5ma&QtDcz$5Ytj2K)9@GNx#C>p)FpYJPnll zM+XyP0gv=Rw{(YKDg(vf3cSmpne2KM5v+e3`Vuvd=ibmSjNX&PgWAP9%;~ zmzvB)A;$EAN6u6DB$76!Cy9!wj6a6?I;+z7};E?OP_MCeo z2~i{RJse{<0Hy8dX`y0JjdMQH)S#tIy?|Mz{#lIuTl9FUB>cIU5+Z+mnn*g-m_mTr zZ_k%AqBzs0@%MRoPNeGAA>yvZ{3Di z)5jtDxL=(F!_0?vm~C`?5{Gh>+Anwr=2>famT2}3h-PJeYqDdm7sL18L%O&!qnPY< z>eBNXV-GB66x8-EF#*eKTR;X+bQYd}&P5yj#{K-WSN-rqu)HlQ{NYaOqU0jqlU{tM zn2-|AflobcCoJ{#4EsxeQp?eMEAlmjPBI@*eR^xVIUx&fi_VPUss9vYyMe1hUbI4%0HyayDhJFC%<_1;Y@KXclUmT#0ZYn)!;Pe{CX!!M}6X zAn;vLjD$xq8S4RDwflqOZWko4GK;w35d*rKGO^kF$*iR<*BHaH2d!(I(WjKw=z5+M)JQ-zS ziJ4@OnBTAHdYqm6KIx9JIgx2~6)tO6)8AgQ$zXNl5*9WdUn0Y|&GuElv;Nw5>|t#B z8_n7rcoI75K;+360{K=gfV|AC;l3aFe#tZLW1n!NpJFS&ul8X1Y#@bQM+Z;WgbW8d z1es3#1BHIpg8>Tqn{wlqfm0RchKPuZy<)LUNPZAQcrPA|Wm;C?_;OW;gpCYLvXV`& z1IoO;ih;WRWYHUD_9kwReIxtz6F^JF?JTp~JQ{M48VThPWWFq?=fk4)5ZgI=?6|@# z&|1TP|M3bcr3%T5`O4m4aIdV;v~g~hA^QCjk0a+C4TSXF_(|fte^}FkT+6}3W!m(H zPXzf|OUShMX-Y9gC^6|ZB^%xy)I^ZM|0s|JS)Nk2(22t2sS+NaXM0zwmhBjK6V)2R zWsS2==a%Llv~UgHkm+v9ub184R6Ay%NzG_{uLqd%@UkRa{;NW87GqW^P2q(3lT#{9 zv}NaAPCQQj8C{ihiACOr&wfS92Unpijx?^z2fl)Of2JvFkoDMANypdyVX&3YySP^+ z#Jx?P1#mYL3RaS;$&)8*=>MohMSZ~TVn8K~XWPk$*-MN%ASic_*9qtU!uBl4cV|KI zfQm(b3=|;jMmQm>A2+4D;-k@L@63v=0T7JyfK?85#!O)@8D0$c$dk{lv=48hfs-27 zu~Aeqfj)vyND%J0VSP{ZB(&kJA{2Je@=LV^>EKY$0H{H_tJf)m0Rz6DY6S|M5v^2F zqk@BOgqr{WDv~MbGAKc=eLH&y%bNP?O#JJj#q@D-LjI1RN8x`lS&kYa4hZj`ZmQbX z@zh0~BS25kfRu43=Qkes1;_)Q1`6A)#_e_nf|>N&EpV-gwxf+Z2bL_VQh1CW(7B*E zslFhoE)tll-lhOT_v2B)F&Zw5S{X%awEx$JA%(sve{nvW`46E2wYz8iJ%bm1>}2&P(Z zA7X@bUTShK?qfJ~?-ej5e?LpHtsuT4E6m_XV?5ZQK}US*gF+=pW-6EC6H6O;;Bg!^=CTZWUdSct{$sgu_+` zsOI`#_lc&2F1Jz-9bS9aW7|aPp2;PYlusZW63V|?9B#N3LZG;TvO96o^`gCxGQ7%P zDr?dOgv1E}XV12TALCQ5d)q7&ejrI8JQ@j|bsyL{OBWe5x7#c8QL!-M@!O%P=+w$? z-bn(_LIc7ZaYkrwS-|MENbs*lBrRKcul&%Y-mC)nf_TS!=@}2j0uG;P$)<-p^y87jJ3^OlAY(3O|M+oruBYo) zxaMLo7{?tQPLX_!TIXMV z+FyD78O}h3R&b@Z>JBhxUjKjq`D|!-0TOprTS1?px>&HNULz*QTK7d+UT4~sKx5BA zkU{oimo%!s#ZQuewbCb9HE{gq%~*_ILayaP-)Ur-C4XUL4uC5Fh?JlvVPn=|PAfSQ7fJDkdiK3BE-6Ll#dJ2d;?`w1^Pq;uQY+R!0gVW{3R7OKHvXgAQluxc<^Mk z9Gy7THIA_h^1_h`wlvM{cUx|O;pD;2Cfc--eE*($BD}mv#zm5Ejc-2m%!M&VC5smK zYMm`8O$kX^lG(CxK>fnh1P)bf+$I)xxx?|~o`TU8MieF&Z)R0}Qgfp136M6y z;<>ssB*)up%?;hZO8+4!2fG`B(5*mkgB67sHi4s9w&3aS`HfW>^-wvHZGa9qw^JqN z=;LmbA5U>|I#aC~?X441FDldu#(`VXs{j2$CRyusosxe&R*JLbE1eLjO|;QoOuHsW15)Axtl)cfKE zYd|PTlbM?NI3e{?zWP*Phu(X;Go%uY>CR%{xMH?}dyh$R0b?W^Gur^kwS>=53?~({ zM@K{$&`TSTnQ^V~=49LJtf=#~*Jo|g8P}!`TR3`2iu~8lmIhbbt~TtxE8@&UxY9UlFlxIH8~oNDJmgdEBo_0~v3xr`}%eOUSYD z+^?+OHGUuNLJl3vq*`L<*cbjwvarnx)?t%B>LUrNKt%O2e#}!aCs0gLZb;cC)N{)` zb=D^}|6#OFNHo&N*1RZ-3?#C{9da6+o1}wRyi(M1YDc zKmda){fqg{x0Ngidk|s#p!fR6>*WN1$maJJLeskjKY~nts}C7kZ9F`R&E;D053r(> z+}>SE3eGSmLYe=VMQE4+bXJ2!?#C>;mqwa&{+Nb3UO)d;xvb!ve>Uj7DY2F5Fj%)! z@7^?yZpD!s>;;Z=*VpUTQ-wIEisV*K6ct&rWh;C*yk)_p4TxsNS%aDJBSwzUr3YbH zq;_bz^Z_W9Z^7r833Xb}EAE0W?4mE4bkcrv8^!?e&LHFs7US%tzSV&u*2O2eRjNrE zvos>FVSCvseV&oya~sis43Wg;?7mn4{CmRIObLf&;tSL}2-Rf)?{%JufZ04_Daaok z$uqQN_FL(LUzdy+38&U~P>b)g=KOEFtb2Z%O(_m1DU1(vI{-jHzrUYD$f1X+Lmue) z-mvn@F+5f$Mm@m8c95J8z^SF0%uJ9CkjNB?ps9mt30Vq-#(S+Y}-b1NY@ zAQv5rJ~^~fDQo)C-N7ESTyjLXo}9R&5r1s4W%+eL4m@ivn(_C(sop40s1hMuT%&iF zNJ(dej8CZHJ0RCnPSPd=b1vVI9O_aoN}^DG7A{*s$P4LiUGa#(81N~W7`aM-?*KdSW;I}n^ zEluhgP7=#BE>q9#JPFndsjwdF)uZ78!Q~a&_KIWsoh&NSW+?f{d`g?bjQ+NVYq1sg4}<^ z-RyygZ>%ko5waGY6580%R4QVOaU!O@qh)XN&Auo2Hux&7j%05R(d8ErxPL}`f3uPd9d_3bY8Te zt<=*)ew1IH43GvBSuf2kbn*~0c)Ce=1Yve;k5NAAGdpUhyTCI$(RDqDzSNtUZ@PS?Z3`84g# z(7%((Nq?&6MwBdu+}3Moo-wmB6NZ$Fb9yc^qxr$2$F-aRzC|BYBBcr#96X9#wuh?x z{{@;w28<5D$7S;CpQiu~3yt*4V22yc_J(N^GtzKV{)Q4Maem&n91N^KPkWo9`fPIn zJM>+6IAQrXWo20?2*n_Yt^@<}p)CEy)HaOCplaPY4TiD$Fo|U+VlT*-|KW@;C>l#6 zsao(dTz1JACbF$vaUr0tFygy@1R@SitO$O-hLRY@<#qPFdqi&FyFeNWPeJ ztMu^wX|pMe=W5VGOvgpOmW2*)senM{%rp6`=N`p-FL~=O#IWw-zRFYnw^lxwn{>EP zY{q=BgQNPGxITpc*D&{)^{z0VZEmR;Zld#{0M9sTa432OdFWZ8keY?TtNpz2|ETwn z<4(mw;fD=Z?EIE>PTtr^%S5_?*E15E@c{*8Icj98HnkEm7@z0Z1kqth1nU9!$AUb_sb#r{ztl@l+8OsSV`GBcjpX^?=ChTeY#-N?x3qeAZ6l-SieK0QwHWqcc=Oi|*4aNFmBJF4R}-|PIy>2xbjB`%ia=l1SEVgd znq^lK)FkNBU1w&^f<1qPGyQN71i+e^(wrWUe5&jsU82yA@|v%qaS&foj^Y&N`+1Mc z8%CPi)6_E?%wLq%am2JxVBKT=*S>G4#S-B;1J__Pe%MqOUuoC;4JLy9O6|)2)12MB z*@+p`BtWu8 z8z)qc4n73Q@n}rzZEM%$gMkbv3ej4Zz3wI3Aeg2hxo+%;GH?b}91Nr0&io23aiyBI zD2a#hxcdDAlbZJH2=cg{Hi}1M-sbXo+?<7=v(R6CC;C%>Q{=5SrbaOnR0xkcXXNU?g~ownQi!> zaPVR1(^%atg=k?gaR5fjltagg^(ehSG$3sjzM9Hgi~MqlSRWPql9Z)8gWBH$?yC0{3AE@<3MRr{ZYrOP zdE->trGojhRX6xNOO&;<8gZ!B@oUs^kfzLM(TtgdPaPWhfArQk-sHi>YIZRO3XD>b zb=nm6e#@{pIrtT+pS@AYF!;0W9q1FNxCNr}7*#jU9ErL=Y0~+Dz;;LRB7h;RUb6D! ze?W_=0e6l!al(+m^h#~V14g_PM9G(9V&e-%ls5$dHqt@)p_h>!AC1%?$Gm>)!n|41@(_x2Sc~rMirZ8$89jF!M;t|_aH`F#SvS3_ z2)G2qjQW*6R(qx4R=UN32c_UXFN-0_Y!0pPA-Hfse?zHCbjzlKNc-7WKOvwLy?vsW zwv2xQdD~?3VC1m@M*S;LRY*8u2cL%o6uy1mei<|p9wn2%{YTAsE*Wbtj_Hm5DIg-j zpbsCK-LEkBq@B%i(bX!GnzAw_>Xp#?_!X;8B&QOC)ZEGZl`D=;^tVKfiOPJu)$v}m zk$W-13KIn6uJmM8EO5cj>z@M8kRI0gy0h>rkiv^iz?ovlMMTqCt3yt`Usv|635Jut zfbK;(&5T#|xN0N-n;9tqUzLV&bdwPvfxUrw1=h4%c4roOkG_;^I{e=JuS{+mR16(q*ss?I-Ct#S%$)kU1sxt-%>KhuO`t6R*zKY{R z&SVHLnMpg5C;?LsKZJ+iPL`NPy)m{xG6VSkEf~xJg*OXn6z?K~DJX5Pc!XTjEKOlm z+m(sEPbx@qrNxD#_SiCy24J2KFQRa|f>HKLK!ihY1i1;P)>j6Wlz6k@QvJ4V_q@2A z(?BcE6Ff_ZS-_(9jFENT(i@38EtuY^xFM~NReiJ;P~syJ6OYqzZkss@XzHM2(Z^1? zK?}#9qo)_l8$&hTEJFMAxEP!D{b9)^HHVd@WQ#3v6!6cTUB=X@kSH2b&R%2<0!kit zc=X|8s8#r$9P5{j8otEjQ}>f=xbhU$cW>goA11n6D?vi$dep*&no*Q%(Pi@_=CwuQ zNXqs4kad%g<-wIDWawEzQ$ z`5yyr{3th+XeiZ5$hj_1qq>Mjy^z~MmfQcA%d&{_accn)_4dRUwuhxO?qp@20Bplo zl~cGOiYFa71R`8fm`p;2%Go_mLs6ZXMgPjOgbNVi_w8HUEpLmlB^T;pf1QGBaq_%b z86-ctaW$FsRd_s~7;S|2!od@DIN4p)ZU;4UQgjq&4)Qa?lGnd>NiJy!?7AfAS&ZpqU2xb^ zg-R$c10G$ zW^t3B)(FB`OJ};vMaJDM`(lo>*wK@IeV)d4wdwQ|#ecrDe8Ps=VUQ`e=aU72JH%rl z7;NHny1m-bK-dqrJMDGYaP)jxwN+9OM@Abhy-MlZEh$8I5INBv@bI}mBFa`YcXEWayc zPwA%p1mM_V_eM~A#04C5qi)%4aoMwRN?d>UwyF8;LQf9C8l|^chN68Tl^_4WJYflv z$xE8G>U&(J7)gV0>8hEuTVH_kybBky^INoo8qtbX-547iL671Q6v0~~fu?_XiKS`{ zT*;5R&npBpv-pjGo`VEL4W| zp-QUebPo8<6eJOme6N<3d47@*ZzQ@W^Osq!y)+6D6PCa9+;D4YoO$Dx0_OnWk|c9B zD+lmkj6WGIKM$`u$@LM}Ql%9LgG$15<42eN=-r+Xci1|Yu!uEt!Qi>9L+aRGI{{$m zo)J*idN;*8HZz;_P3mU6^pBL#_DbDKae!rY%A(dIAtX9l)&V{&FktbL^*h*=5UwH{ z`T9M|IUFSHd-%X?3hxMnc;z8p5(aBc$5g2?;tS41>g4mJ|H1dqc|W)Qn?qiv@0P_* z-e6Q~!E!Bjr1!LJpCd*IpjQ;Y<;TFfxc?n_ho*~NM16gjEAY_T+X(cq&VOjA{s{I2 zT`S8HcQ1qoBb5QtPBP##NEw*G5Kcg9r@FQ|%c_ei`GwSIa^=qiifU(dYYPQj`1N-9 z-OCFM-V=OBZ7X`8P&N=>JDP3WlO#nP7mp;y&Xfe_)KnZm<=M`-qq`XunDx z9ml3$P0p-3^*Qu}P3Wd1H3?eYQCXEm_`eTn2ojz*h-zmm+|F}W31UiB*p6JT%p-Jk0dJNZw7 zfR|)yR8qWg^B!7KrYxE+5Dq3wZ4>xRihV86o4u!swq)HKib|X7e;R|yxkU`!1JFX9 zTK@ryf0g(*Nn^~{Zn-u=N&awL4q8#@k{_Gf!Zio`J(=JywX*R}PyOxrLZbXFwl~s8 zL1G`2u(_Vv@xee&GnY1s$E$3Dum)ei47I)wqKn0CdB%QBzLQf%=pXwYFU~mJvFbKh#9Do`?2nz?Oi=`rUefSz%JfDX6!#dvK-}0=swMb@`Am8g?7oEHlC<# z1jmw(&Wt{#zx9EaGET<<`hS>A76E2;IS0qh?dP^*_S4qZ|G1fY86zN!&T55TObCKa zm;5x3w!sWR9BS*Q)7%a_bQ(6=@z5qYH6A5h`%mwy#`_oY@bgHRpRckDI|?<^lrZpX zqRVAeo>}BbsdfqKvG$Y>P@2J=B}V+v-_6yBVioZ^RWnsPvc6kOfBOr`bh~E(kGU-C zCQRWvA@8rD0U`9q<8ck#`{-eNHiQ-Ic?rq$C#Y95Zw$-wR1n?u$Ys07)Ig3#EM2jY zoVJZEw_>kTPh^hjOduJY*52CsTH4e8!F!U-`bMAlG)t2#Z{D;jZ71$_mi(=BqS0s6 zfQgyN4jP&N2f~&>^2ck0AUn#Mw_{D zC2FCmklk&K2G+>T2^w4d*hs|PdHI=2h=*?|KyFgT++Bfvr-$`@ZQ}i@EA5jwjIy#) zvroLRyJAiVQ$)L0J&kvj&;HXQxqyQ4Kq{uz7$v;konA6e1Nt$Fr;cO{GGJT|p$Ch4 zLg-2eLT>XQMyD-<#;R76iKF5~H)_F=O`WBF>|dqE?ePdzy`xs+P)ZB9*s0Ew?w1+F z*L+1$OLv3LJAwqF&>0cky?0O^A$hQUGO+G9XS62%lBry!AZcGwP_isl0~Hk6?S$`@ zS4^F7ffs%ru9H-r`J$4g`F-rNs3-(o5p!Pxf=X+UtoeKiejD(sGAlrkpDHubq&K-{ zG*>N8LpQJLY?$LNH0h^p-w>hA1f8{#$c*Ss%%*7nfp#M7-o^3IB!sTt^wDdcRZ}h` zFy9z+8cxbkX1^bbGwd*l_+@Bu=Ob!(ECH!5Y;Ub2GmeDUbWZ~c`95i(%Cw=r<5_DWPKH%sRu2jcF^2^yqcMp!J9BI|M*U4ON=t8UTc-{{;A0jpxf+I!dJ{|}?sl4Wd15_WS} zl$Os9!*Hqp65j6~V4`u#Hp%}l$e8|(n;AbE4hI9t)g6XH!Mo7HV)f87a@?lR z4RA<&f#5Z*)b_tOZ$W^S1611BSN%o~u+jDXhF2IQQn)(Cc_C0vF-`#^wE8iy$MKh% z3#OVj_#zy}b;Mg7%b01;l@1$@(X*nOK|mD2=)ach&2vn`*c%o#%-Wh_KS_d9#{)as z@HR8l&W@1`rcR|i>%dm8z=AIH+$Nk@MZj0oPf=^CIKph1@1nlUDhbgTB)=OzlkQ#i z6nZYPR!jo!eeRSC^bQu((vWb-l!l(r5j5(@PE43+2k;5pd&mjKe!H`FKF@^#S2c|S z-|nC*i(ZzuElD>6K(6)+QRJXhNSk8&#gZ2&FSfEgQST9rPL+|56=2!>l$rJV!pJlWu7j1TwIt~C zwA5zhaOP21uoJGJ-3_Uv*i$!)_|qS^9xOJK{zxCjaah1fQ~ZO?gxPc!W!)Su_(`iD zI4n%#Wo_7;7M(y#KYwK`4`>K_n#L>-)ui`SOG_5XV*?&o{UhldHn)GlfFB#)Q;a|o zALHXV6>G>XW&ix8XYm6#qB_YANzSTj>Te*>+GU$HH)`@NRLU9r+`9WB1?ido1#P&Osz z#SLB2Q*q^D|99G0+jZHd8`5)eKV3WWxb~4YsJ@v&wnDg}mn{sbN(_*panN8}L_-+8 zmF#<&K5`5ke{#vLP-aAE-_%@fTM&|MZUl}`z>8EfxW2j&;k373kMi8!Z`Oj(pG_2# z0>%@AqvfA^akou;VBUQFKM5!`2fj8Yt~+4=?Bu6RIupKq@&Qyw@*pPd-Z0uo%Djr} zv69UvXt74aicuIHbXQ@N#7NM`UzbpZp4pc*F13Z?I-7^&fGeG1(0!*K?E z94SSy4ph}t<(m;${T}_^3mRs+FtciIMcF;$?tB+Y@N^7Lt=?&o8py&t>JSWRS zpP{3-m+)Lc@XVldG_tm8QqDe{U2olaM(={mAm*0`K_6_v{?1=-SWO$@Cwb3CIeTRW z{$E)CadhO5#DQ1C{|jq(h@ExkhH${$>wX$tX68^l(KGcL(7$cSH(-8&4`2l$;-+UP zSmyLWsA;fd6S7ny=n^t~XF~)Up&(fmki+L1E0HMp_dSS&H-n8{t{%#TWG~>!1hgOp zLLm@H``yr43RJe`q<>Qc`%w(vCSQDw6&7fd>oGUSO^oTaTz}y-MHChV@No$bOb>Xw z0m!fT;Ke%O#miV8UnH~-Kp+9mI78Ro`z-P;EwN^NV=P(|K7tCYr7hM^iJO5+ zwGx=lC_1B6bbgvxM_2gLEBpw~ZKd3UC6l0p(F$W^X#k%bbNwpyv)%}NG8oWtS++@I z+J6nwjaF?M*)K{Pt1fBLOuze&|Br6a;CUf3(+ueC6tl9q{|FAG#0SFk2>8RBokJ@z#Y9vW}!`%VtfK&$x&&7Q52!(5uMb5${c z>+anhOE7<0!ECrx#ffp(SOcGGb+)jfX5DaSqR zQJ_e#&K}t#Bv!s+wtP@L64RBD?aHU&u=tLd0RKLF+O#&nUS0MbZeNnD7o(}tx7`d# zIlJHisCO8gytR!Qu=Sa50dlT&efdD;vQjy4iof&hDx$v-9Pg9pky%6ONN3;9=gG^7S5&yAszOY51%shf&SCEOs&|l8 z5fZ78UwU(zpVM=O&ng}`0;F}%H?})_u*fgwx9q1*YGx5cCq7Yo5?7)Kr1+i-e=lYF z-TlhAe85JnJnxjSN-(=zv1|##IH^0(Zf_uf!)L``|GLtI9=qO(s3pKi$J)aLpbclj z$A+MqHzB@Jc)s)Ym%b$qL`Qd|4&x^UEZFKh8T|5#JHF$0n0#3_@b2Pm>;a2t2Y2FB zWIU`jECNW};!PO0c^`Deb&;B$5qd(Vf&ugladdSG6Nk~p?pbFZYSnZIsy(`fzg=^N zW6YLY4%w&UfKR^#b8zKvs@3PxA4P`acK_AJ<)ggEM5X{)uscy~AlnWb*ob;4wghHpyB4b~BQb zq3*9JRQnZK5Bu8p_M+9PG$dS*92Pa@{p_o*bkHyhQ( zw1N11j=J~?#tw|EDfjm?KsGB4H*fihL@Lv9(D@IN(LeSmeA-Ysj)B)*)6_13-=YLC z1}s%|Xvq?FrT>6PQ7=SWc;;e?{Yq(U*(RH2x7^8(*euA|EyGLjM|WUf6CGHFX*8DA zqf$4;3t=%-aN^Z&eX4>W86qD%l$C8ey3 zPMY+jt1ryZyMLWUuyh4_jji40W>b*O=%L+H92`e5NdOz`TB&1OF2B47JKFCu);BWs zGf?3Jw@#>_I$tVWI(GF#H+F)xG16}O59Au*r|`=oP4jLUbL-FfZ&PJ7<&^Wpa@w$A z!PYG^e@4cd$k^(YD9$HiZ&IaxzI^WGN!=^|{p4tF(;kCzm&nLvXe}72@9zCO=pArx zXM^TUQ@aAa^wywzNHxn}(i%gLV6a^%%IxO))?cH+UlWf$|DBd;3l*Z{W*OX~>WhZ) zqYVt6%mR>^=laVt4UNVq42z74dI+KxR^5ol7REd2{kG?OpaW8v0VXCJPb5V^K+GDk zdGVbS@!})2RX$YCrGa{>WwRSHs&*-NJ&2zRmzKdq*XVb6;%lDbN445G!)r3u%LiDI zv+bz>Sjkh2`C&N#xgyRs3kydx3xCR0L~>a2c0r`0TMEEtg-NZf&!9B}{}jD3Ii&$* z_2%o!{J$vgbQ@qZpGQ4yE-;&k!p{hMs?T*>4z4}_jA+Er_XVT56+5f7e}diA#JQ=qPz{G*~a@XetjRNWeyB@WHF;yOoo6+^1=}DY64&tzGMz;I9CH z^>Arjs?bh_H?r`I z_|W5fQ9j%aeU;MNnmNRFJ7V}o0YpBGEYBxDq7v1qu`iH2>Ke;o_+zC0%9`a=2;R_E z+9bA32n%oUz(e;f$UduwNv9-&xj2jQ#k?`+S&sG)3UJ>~t=V16snne?q5z7Ej~%TLWTDAu-LacHF5ifK{K3)K(ht~y4SeJfCX!iJ1sevphVw(%M=&Ni=O(Z-)O*_vU1!W ztjZTfePt%z&~e9-+s}95rxglbb{@@M#!x&~4xz>j1WWhyE~IM?P~Dxd1fl3iJrOCU zl}qw-%FS&`1JzJ+C8+1~yF-SJ#k$S}gF4Ok^rUc>1)#(J*_~z=Ob#j*6*#N4@to(Y zf0&HFl4pz=y9%ineia0(0Q?RiVz^H(kdrRffA3>Oik?`@XiK<7*i|v#EpYP6fp(`QI1qoPo;WE54fz%~y<(!5+UgAt*-kHi%2WvHCB zf+S2=G0A{DAb-t5NGN0E8kr6E96SA4m9qpoePmoJVSjSR*wBp89?0q!1h3TR|5?s; zRl5a&yvRvqAu%K^u092e2Xq*Bv9;z4uPnHJ{Ds1y#j25Ue@tr_)Og&wy8gOS^QSz$ z*{x*Y0hy0k(Uu*Wt{t1;AM0>W&2%K(MR)c~q%FHqo&Z*J61t4{>(Ik1`^ZB?3$T(W zupKQIf1O&4rI07P}tz75P_E#pJ(PsTA4zq|Hos=%TdAdco6bs9R#7b{4GE6z<+hW4kMyTRlfU{)Jy> zk=rzX8F5O`0(B*n1PH-<68Dxs5-YDMDtnUw6KQQlCXU8icCPS`>@3ngLC!iXNr7Oh zVorMs!P5OP%F!M7;fKM^?-bNG^OA(V-Y9hmGe#gkyc(FM*~hNuo?8=4rKVWbrs-zn^eSLahV~yQq^ch>o#@Pz@fox_|}&1t0o#Qz?H? z$I?k-1oev?y@=Om$1Zh8#%l>xV!M9pd&vPwLFj{4(n z>!aXQ)*ABZ{tQ>1vyq6V`W~E^b%g+|2IHCrBUU-KbH+bN(dzdC zUshENu%ZE_E*hfI)bM(3QpaE_o%}LPs|U98bZj|>Bm1EK?gah+I#o8cgOdk9j%IH( z*vvXRM?Itq-Kh&=dp9GIOmD42kLs62VgH5f!vfXvLjRO)+h3!#5neRCX2LMWk8E;X_WIDQv;L_=yvMZHwq-;xhs!aPvefMkX2T+p&9szo zsZX}rUX9{@!)eu5#t^}ZM*&6udv>@ETvK5Qmjyv>1Xg%cu2=~dwo`jTj<!9H)4!rYHRClcb$}&Dp9%3RE9&itr%ZeK%Vb zMzg^Y+ic>19;GK8`gB0PohSowpXq2Bt)Z0j*v@~F35@+add=O$G)|tEn?9`p=vUA6 zb|FlgvJC|83P&9|JcMgnB1-WP^z6^K0vD{m2{nZ)P;QUUmC@d7e&4Z(FsB{l*}%Wu z?lOS@;tcE*u0lUn%kNM7o-e^n+{ui@dpC)WV_**E`(hy6orF5f@(hBr#y>|p`*!| z_BIMFJKOA!p@f8CRj?`k){N$v55wm1_6%N|ja^xf>NJPq#crE-weuP?OUT0{q^lQ! zmPRfHx=M1=kXIBgEV5ws<>CYd;!8q)^f%cXhS@4VBDb~S1*O0i1ScW4qUC1bc;!j0 zoP>w=Zm;-2YMQ7bFG}Ooeuqno?ld^j;tQ*uc?8PR&DuV{s%S?P5%=Z zs-~)asxa3Vci@y%(pcquB8I&QW0&XcpWPKX(TU3 z_UIeJ+%b}2NI2irW_h;TyqfjcLvnKTG}l(s+NQy`K-|Iwiici0*mf2@=eI)SxDeD<;q(q{4UR+GdOgq(R?&5@;|{} z@mvGZu6Xdt9a1nkV(6%0^w4PFEyN%`;39zK-Xq);&E1CJH{fCtuYu^$xcRgye;bgu zKZVxpG~+?hA&><310J0TfLB-$;ZcMR`FN7VdTz`|aT;a4m|Q>tSGYe-#<_Z^NDA|M zq4;(H9eGtzWqW7;-id)ACjr!w|2oT0eys}`%U(=sRlz33J^j(=ij2u2L>vN^(wy+g zvxF)Y3El{{uYZGOV2R0>C6qEs%4!d^ZKrC%j%WMZ)k=yT42Oe=sOe^g)cP`&m$`iu z65Z@x#UhYjHQmXV1B55qS`UnlIWm+)Ru)lx2}iTGnSF(nwo*C_!Z!Y6d*t6BRPQNG z-f1TN4jy`_49fcZPH?&7CNOW@-tU-y_?r@2ci&U zomfkoO+QNJG`rL9rIAf&p31|(rv{!1%x-K}KljQKx+|Qrd#{oESa-);CQZRjGEQ?Q z{?{3hEq{D>f@zUs5_PPus_%1T6aC-|5krA0ZhJLsbPc4h<*30^S>qzbgp*TzO^jcd zVfbSZ5#sTNd^Ou&TDY_z^BK=Vy=5&2r6wO<0Y|} zfU$|N>-1t9ihEH>S1+J7bO+|4MoS5=#eY=XN*g6#V#P4e;l9Z8YlaW#bPGA9!WfSu zmJAY;eRK4J6{Q#Ac>b-?z-TFYx-&=>Qmvgx!vTU(kT^@fCJ-re4E#VBpR8pgo=TEWrD$|O z)he0%%KT8E4#r7g3lk@mP?M60%SNph{LZ?ilHIcPFNU~*8P)OquhhBe!1B;>c>BLi z34&*pp_tpYjLkB&|Nkp)$kpEoNExQjgg2F2$+DI zhsnpixm!ohYHm=k@7@&yctIJAP@v8Ywf@@lch?UR*4oB&iG6~%C8^BVV z1Q!W$dKwFjTHnd>qf*H~9MzQ56Qn){HNyJA-zQ9q`#2x`+vGwU77_ zer=3j???VsY*+P_#H&z}l$+J}-%m1HUO68)oPJXL;;8k5n~3|>}L$kzzw zKr4d>%Ltd80BL#W<_K#8C~?AC8Zga!7Y~UkB+_h4_Cy`}4l`W4UG_cpO2`yO-#Kep zXSDw3itrYI1Fz$~Mx~Pr)*akqs*Skc0<)Jvm!=Ri4!@Mg!lm?Grfn2&Rquw6gY=4f z!&`e2(L3a~9CSbQF3cQ0HR_iDoZj35zt)F3KRnNk+gFNsF?<{C!+jmbZICz#-tb3( z3bZ=rmT?To3j|Dc8X++V7!b6bLE2b^^v~~$#vdDm0pHO@_BsZV0#e{+Jg>htcbz7^ zh<~omCcu6_%#Rzs5YzPTe3Het6q}T)Wj>UiXSIYY*EZ1VIs}>8!Nx*_4f`N}E~)EU zr4q4%4AwmVUe8=rf-L0eK7O)*=>fB7;Wy3PRJ(Q$6q8gH)s>Qfdsv6)wd8{eu|wzY zRm`%U*tMAfsz9H>tp8sS0xO8U?`dSzUR*_pY_*P8Opn{pe`UY|9$juz=guHzvo~ff zGgbjj4+>0;OVXXE3rCR;yOjSZ$zBs5p}W4ha1<-td(U=iS{fmiO?|j1<6tetpng|x zoK3dZmXH{E_`J=FaCI6?zvY{JqEq^DcGqBLl9d47l_kS(oFp~U`E@sliq|vDQ3fvv zjWCmoJT9kpt7$#lAS}@zeqO>-rCQP91RNr=lhF)){sLTU zn9&D2u|A}W#?__2qGd<&*liB9!Flk634N4cA5rsEXpkp7E@jFB2HcirhV)(Bk zmidLuG+uEvB);Lh_e`fYC7!pW%aCpwqOEq2Jy>R2b5~i&@oS7;R?>iMz`ye6>Jmdc zTZ`25T;Me$dsb*Gn~^X*n^obxV7#%g?)32Ayxa``2SfrYsUm#JF;^^p<%7ccIADPi zx-+DNhvuy=+LHHPo3N-mky)Wak$)K3V2iKfS}uc(IIP0DKQ~Ufs>QlSi6> zniDnxoWSZC{RTu2jigrs@Z!{p~&Z-iFgKC4ME2C5go5iWh&xqx#0*T&Cr% zFttsM6(d@=jRT2BS7I0sYr)_?vqVdY%V*vgyAAQR*%VeELX4jD!N=O$n)|P}I(;e%p=5NAtr(a{V3DWySu$hHOL? zHde-=!h2tWS!Pu}A@6=)aE~~DIGcC{v)VfO1aV=I!|fDr-}jtqWH#!|5fOlUbE~s` zExZl_VZWd&!&c;jPL7wbMUbAOM?%udHdDr&&hh{nf?_1+s|u%w)kffwklm~5VmLn7 z)Y{!~qpm|1T_P}E)Ee$0H7w-}$p`>D3_z^&-Iciu_T#R3A7QP~MH)Vluh`$Q{+S{zbdhF0|aPuPjw%pWw0RaKU;kiupD3wSoB zdekW4XWUk0MsTXi=%;Q|ezDi>TmeY4QdO~-6rp)ljCLAmvRfM1)*O)X$&FAKHoE@W zb^E9;Y6^*NXr>S&mSIp5Bl^kj72({lEPD3t`89SeN{Yv2(bE7{Rt*x%na7A9*ZYh= zxhUgdTyxPxeg&Khs?s|MT@=T4jFI zahndG+g7VIGd6Z!SoxsBWFZU-G%W?-^`h*_ZC}OLpy*MByDbT6Jrfe2_NF?OFNAX` z`>Sr21kNXkZjGAUd)au8xmoHPU+1->RpEyf6`+#VH&))n>eLG`1})6G+Z8%3^57@R z3jLKj8AZ3x(dXQ0fe|k`;m>?EIg@(-q0C?N_@S&x^Yio*HSM6`NWqI3br7aK6DBsQ zM;KZo&g(S8FhS7<0}g0qy5yQgU1|BaqnvSB;+#Vb?iA)3F6yL}hd7S<$U`q`LA!iZ z8$1v0UWJ!7C?}N5i1o8@RSlb=o24k=wey1q@lX|@4&SaNS3sri0FiwBu0bZeazo(j zBbv{-FO}efiU9xb^=NdW1Q)Amc*-Z0gew%4u6o&Qw~uS0ZPZ+Kn-Z_~!4IS8OE%SE zjbI5T^v;${-srZ!xUz%v)u8#)PFHWZ1?|)CVKt<7+gx_Fx2~$g-rtoCnWCNCHp+?G z067I>q$yM4T4XhmBktke7lE+(IF$6}w>#A{YNUQQGJYaSHMw-QZMc(7x^J@-eolzT z6p;~b5lIa6-fcew%gU#4AP!Emz(;RcN60m{XY$MMd6G^f2G+%|bM5|Z)ZCQeRogoS zMD6JH`cj3DP5jWTJKH|*m|9R}*IdxM@QC~sflyEAcu$Z&9E1y9Prbr06c_m>at7H~ zz`yUrQgtWRxVC}GeW93uq4+?v6vsSQ z$_)j0x_Geykn>TVU^@YfE>5y4vn(j3&j@-Y@q15^m-m=gk3X2{c-xotEGu(L!n**PgAY;w{L z;e+M6*)C9|%pj{*rVrI-9w56&ymD0iTmSkQSZ>|dBNNw&V0o%;DDvjK5LiBK{DhTr zT@5sHJ|iVY`GXT-nuB2fey~5J+imCb=JXCljzk8nT8EHe)$N3Yw!R$ za2qlrxicb(y?&xJ9y=Q_WC-cNK>ni?JF%}G?k6P^I|2OFeZ^B&5B++XpaR<3Clbbo zG5Bg|FdVB*Tw5Y``0U9>3*YGI5?pt+a?*CQPS|puMX%6P$rayU#QhnQK)&6IBP3AM zd&`0$luYafJNr5~zjw^`CRi!Qf03QEA zpHgI$L|gzrK)}B%{{R48CJEG&I3+|aCW2=MC`BHmB2AI1T+^~q*4v6z6IWXtB>)x^ zJ=(HyA+P!R%Uk|Y01UQ=43|ScKxwHko7?dhLv*g_q_3pEYm{*e79q-dC%p2LI&uI4 z>USS^jdMs-Y{q@-?<(zt5h4IE_|vg>B+~@%pEr!|Q<8mOpES&sdA-R*6!$5WY&y2$ z9M~@C*LN^2;1pny$my_l?78oV$-G7Zpn1KEdhIw{O0wyo>B@)piEp0n7jlgluCCA5 z{+oYhik3#+(8{y<)$?sqIZc^2EKt1;1-8vw7H2v$!V1~X2%Gj^KH9GPAn3NQrdf!!y`#Movt_i?!L9#sVYj$EnZ>-Lb9w<;kAyyQ;@%H zNaG+6e3KpWcnm!OVDsVSNM=MT6{R2ga9`~`s+`CkhlHTgBldn>4?u~yA-jzPWg8nF zM&`Tx8D$91>qLs-H@^4yhZ_5txWsvf2KTal>Z7>Y+MDHVF z+LYP@w;9zYlV=FFBDwnH_&kxoGlsc+2&5Sn^)E-|IWeB)}DIBPKmN}PG96`z?g z2>~=pYtC`0$FUG0D{~5!^KEWNu{;~#gi>p0vtsSjcU(%kq~J+MDd|6jly>W+JKHV~ zdxw%EQRCiCX@{@**6m=+4JmKph)BGRT0QSWk>j_S3vQz9m@`MD*_qf_qzWom=?&sP zU}Q+9<8=kzt2`BqRC;aueU1P8iGy1B8n_F8KXKO9xxGI_-|VSfNe>GUx_Es0bJ^b| zld+@wzY@Ij!B3uahOXZQhALKcY=8wATGb&lM~k(VeX0R;Qi?ghm&a^=mD~k&Cgn{? zKLV7SX1Cdz-suODS28CIiwNQEJ5c&)d+sThJ-UIzKY-meh=2SnSoL4&7Y z2YYhTjrfP8!yh8!0mj@XCPsq!f8x92l@|*VE_r-E`k0qKO%7IiTYK3-lMb%GtV(r1 zFr7F~C`Ih*2qb~SmC1!Q9r3?Ia+Ua##XcIh8C-d~-_O6%Hm+e?t|s71 zJOmf>L5pn9PkrZmc)NQ*dE$ihoTr^!ha?T3+T9vhRSEk8%h=!6&=GgYt8SaMlBt6v z7uX!m;K>%Uxde(_@wzWza5rvtoK^HfMZfg+c|T=#103=> zVz=V$7=A76_!-5i2sqjSrP$Flj#LWPwA4VI z2b(dL!SM>%79_l5Z#CS$FT~~hurr7mSlr@Ht{KZ+2>wVEtvvUW@<^z-Z(3!zR5!Z zFX{9E-e>Ule1X|hP=1tz+&=1^wmj}S`&{yXKf#ox^7ja$fmObp07SCuF}Y@RY8-yD z_15`&ao5*_0nIXT={U(zE1z_is|W2oRb~KB@T=JYc{>iXE{8;)*ubp(%5Wl6A>*3$ zUT>XLI$LAPvF+PC{-QC)%ot_Ffja4CMUJ(97#=_GCIy;6+)_&~5baIQXrzCJ>*Yru z0nMJ>JShgpe)-LrrU@&KXpIU3(8b8S=Bet45N2kn2)f2^m1c~O&+C{Z$hvp;BYdjO zYIY(fX=6W99%l!{mSv(3BQh`aM>?hz(U&>SAHBpazB52-d1!cK8eqpyPW!dUY?t`j zci-mwh_O90ZSg%G+b}@&-OVkv_!I}7dy^ZCa;+IK<+U-Wu_0hDD6U}{RcC;Fc<>(U z4vgy$C-Ni(0vqJ3lS--TW>?j!7&4gX6z(&Bp6*EUPBv=q0(xBDmeC~6MuFFHlfjLh zqp%c?P?nE$=4fV@sYbSs?+1F3@kCK9kVsR#Im=~Asy}`w(TtR@+83WR!+74Pf`IC# zD~ytM{gEZc8OFpLR(q9O+$x$zM-*ZeU8Cv${v9B8A9MwGFVUPJp!`2Cdg9K+QtIgGBuM!a4h z4*icFHi{Tub^=Y!i8X3IibY#;CJ_;AIkZvaR9|>u@9~tXOn2qlx2l0e9zx+j zv^*MVg@uIrt7F{F-}7ZCeTEyYoOAvj5E6bPm=`ZPpBS|V47AH>8CR1PG2BA|$$;21 zB*b9Rv=z}2k;dW6xxCw@D(Csj{hEB3Mn)+-?Nb@*(a74F4N9gUwMT6^Wdi3@_bTG$ zm=+#iJBQxl5+_2R__d{Ib#qxyTiki6GT+v1{P%2a+l!@@Y>iKoET&g)HY3KoxpQl@ zg2@sfeWZH~Gsgc4doGoUxq~R~Q=@ax4P3KWFn>`d!;p0>wNn2Wd#*_03O>en*2&|2 z-}w7Np!lWDDuAopVnn+|?A@kNX`)&-{=?8THrP}1*DJu?3t;q+t>&A(=h+XQ3MKgG zmpa;xk5iZA4TL@svE=*0f$E=QkMkH7a;z?V_33u)2V}m4e%8F1Xm4au3HW^3?9B^-&TCo1bMgi|3U7cCWEuJa}yceIDe} z0e@@1&Z$ zJXt?Q?Cdnc(Dm+nvdh={fs&W}f^^vLXV4uAih=ZYUjKH{ffjZ4uXti~odcLnVy768 zk+rb18Z$#?^&hDl#+pvpe?p$0Fo>vxj!Ul1X^??dturhQG*~q&o<&Tu#OzSMA)DbN zjlz3AyQ7XLEj3-;#EwIap3SDQw=&IAg$=>^B#(x6zze^19%kKVX(m9R^jj!ynR$^- zwYO6x)GAo*f2*BROfbni3<~T9!5&QBB-LkMi|}LI1;^a7?R<5ktrBZ$4&bBA^fYM z^t0%dVF#G!X`pgj&-&W~*nT1fyA{Lr*dK|cD^rYPAj?){Kh8^#Xo^Xmt~i_Vp(@j( zmGs;sVl%&#(T_>i>P8+etA*NnC0lxibUA2Grw;_+1Inhn%?M%=rU};!85uQ@#l87f zC`c~{(xVv%7uC3@or!2CF6(-`CyZw~D&AsojA_GAD9rwcJ>akE4_3V+mHQeajEto% zpdi;04Ugf-uy#ss5gfC^43+X>;^Gz|AzQ#Zf z^NOgW%UW#C6_&5I5<|mMe^|8SPM(8n4YB9ob(R;NGG8N5qyl%kjvgGZ^9Zj-XUPq1 zZrE$M@I8@F#>ocET$<9b(4qw3KH^n{x{13()=&0Xg5)?`)76N$fjL|(MHP*^@z$3% z1l2S#euaCfcCz%!d`bNCpNyG}y|gB_e;zMDfl=KrFn9)FaK@WSw9Yy3TS}5yVYmkU z8()SjZY8*c%-494LlpKlCr?*{t$JPQ=>ae107|M*TR3Q5<{}21jQNW8<=~PFSfDUk zn@&BM#B&V~(L*@g=bMNc{W1jA2qJ{MjY9<%gaZxTOZn9C28w#8dV$#GzIWO+8gLA8 zX9ltyZwHX=ujb}%C@57D7`4ZsVSz1WdYsZ++L7l!#L7al=k$5y4F^yXJD|I!{w-fR zVsb;0T;VTy0evDSA1}hb9yonA>HY@g?tV@-V048mWKH}(%+$x;JQXH|lFIVH;9a5* zjk?vu^)iXDjlCw-B{+nE#{}!44o2OjMbDFhU(0T~H`o05?P-r6tR^Y8Q4y|+elsD8=luz)wC%#lWs(?8|b$ckIv$O=5V+DH7)d(|6`_6sA*mu1^bwJ8t{ysQlYdjR5-<1_w%Kh}3yJ_QbZsbv;X zGHlSd?m}5VdB3c_KnZjsChPCzvHWlyFsw#qnnaJ9Ev&E?{3c8vggK&q0ji1CU6uoq z4t3=5?HhOg8uFGbr&7^qHj89yzM`oX)Nyz@1Me<#$j;bVW#q00#2;h|wjr#YRv?TX zPn{Rm&$8gL<-wER{>rHT#)y7S)D!;jx=+a5Y;QJ_tsb{fycJFjig!TNo-gak9;TZ^ zgxO1rHF_8GV{yxkFiioezlgRn8;i`c?2P*0ZorfA7)bTitvF>{nqvIjvB=vC ziQnvXgE&UrGcU;LsEJw8O^$gW9ig*zVga2*zS!7w+pz~6Px@qLeE>Az=6=Zy-zBRn zAAb+o+Opw=&v7QJE+W-OG^6#0cswF6t#dbCshvuJDal zW~7uawS^*Uw+Ds*Nwp6;CF=)=AO>qvS@bkx>Jwr@xY^x=#1`V?!ve2qY~J-rr!lL- zEa9n}k3uLz>kx3E<)WU%D*NH~S`}cNqOc-jYq)*d%}~=?w>(=95BQyHVUH*5Y|-s@ zGH5gNG}scgRe2o!+xqkwz$rbRJLtS}s2W)}RW<4olbN6S^3AF8S2$u_7{q-a8=3Zv zt#W-`jR}x!rEoO3GD{O4(h-+E1b?A{9Bob{-f4Wc?GPM96vj|i?VS6+^P{XmDSIL& zJytodZ5M@F)N$Uoo+gaxe)>n|#ognsw$+CI(8C&j>Qf!c159+-hcTuF zyJg);sl2U}Z_$rh$8nF)a0_BWVYv)@wZ_bNLe%qt_M=DgO&ktK2QMlU;w=C`p7?3U zWnErnBcV@rT5$XHfYT}ZB0s9`(74+J1aEivr1^PkhfjBxllPwW8*X~XE^-EpT6jiW z(%ulVn}fm>1n}I0GADbAuNZs`=N4Piiuk0x)VEpcN2igs2VT{4k=e%Nk1F7bS=GsAf^>@m8hU5QIS%J^8cwG8a$l8yB^kt zg#kN1K|_La9S#G__%V9B_hl@mfge|EkHN#IFgPg~0)m@7JV(4gVtXyn$I@zP!+VIQ zE$1KKDoPTrh<$`ATB1AbT<}fVXwO9<(-}p22fsm7h)yolKc@-jrVG(AXr3RpMV@AA zg=ch@&g8GP;j*N^K4Lueo7REa2w<^d{ez zU>u@69?CfbP)|o_N)K$EMHR(8Xt&cS17!&>pOIyh_=tpJQqrGSY1E9G(#yy;{Q8S1 zJS%^U=5Uy83wfYke43V2x0P{U}NDa1jKLx3?VKGYzCN*lm5i!R}>K z*IM@Ad7#9Y^{e8@9<$1D2ai2jg*=t>%t{xEJ2I2vG<)^}_l?bY~GT%G`1*R6$gh`t{khl=PYuNvOk z;7o$)%E56dW6^*)8Yl^&CJDOqh`*#vx}6BEbB(_BpPfsg0zvtxedG1++K;o5Bxuil zvnEEbCGQ$>u`EhQ*sTR}K97I@kr75v+E*OC#~Ha(lSpfuK&@P`Q4r29)ezUkMD%kc`m)`R@HvZYuuJUNm0U=r5}w z%sl}vT1!^lDQNbP8B+Js<`aq^g*DYf?uwq#pe3hl#^L5||dpY@Q7o14G~w z9;nICJK%2sEC#=v)5LgPPS^wR`6wXKd@=X^=ZPvrp$VGYw3(@x5y<7&O<)I>^on_R zBQXO<-{PM02^3>}*;eH9y%)eL*y&4s)S$DC=Xcm$)Ib7r>su|yf87j|mA03QK+YHt z>Il+#DY1p469(dk}28a8|B#(`jSvqopb|6QOG>i3%F0WAVB*=%Tr z+#yn93M3!e5TOlR6(td8m)QR@qRpcE{D?b4hB|Fj74mOZy$9Mm5{GZ+Gy-E=S>F4H z^0^-*Q&aST+zUDd**phghkFlzw`C~l7>V)8aO|K)#Dz}S0qfe*jQ4Ks0oae^N-^T^ak|pN=-la3 zq@+9uIrKRs z{_;Cl%ipbBv*daKu`9MPtg1?BbaoweUfS?fKv?w3qQ&>|{~0ak!>!7$AGgq2dx7%( zxrG30DcZm}?=)2}L~nk?PzSfuX`>=X!~Yi-VOLHkQ$#H?&UGXp^-XPrw_N$UUvHFU z!Oh~Giz?DiME9jzh(j|F>Vwn&KdO8X?~L?Zv=7~~g0X&=faj2C@i`qf+c$WY=%S4P zJY0%`w}}U(g^-w|YrdN^c-TOD%gXm_N}yvKvIHTm2h;&S;Lx~Tf~+f(OR|%Rtzmf* zCN9k`;0r6n^uWa=p%ad{LOu2Hy!KW&hNlx|S4IXW)DOa2tK81Wl)8&jF&7HZ&}(`{ z;j()~2DaNj7de7`D@I}6lTt80KX#+^6MGvCqe$bHx?U&1`~N?29Ep8^iIDF{S==u8 zhD+rA*Q-ZAt0E~#d1c#GqCPcDuuL@`dClw_xMUI$7@kT8XQPdppQ$Kb!;o1!?AKIe zXIyRf85T2QWKWFJKH9(rp=uY~Tu|nA_39w1;+DyQv&j$S^S{9WWYzxgBUuo?ibH?u z2=*5@4~G*%?mmdqD>#f!d9AuJ66`)C6i6N_m~0p?!bF71ML^C4*EMKs-vpI~zpYMG z+B@0}S(plKYviJ%<9o{-zdXXOLwmyld>m32f`G)*9OH;=WGTWiJ;{m+++Y{ z^|c{0p#U_BXK_$7Yz<*>o?q!9RIDHGG_Y~UuRZ`<>t#EHLbgT1YW56lvxppi!e>M) z$r8XyKxcQ+4(k%IU=2DcA1SV6&00AfnLKukd=bxZwo)R~XqO+)hR_@X*4T}EnDQ=< zTn}sYaZW2UCN6MFlg5|OcKC+_Bx+f_j}E#QCkJ) z(&z&{7qjIL@%ywhM2#DF8#?mY=F3?Ww06QqfCcxho9IkmYS}@dB7qWbEAv~N7}2N- zk<~Oe?jskGAiXq1-Z7<}Az0wTf5bS-yxulTs8mEkh9*PFEpU!#drmzybFSdzH*)iT zuTWH%fmE|7tM6Wfpqj@Io47s)*v#rKxk1q3U% zdAve*%~cKK_q0|OR2S(lx^qj@Dlfy$m__z_4r?TMDL9P8QQ^kWP9GX17Ui|n#$~L8 zEhsS*()%isBrI&IGkQY5vC{t>{Rrj*H!R@tvcWoaWA)nx54LndM-m1%mg0QxTwo!G zYabJW6zUUqtX9Ix%?=~?6v#+Oc`R>>s7-a_S$pJ%k`pI&8z4M$DvqqT z{Nn>~GI_u}Kbc4k+pb~%ANDqY!~7ghO&t1-elykW-ZdyJJj^xDhX`&>G==!*_d34^ zU>GE^ryIt6oMjxnqQuX>UOe#?_OPOtqN;Y-{`u}NTe0rhG@rxw!g>W)D5wqNPh!&ykW`jwJbOD8Bz<(fc4l?vUbCF0~ zTD6);nD}QBfWuGb-~74FeLyeTPl-bKA#-vN12?Qrf)SvC}fN^qaY#n*n>Yjy7T)l2t-5$2o_x zfB+fL=r-g41ng62Ds?`*v~nf2b>9@v?Hr%FNp~OysXtr)2hx8?(Nb3b==c#2D78oD zgVm>~r=Prgcx(VcTt$_8zcq04i0E0mPah^;?bTC9pa!Y-Dc)P}`+O=MX;FX~pk9Y1 zJ{9npBlf$fs#h{ej5e)Qt#HPXhTZEZUt{!QMFW=wgFVnt>CEM*?M(FjLR2l*tJy2d zLCV84^X5Gh3u5_fFW+H_=s!AoP}o{v;m*u?8zS*;ZtyOqt?5>-xciQPNf*~ej(H$x zDX*q~Qu+M@UiSb*j?5J!cdj`;Yc-SkcQB&Jt4r+aZE+JYY7x0>HVQAsI)Do#lRsH1 zZ+eJS;6N%y#4)cNQM!3LZbT>_^)~Uimbr}b*CX^Nv^D!vMTm$qHYMP$w@?OLpUtA? zFPo7-qaFXt@Kb60Gv9|F?wa!Bx`JY9=qwBqCs#CRoFLMQ(Bu32ReP?lzB5;%3V;`e$b~CK< z>qk;A7Q!FII1FU8^3BbluZ7VE?`qqqd#2K_=|`zUP>({)v_MH?fek&AkQiJTTtz}N zsuFVP8VVm4`-r}pe!LsL7MC-H^WYhy89;p@87+yxFFNvsZNoJG4Kp$c8L)?2w8{RP z-ay%d28p;5%VqCnR*n}^t-uQ!vI|xFkBJSJeY0Ys2csA#&I}@>-*eo*%L!IwDBKH3 zdztMaW%hu@)^UFVV(o#Nh)zR3DkuLy{jp}X6eCqLX^b?Ni<`@Xnff1GFa)s9c zi|1=zAmh@=P-gM%l-gq>JJViF08)#e)D%k2AeP{CSf zPpXPyL_k*;1|Th%@B=H_$(qjh2)gnc!}rpW&4nW{#@waV#R{>|qLkMXg5JJk2DKf~ zYE4|_bn+aF#k<5-SPFr^Xs0z+KoS42oV-jh{r*ZU)O`+$<(U7MA2#e{RlkdLE*`7p zm!w%6bEKuwjtF3g$*{8nBlbB8puwMearkxp2{HL`a#E9=cCM z1;H9CKQyMXbJ+itlDlRDCCysUGqLw4r9+`{ul9P3MsmBBn8`@{11OKDp0S|zC!3ro z>Q<(ZjO|Z2m9ga%LTv8v_V}BRHs*WvyBQXzL3Wq-D6WoKBPl|s7fFTE z|EfQ?k@^|6+dV45HM}cu&Jwb$X(y8rK%-o*cO*T{+9}zNo_S|} z$r|(7dVZjLAM25LHM`jS)9jp4Lp+DSs3npuF&@72xQq{{NhPjUNK%5Rwq z$BN?*0CXi_?=t~hyX22c3rUgsXC~sWT&Cf4m}NhAT>#J1{B1!(qqLRh7I(L82G*M8 z7zvuqO+h$N&QJFxK>}vrWtdivZZrf{g&KWi|)fs z))cZDU>4ygII)H$hxGj!5IPwq4n!@=D^N3NbZ4TX)T;j?BlW?exKAeZWvh1ca(|s1 z&RxB>9j8Y8a@z%gQgK3$HX6G7Qz5Hl{kBFzgkT+5PP=tf$n)>;mgw}so zz;Q)~!CayD%!H;&u;eD?TB$L;w2dZ|AskslL(^a1cv;vul1Q{Kb<2uE3T21<)hB!! zjizR-nR^Y(+~^PPg4Mn9#GpmyH`wCi<}t2#m7bypj3od67IxB%5epF1N#az~Y05{Q z?~Sr$v4m^&%9u$-Ly+I1w&ujZ7zTX@aWU5J>{Jlj%-8)0M;p~b{_GX~YjFFe z$>~faGBT|x-;cajrZ zL`+e$&adIdHVDc0167PFJ+*GmAKa}M>I{@#MS*D|TV>48Kw;ehAh)xwn$|^GHa!j1#XrpjI(furcfS229N3#Oo)T!Y7zVSYb z1+v?xrB-|?x`9Ej9cPm{Fs}1C>M%VY{YL*+D`BxMLcz;yMMp|!4cX!$q3+AX7TzSy z6I+I!NdQEjA%tKsw4q{GjDBJ*=BwXF-R^tkR2gw1UlNjwLeAI4Yo-nzVzZLC3bZF7{8ksY zvDGXySngdvuJ?YJ-|UisZ2*l6VTXv;b1O+2OLzfepN;ebaVrE=OTW%aeQAs)C2Ld~ zjGluL$sk0P6TXU&FHXp$eEre*v-cxv3P6aR4QI4ZX8oS?ROTF_<{nLAbu2&xXP>GCo8?u#+V z%z0tvw6y}JEs#`2dgpLr0-x{d*=po&(1U_wZ$R;RQ{r_x_sBqq>dZPhFJ8rTew z$d;4iR|0`0M=qi$=uUTx30is}IACi(qj5VR;Nnl-1UfZ~^>Y|x8xVe(*B75Z>{fGF zA8)J8#=|@RTr3hQASi?!#AA5vw_*u$H+A?Zcu@k}J`;5>!(FB|O0XB1yxHgYWBNi$ zG7d9Iqhr9&dl^4mk5lB9CCa>%H}r6my%I=&`@$;pQ2#joN}s=H33qc5inPdlBBriW zjngr5^H~s0MP3JPN#a1vI%0)!-qVR`zu6f4)4UH(CZ7H)mcuV;ip5}`@~g@>G0mRO zsrlO!e7G%8uQe}YLc*1&TDB3$EBDsWQM>zhtTO>JAr_u*R)*6S=fc;-lehQC{<7CZ zkBUkLRJk$uMNbeXkQ}G{tTV$_yoy@{U;-Kj7Q6gmGf3C&&?9g8CZYR4^!K(v=-nI_ zMA;=ewD=HA`q!ZQuLiZWOl&OAY z7F#-`PC+qfBi*3Ei<0xSJc>d+`Lyk4H-jCjk8MNr$lDaPxZk|&Aq4ihnI=F3;`RnK z*DhC*zxW$5oiR-S3J$gqra*ufoRfC)IkM;dF4+i2Mn!x-ba_CtLsZ8=)dtOqy&ihc=h)85$bIrB@-E4`T+?3J& z&f!f=c6fIaPCI7~^ocf$>xXVCEZ7RY76GkeX%cqoqWbcFrp5 zu|j(BNsag#y}N%Xg%}=^2_3<$EUnd|opHZmn92N8>MFMEyHZ1>5N%-WZ_{maK42B? z2DZL~(sc0O9icR#twA!p!&hYbmsM9zMrU8qxUZQEOuKF-o+9EteRzufARElXE6xb2D9pEw>AfoM75jA0R_ugx7$*X8u1BA4zaWD*;9=KtSEsc^6 zuvPCbTnRaj_RUKz1_J%_g0@>tk$>@z+{7NvT-Zoy>;FZ_*YNwYSj4Ofcc9Hl7#0ak zRqM~7zV&74bt6`*Z5De3sR3|uA1pL?RR9WU&}giqX8N$)o0&4dwITW*6`pAW+&Inx z?gO16o3&UulK+a%tOBZMnVSd7_M(@36{UQQvUD8sq-Jw#9$Qr#kY4qKD8dNFs8;>b zOENvz2NViC91i3n_Vvu0t_#eu)oA0d_{#&3*A38pW0nWQ^!f) zN0upGBIxSr)al8gvA0==&1`pu0?uLNJXENq`jMosBj3Z_A!YGx+Z7SLQSq@sSgqOg z*u@ZPur8(lNsXz9EaC(JSxK%63yxI~eoCl+*K&M$BI1vDRxngfc{F>v(q}CF#U1+DLvH4T^5ha9K*jl)9iq)U959Ba?h_OHDdh4EXX6xzuXKo*DrU5(mb+l!=| zFSaeX=-j;cUPr3LmtpqRS~EpNj3h?YtCKUXr5&rA{Tg+g*Hc`?UY3)CRxA-6b(=_4 zcWd#V_26E%_;SzN7h`*&@3zEJMZ$52xYO_bQ{P++ zMKo-zA6aKFUGs72!1Iyd9{>RAn^q49NK2ZX?|{LLMI4GIMiVgkp1+ShFE7AsXW{%b zxq{;;>s>Z%6}#m{EjHYC_>?_6_?O?ol)wG~FK0eT&AlnwR<&cLAPnr%08|O(KpVnT z2bX|L&@})aQcN5Zezp^nlD;W5RIh}3Rm{R}tqYN_!JfetO#J#C*|l34U|0hasd6Jx zN0z_5)r7U*XL-xWnA*aa{H{D;*wp)835irq_cgzVsN40x2z6CkKAd4BErsH`NivJ@ z+(Uk4)&>iMQVzS8Abx!)QU({P)mNN|TLM@iINF**~DJFsx~ zNgp)x=B4#z>X^rhUQmLhta1PfsTzd3(n91sZm`uC0ar6`c^r1q%=XSs^^YYl(%XY+ zcU)>hr~AUYcEHdk0V6)NOCcY}Juhwg^|ySlU3C?j5LVRm`XItY&hRfr2f1e~ud(2Z z3&Y=^29Esdi5Vrop|~?u!xQJAV*h(Yv}l@ALfJZ325b>qY9M8=NtXBW&J%htCIS45 zDb^6uz3kO!_0BLvNXMQ6ON7gsfHHu+OzLde6RX94uRFN&@2k3Sx!Zovl^Ck7jlJOR z4T3bPDgUfJU20Za5FS8kj&lY{S?y!&mKj?gWteQM(F*wUYO+?6^0Mc*FA<@k^+7bR z?_|pFW|x1w!Y2B3)MHDN&14le^*7avP#0UQp>H@6c}V8C`gZIMa+2k`%{bZ-c%1t0 zD+1j0Uk|osr*mUWN$MWvSBSKyITf%}b(Nkx?>oif3&O5T{fRmo2~E)WygF`E{6Ab2 zr_6t`+7X-Wgv$gqt1flt{5h#Hn2X*V1nbUVCsVxV(r1I5s1z+g01OrDn{|=e+E==E2}Q6VP?J0eLlCqUi*coWAIMk-*-GoYHsn_26VF?qal8rQ$y&dV4;bW6n^0)TgKac~+#rRpa*l17u(Y2TxagHsW6XwiIP zgXnuzHc0jRR@z{x4^n4gB28vyvL)$n4%FAh)O^Q--?0u!9mDDaU)Ksy%?kW_;XpuS zHB#^?A zDk2)`V<(v@&h%UA+6>)k5)imb(=7%FDt^4ev(Cb))lBQqQyObD^AkL&qZI)1R0sa= z_#8R$L!^H4hHCP<7-$F^Sbhyx{M3Hx919@vt*)3qr9RJrzpsKi(YfTK3)IQu&yiX- zE1BwO1x@!424EGby0h-ijIj2ENF+IMq;7um{FD!)by5x&h4q96XFvO6nQR+u{7%<7 z!uyiQXUd>DJM_$0<>O#KZJW;=*vwJ3>% zY~G@!YN_&LaguJIad5tjEKuy!l`LQ3lL~7C{U?`_)kkIZIAaJPiBEcs_s?cP8w7- z$ihTV*(-}Q=ZVW2d;Oy1<$r%E^rV&!|? z6z{rW8Lq30k~AP!l4_`PX5=i`1YYWpL@`U(e~2NF@~!peO@-Gt3oh>Y%nV>S4}QSz z5lfzL1<V%Pc1AL$2(=ZT@>e}CQn&eKZ4$TLayPCxz^3}^fY$6jbLA80_(=MQ|oux%5 z)X>l|a`T#E3*xcp73{T6U&X6t{YWdaW5Ox0B9bkup&o}-c-AOl|A^C~6Er4Dnn|#?K z!NC9N_=X)7S6ECVZ%zC($7fM(4aep+_s&dvRWE_7#eu^0(`wugwK8#z!I!dWc^Sa} zF^@8^hbMOILq=xI5nm<%KCDU;kTB`$znUmA46qavhWP~5$l6iG2fC@vmlo!UEo)kx z`GkV;91-Q25(azY|D%}LA-lmE5lB2UfX4|z;0)Ku*Ji&6EhCRwr%$vYAiq1jasYq`sJtg{>k z7~cj*lmclmWmm1BV4X+&c;$xo@$pGLsd0(Q|K#BaRI7ZGa z6S?$Cde>uMEh)jhe0*vg(;lv?sSNA#m35i?ay^jY=s2*GvfkRW>E|DKmY}`9h)iW- z?aK~5d{tYUt$GgA3-6*s2&@xN0Y0Wq_|b|l8(CoR-LYp76D>M~E~2;!0@`a4r`$nI znTlEFK9XSRW}5)xIH?vH!3_u%_BUK8!n~s^)@sZ(o6KwQxLfe797N=Bd|v zc(rXpC9vw;M+Ni=xeQY;vkOh7$IlZe2gTuD8Qf`1uQg}NBp6q-GM#S0$tx+t`4VDlKYBUu^ z=cDaW>KRz&zA^NWB67=bO^NX#_m!`%8rm~fxgAAjN>#K`&7I-o^O#lfO3i06_21V9 zLwrf&*z|5K-GGdHl9`$1JDg?YO=U?+pr!b%M&xV7<3l+Fqu!_(-TdZ?xBZEJn+PeS zLd;kVAkO5XgVkpmy3ElM2H^lL-i1?5doDlPpTIl7mtP#$?w!Fr6#c4B_7K>I&qGIC zD134lqI&RFK7KF??RVEbU2*0vhxSxR8Hss?Y$n9*f!@~JMF)#Sbdz z-IOQc;wh^eicvLgbZI_WKq>`Wl}X11nq6CICg1gt zu_16I89(Y8Ny9rV*(i-(hrb97;Bz@R3lBZcZ;9f_bv-;zZb?c*a4aZ*$1Ks8=D{pE ze*9oVs!om6Pt}^$SsA`5k@+z?;8#?9j%=2qgzqR5s+DB;f~sN`EeC#UZiC&hUM_u$ z_xxOc5)V%ynLg*Nju9@pj?FxppK%#ecRPZb5hN3Rfwe9A$4YP5yZ6#so;zby^>B2G_|Q zV<9qK755dSK}+I_fcs`v8YZ67@mBM;j}eCcukOZdT05Xz8mKfU_#KCN!XYh$pAhrk z7z$|&J_Gv`Y@QzkRPq*8jouGe7waRL@%C-cW6A(Ji<=bOw8c(UGV?C}fr_We7*EW+ z*h$jEFhk#)j8pZIPxtGn*qS5lt$zH_B!KCaIKKY2C!E1nS0}{Ym75L@vWbpKT1S?okMOaFr1+!xmZ*CFj(H4$8?^W;?~4C8ER;KJE6VoU% zaqGINkcI2R;ys?CxxHuPHEinvrSC6SEfGFyx%o%PxU_+=;v$KZnXsiT2OAufgnaK) zaXv>YkiBUoP3B&v=}OB~dspt6Ck)kK&S@T5`xy}>E|7?UDlnAj%9#a4=Q)b!VmsJm zJw4}W_hPc{ddM9%zG}>W*bzYF^HjA)XzK8oI}cH`2?jnA!$F|5w!~ht3S~>^M=gtF z4#EqmpO^|IqU4+Q@m=DyX>IBS!&t;h0Ig%pz(GI*7APG%y5aDPwtpzaUbOXOA7WIK zW}5z>cP=v32hF;AUBpsLDYFfV$~~v$qqyI0_tgg37n0J*TVwws`^YNiAJ22r!^Pk! zgyivTgqSi{LfByUk8S**43ZiUcyE0%=pA94&Vk;BxS%u{@Q&Ns!w3ZUxDRUR7~%YtAuUt_D6o=~NuAl;0!`%1Hqe&cgVM%?PD#JV&7VMKpi@Je`|s-+qJU@; z31dhSR^#N|lhE%@PdZP}HU2;ak#>2A(eYyM3<=K)Cy*U4PC1WuZ))~wVV39lt zU&xYfrS8B#6#e+l5dsJVJHaJaYJe_qD?`h^{M!5`-6`ddsXME_#uBC4hs9nb*qj>l zfb1<=F_zCybO@XIMF%$@4X5kWh{CxFHB9OdQ{RJxhOu4j!V2&5H$IP-~>F{*wSGyxF}Hb9tImcvGCaB zd}BUwvBMts$rqnSlLN+f*Wn65lNfe5b|7`L>G^9%qsDBgG5g5X+Ilt(O`W2=b^EGx zw!v)}>VH>e<=*S!9YSKtLK%bdSKy+d8(5!qSr#*pyGTx_(wZa}9hiduY}zFr%;qYS zJe1jy*oW}4B=l!?Mw~1LonjFY#bA~8Qg+c5CrZ-DkWS>RS|5~Fvnf+h7^v~nYHD}~ z3P5IV08vE$uWx&C7&!1kkHS8oDu*5sccCgT<6T;MoKf@mPPwc;BjeZ+Lh%=HS0PiB zgG00k{QeGeh0r6lynlsO&GhWDAKVg0EG|mk5stptFn?&9HwR*U%PtT#3U1T@9BL=L zE?w7vonj-FgD`3&kz3ViwklX>JDcvkIYz-O^XLEJYJ|FC=EX)L124$!q+;=5#WS|A zB(oc0$b65R4woMXeOeS-E~d602lj!oB{KT)Yrwa!A8gU0jOx>F*nlsk1Wj(DR(uPT zixSOI*$IJ~uVu*&-DR^OJPXvLpv6`>9SGaAa-u?xRGJr{Y{3*a*~LMsA81DZ>gn51 zw2HWOyePYT!7UykZvsZWA`hZdB!w369jS3BPd7H1pA-iZ!s~vz9l8ovY=O0oJxj3# z$(3aID9T(+$GqcV##QkAO%5T4U{t@MKlgwFtawUs@Pk=~o?sW-+e*{XWuWxzQwkRuWHbC*IJkl^t4)UDLW;@f82VM_gXHc`&YQx)08nMloeD}Kx8K+Y zPe0X(A){;R$d6qRs!xC>?CWIQ4B1YGK+oFBi9hRY5V^`UJ$s^fWEzbPy?9U18p|Of z5c_2%`Gna8Sq~oWE?b+HO`)-x!USfUNdNHJJ=d`<5X`-8?SVYDQpb%JDc&U)m z2o6Cn{N$Q&4`$hZptO}>!RA%*Tt4ukz>AyGdJSMuK5lxv`pFM zlOoPmPj#B$2Zqo<^hFUxGD>v^1p;srt2UF`W>CFnN$nud6ntyCh{nJNTf|cz)G9tz z1MMIAV{W3F$1^uurSn6TU=q`%{44i*HflSg;>MIzj6PR53J<{qc%00}xPYx6Le}Rqs_qN*uF@tz0Exq$J=hqx8kt z1m=QV*;aP_ZW}oyQu>Nt4z8DEvgdnYba{A{aglH+xceRSI*tYDliye*8wYz&cPUFD zHDJz8M?7UPxlz`=-t<*|IL!HO>gpVNc2uCBFSG~9t^N)=db%cdqCiko+_a~Kd(nbZs?kI**;CGR*@eL0UN^&& z=;*j>n-kTh`SACDoBo8}^0jcb`j==`522_?f?Nu_^*$y`Mm)G70!3q7>|D zb2{74+&8e#+^{SVA{D#Oj~|vr+&0jV@^e4Lg_qY_zbr1>W>|Z|j}>G}&=2hLZyWt8 zIY+c<O9(!frE04IX+OLgAKeYzZ=}d>KsA zP7xHBZnf1Y>MmMuIyCz?tCuoLFEg?LE9<^5yY>}R;8#eF~85*=N7i)-M z`u*yErn`n&997l8FY(o|hMDOT1o()5T}Ochn2seUqsfYQJU&5`t+FCI^*y zh-J#w585!NB3UZ;b;1i80nYAh2r=2tC)k&Mzq>Z}UL#514q~%&ZIAK^`D=kMT``f16Z2@H{G|8SkY45BTD#2e#Y}|cM}1;JA1UwFl*DB>GLjcrW}vV1ebkv7 z62^x?lmJaU+e9RV`{}4noMUSum>3JUh@tvkKXGc=J5IXWd84*E%`6mDucJc+dvR3u zeBRQkddr15JYL0pL$-yl8tVDfhHp-+i#*tu1Gvlbt9_Jjzmh{xWlhHi)qbm;!XY92cEMzL>t9(0h|HPJEIipcwOhrV4!U zy-E~;hUJF1$NQrhMW^bA{7>zXINa%$H@i{yv!VrPwI}tw2JvWp@f_v&gQ_xpgR7#B z3s{(rjKDIEQaX8x(+XLl(NQfM8!N2?KxQB#eu~U^Fz>8HI721Bp74TUdCmE(&h+{d z5;X1~OXN$O1^svA1TW!UzoX8QU-vA5m*o6Pv`m*JIF&h4rKhbYKb9G=S?8j>#f%E~ z6kwPBU#vhYj!sDU;h;CZtHFTC1e+BC1pY8e2wpfRlNz182ilT|&W`@nCESQSggSgF zSrAYc4S1n83BrnK@R*y=2Xk_CN?rFS6~Afj2zp#VZVi?QXHlr!3!cACd2zP^hX-J) z!r0$-i%*{DK($hf?ON_U&Rri&e%|a&g`Uf>*B)_BJW!oN3NqPCi#kmx`;&$*9`2W{ z`rHoscl{=9&lDE21@HeL+FT6Lx$DaOGhf15DDFdIQ%&ND^})2a96^6CsA zW;PLcU4~9v->+Lhthdi?=TQ4qbh-`)zJK_!EPdxp>d)a!F*sdoy6@+(s~qPx?A+er-1xxITRL8pa}kKReT&wg>o3Uh63W5P4(+M}2M$v{ z`|f!f0e)tt!af#1CkIoYJB~V^*BV!4Q*6B+!{!PCS+W!1LggFpY`pfdh9o$)31=l zeWKKixum38Q%-5cNBD2-O7?c)(>-+xOUn+2Yj(OkM63?_6P;yN?1a`8&AvYr6pqmg z726*%!wjx&^Z*6ajOi+Hb;(+}FK6Rh8bKL#IUvrmqqLaCS*e{Zyi~=nm_12vb?^~) zjFdf&C~F#@S_c@{g%;>}a(`IV=SrIizUk=jUa=+o`Ul<2YBt4TEQcrmBaX`2vmI&C zJuxGQx^icFW_YC)=QZ;)H18nhTGG>tLk5a8X(lyMc6Yvw^!5qot0O}CgaZ*NW^>qa zy{Tx`Iqb~yup73Wa!tb*^-gAy_F81yBZX-$x06iTyMoL=L@3adS{zs6Yon`#SRfh1 z6({Yk1e$Ki;-?;ryvN-7oITgEs%HO09m%-_l}DhTKtVe}*0f0@r83FsyBK7Ur7n0|94G z5YedFS)vMCP5mcrMk`jbgVRqu)q#*660@xVl*8>_+;GXr+tn!b}QwvH{6yn&9ShZ z3o#&*MOm+(BN)?ypTv334%o4Z*abLv)&y~igDopZ?+Ss=9TbMqu66KG8jaV6SqqFE zLBWi&B)dAbam%!Ppn5bZ8~H3m>Jtd%x|_2CFW%D|zMqx{0#2&bL>Q} z?E=a)bA#U>t03?a;!@g*o0>{U7Zkab{NK1k$?4T;zb|1R|!yvB2^4dW68e2 z{c^Bjg_#VVnnQr852$5+`iqL3_k`cF%tyanzBte`Jt?KuD|)i%ABa1n6zLE7Krt8B z&-CN+HW3~-COLqORcD;t@qcP35&vD8YMWEy#PD~FV{nogtvXLj z0&*gJ<*DvyWeOLvF3Nu+L`v(l)IBakRni#OI+Rj)Ezh8)^kW%Xx5Hi3P(tRL^s)v1 zkV?=aTzLU-u4g}FqFg*pWAbwzqS;YO(Z#znc1sq37^LWm=Lc&Hb>EnGj>AMzbD|v? z-^Is)VcCzM-!s7o#?c)!kSO|fz?Zv^Tk>UUQkKw>ZG0Fq)Q)RLyg&H{68}WmX>EB* z@+qn9^*hQ{Qdr&oA0flAsdzy9{`KP8Od6LTW=v6fq`C8>_*7HMm>woc$4VGI10Sj& z!t`?vL@0)}|6O2m&1jCd^s_wN{HNRfPVAX45}D|F1a80D+FcGKk=b^;_QIvpdWh-9 zcjOO|Z`jSaCEyFs@y)q=9P2Qhd*d81oB#9ZKv?NKcX+WaIARA%h+TCABP~uVyOEg& zNCVfqX2XH{44P{QfUT|QzKWT@nW&!|FiPaQl8)?3E0(M*DqtgDY;t6L-oW&ba>KCP z8Y^ZmE)ry+H7E4oB4PlZLD2J3Czs*Z)AP5Wc*kKjxVy9341pELE^Uitdo9LoeKg<5 zhYxau8_j}C4Xd8PtX&tDsuQyuHpd|W`PV*m3k0dsjD9Mf(|M}g^L>8u1U6H zrNb2$OkDxI3U(G49I=;lrT?AqI~;6cx{}`eaD9`Yy|;1igg;F9rDMnA5zXRky#0k! z+w7sU<)P(?YabXl=Y_<;qi;V0J3D8^!&kad&hR3E{d|~1`K;8kRqwiw(RpEn_R?O}g*?PtXSIhoYuqtaHkBq)E2ce^ zuW6-k6ToxengFd1OlP#4#nXwL7I&sHS4aE)`4{ET7!#4wGrDV(6 zylW;0Tg`p9wspli)j6_58#2hCCOqj6TayeBH3>CFWy&theB+&T~dZrfxG zdY>b%A@noN^5o6U`N9=MTLEjH$^Bj8!EQ-+R&(~=7$1z-l7j?#gM2AntIJKsYC)ny zX#%QJFPH7B>P`517>qq`=*9ht4Y67yA>+9@#admv>c^tP_QF4~{rpwDA7Fdg1t~^W zvgAoi7g{??@pT%*tH&^iSlSD*S0+HN___x33V)ca6leBSxU|RZCMTEy!jkZc^~GdH)FRfq{a-$j(5V3zq4y@&+NF*46W&@Mtqf(rdV1MiW{t4x-~o3Q`>mlo5R$E(H8?eE_U8#iaB7nz|*3}=2Vl(V6nspe=L8B3R< z(iO(0m3HSfcM(8m-oHhHPUoU+f{vxevAvexL2c}D0sksqf`MM;@aF6(oaW)^f*&25 zOg%832cLQUm+KIo7CSA4JIg!hf7&)O=euGvLFZU%e$8|2^5E^M>4WxZdpb^z?UXRBy0l znPU9%x`)q1TWr8P>^Ij|i7->3HtpN);<(ZK-l|@{ zVbY*#Ih4ouG>Yp@a)W0BwSI>VNMCYY?VG(d?G*|jjsot!=$%zC0i<)ncM)t%w*`r! zfgV?GaNw+rOOprWmVe5y8cIM7J|EXFqC0g%{$l##(Yh@|LFoFn(-nCNAkO%X#DR{_ z@rX;zTsOg^=kHI@@JfUx{Iq|5DwqBj;N?(`_rk-oqm78ELJ}?ap%zzTab&Ol6Vf3qr5pNpD83rertV!T-Z@dY1(YkRBm zpb6YnRt5S=egE1%+@DMn%bjri@wOwk5@gso9F*)EMbZvO;$|ok!UJWeDF%D%7W^$1 z^^V*muN!i!gHZ}4PyvT>?&|_2;4_3wNC( zv{1Q(ri2Gkg?7KN+V`G`W(A|3=vsG?v2tXp@0>)38VpG=dZgxl?~e=ejb%;Gn|Bls z&p!^?a=})J&ReHHlBh0IxCDwd9}yH*reoWZf^=B?(ukIl{U|5>VKW*}8ulQf-bK>_ z90Z35V&IQBS^OoLCe$VVNTD)Z0kzZ>(?9pa=;U!er5$MPT-6-kMBn)S@%%6d&VT42 zAy;KDnAttsy{CEG!e#`ZVFt)YOns{{9k29+0LBdZWu8BA@`CPQW^E7JOdWDF*eO0X zowiJZpPs3;7b+Z?j=hT{lUy6w0@WS5L6NxR6Ro z_Zl31gI`}HMp)gP`8rjvmEYOOa+1E2h*V{(uJx0epwtEm0J(RpVUSUXZSH+k0(Wa20;uPc=8^a>Ae&1PB+QT`Y?dLP&Ufx0u?9lfI zHF`ebaP{f%OG8wgp5!+}m9k_uM9VcvpbXKqq!vs06{HcS-71g?jvp zN7eETe(PJPjHVcYe+qwJ`m0sL+&F!B16N6-%*JNr;K2O_&ppvRlL4ZXF(Ks?YRS$C zv=)U>qg@|06rI_7!%t>q6}$Lif09r)>c`b$jPQ|Xp`FOs zyn5N=P4W1YBEX5}3K+y)JfUn_Bch7Z6EbvC)s!{IQC-^>p`csQ7ES3%m79njiYA1t z(==a``e9pI!Aw%^8%G)&UsuxUe{~=>4INfGOoCIqysHf%R%G^CoV`eK>?HshNEgKK z67Ec-2K7YqE@XO`T;5czb!fvcA^qV^sxR2h36DZ~{|Bk@irT}9tRcY1+4X631(5t+ zP|@vKvS5Hy_hibz-gO|-05(?b|e1zv2AoxZ9>X%PvW}!IH{Xt7P z?p^GXbCr8Eg~mgs?NcW|K#xVcuKH?-o`!^v#S$M*}@TiJf?*D(fE11D|gG zj}d7PbFkvxjUC}1cpjgC=1@q0pSSWPtX17W4qmMy0O|P5U54+l<~CElCWH%MKHCTC! z(jDVO?C9kYeuN?YX$&LYa?Rx{32g1z4<+Yumv`Kr7SUc7HD|eP;?K)R&})Cn0xclP z7H8pzKCaxK6XO*DHbs3jSrj_rEP+LW1#NkkEOVQq&?J@;;w!UD59P}iRiSy923w(p z6dKNm`ZeY+Wm`6$z8e!K9cky{lqb|_;;TluH^e#%9?&->f%b#b3$A-1Pd}&U<|g*X zmd-raIrFg}^v1micQ#AB>jT$(uEDH?QiZq4P!Km*jL~nnGB0z)-ju(u%c~&D|95Pw z4HaaAoQc@+urcHt^&A$&f(#qLDZKayl(0rvwgq-@m5H^pm_@DQ!6s0`yyY-hR=dsD z+7p}#)Q+UOjg!dP|1~vyDbMVOc&EwIMlc!tyd_+LzC?cq9}s&CxUZUZXXp_gH)lA! zgtWuEnz<~1$I__84tE;~@7oA$ziK3&8qVuKckYbJ=#Hp#H<`mVeYmK3Ehf7?S;2X6 zFYC3p--r#m7{^=j)b2_0cys=}2rKbs%l(D+eSGu%xE5Kseh}t|Zx~FXhy;`6;yZ%1 z<)Ien_^&7U>g4cYHLfia#aB%tzS{=lCm-cPti?4LvBl@m%r+`vZyg-Cq=(0e2va2S z4D|#ogT7xGV8XidqwSEunhnT$ri)to5CENIY43cO+UR@x5Q%URI3En}(jn=!p_3r9 zCDPkN-caOYOhi(MyQH&y5RP8rXf7Pu)xi$(x|9%-QaEOK=#LDSR*AS-%5bTXdTyeQ z{P%bwO1os+rzGdCm5LW&3W$gfyY4-(Rx2zmlQs1H zg8-z(IdphG!lu@Ra&zpo`Lq@%zde}(DdUO;W*DuUPG+ddCU+c5kvwKzY9~CcVmU8+ zrd<_Pi##-Zb9Sr?+$2wWHrpHC^YpQ0cXSoDi!Ct_2H(2rBpbW-jzq4+lJ^M7S^%rj zD9lzf{tqc&KF!JLmE}gO0|{sr5n(X}GQla*%qSs}yZIC5k^=0|h}`0y0_~q?trn_F z6rL)-$5+Y(@+jJOQef8{xj&! zBT8L;kU^k(Az+)xA#jR9d|-;YeNz-R3}c%QY{L;FA**J!)vo+xeN7l|H`=W zZ3B_$lL`a37%CgCW=Fj`2tLU2W0B+o|TD) z)3fUh2xgF&^M3`LwoVWgAgoBw3>g<3rliZ&1AWo!c&EAcFk**$n0JrjWN@!LD%Os1_M{ZUfK+gR8ThvF#o*VN}yzaY;|EkR$LS=YT zX2Y-&kYFM=vo1n-VgZWbOz+`gAR|>-k<}`;&QAIgpE|IV5_nhT^qT(aOzxM>0a-x( zdot3Wx4hVZ_W5YJ^wC|{U3opfEff8u{d)!tYTO2MW~lQUMwf_Hic+Qvic+d#Zs&4@K>Tu5ATlUzQECte2O@ zNJLGZJPW4{ezsu#7KwRwKo-?4=Vpeus%l_Z#Ntf-@`r`RCw~#2E!OV9FCoOv(|+&E&{WZf&&7UECvi2R|zoN#@ztZqhtfWjB*jOjM;2r zp`Y?>!tI8&zPYg&yRgj-df=$q0-O+Q^!^VJ@b^bPB4lvyCA0xqi^uh`)s^Y|bw=eAM1h{R#2K-`St*dx1(2FG^mtL$qF}7ui_}w$OkB%0184jySF+C@4?`{})gt z{TkcVr<%s|AHDlldXr7mU2ytOjsT%9eyfN$5>$(9Jg*u3cetTGTt<99#-B1S>MVu0 zrk4qj11%y?c3I4r3F6>n-v?XN|5t{O+g?RySIE=FZRh3vy$0q zco|SfG$9S0*m!?h*R5gQ582O39k$apYz@7 znXEJ1v++)71g4P@w%C0J^x1kX8K>B^=o7 zNp4XL$%C?RP7`mh^r2PPVRNDnC>oQac_vEoA)HfT;bBQ-kC*ghH3%~f?R+R%tmwP& zXa`UqqJRNpU+rOs62Mc|qn3#46eF)c%1JsL;Izc&CYMz<&e51JsD}L*k;G?jWMTRD zqu*6mR%!=}n=wpDyEf>i&l;mqBx7mooCb22L(KR~)#`@2J1Ujt;U4A;2V4rAd^;E}W>6~>oxXr^u^*obP@j?J92Tw<)LSN6PzI@f z(u>T^(0mS<#sW0F(ANoJcy1$hN3-jyZncI|KDj~?$<~0#%%Rafk?}6F^OaP84)&#F z{78XSJd>{@m=57I!P)PgFQ(Y;=IJIl@*(!Kd}AX6sACmsxL#KIWDYtQjNxD|hU9|4 zs&&PJs;pv zn63n@f}c(UXhvb83(@A%7Jy68lh-rT(hU%E9~Ul6vE;|6iP|?*>=N$tciq7$AJH*x~o35so{yF{k2IWC6bZ)I!v)=%nzZqWGEMA9% z@LT{C-1KBNViGFkSMI&PM}t=spo&5YHNSDSCaLM6+^beR1RGX_H|ZaU?i}_DO!&+_ z4N+=oluhG`+W5<+C{8=*-D(I12^^ehr49HxW)Sj*w{hG11iv4*QHU2C67p?$3xc%0U>9Er zRG~}8_YNzaS4AC@9;_NIuF!%FGMx`B={K|@6Qci7D%rR)%yz)8`Gmc|CRzD4YTFVZ zvZcgQri^JKWj+A^-FH7IKho4kc5>T8wY;IVV{kp$q;xhQ;pHiL(b)rMCnS9EJq8sN ztE{wb=78fOvrEvv<>ERyy!Uutv$dm<5e+@9I@Y9H0!mqNv+o~5Eet64o_&XN^91eB zJl?kK0q=K&(0mnyUx^N);a0NNH$ zgDAtdV@I$;83eV(S%Ju6(XBKy@ya7F(&Q`>mOkaNtop|0%$UmH^U<1JE+#A%)2H(rIdqRPJ810`Ge)uxYI z^T`zauTuxQGZ?wX2G}QfOIeZQrS=cbK94|GW_9A~f)1ba{{ZWb5VxP-JsF%X4mUQv z{Ut)CqG$_dYhVW@66;GrGjk3}7CM#CIYqo}EO`5!tBOlO5lDM#4Kz}1vPgCk2Iq66 zqlT5H<U zYF$OSA0M_rpr>0zmFov%X}JS{z@U0ez$Gi%4TF!{vjSazPg~P=N~lpZYMP|)byLU0 z0XzM~Yt(KR4wY7ccwokvX{JUgx0)vAZ;Rf?^U&iO z>6z5)QHWZ_on4u}I0OU^reDD@KWtX_70u+8-5vL6bq}<1jcQ%c8U=NimdC7A(G|a> z2aGMI7rqB@kCy6U!HR0Z30E(ahj||ZvF>{>q0jNEmWgy{C6uA%{5f1HX349hzI8oc zvLaeUcKqP;VG6}reDwmNpM7gLhfpYW@$*`&un5{~$WG`l7?M~|t$_540X#jX!w{DIH08qPzEqt2Go zV+Y|ZZz=B>kCgd~PD8~ts;azcL%e46#{M&;aZakEX0zf0D+J@Evu3e*TLZ1YyW&A% zK(|`w3z(1BA5Yh}`mink$6W@Pt2>1sreXpf@@7U<3;?X@*=_0mP7)gv97SV0Et z+*Yv8L4=fiOG?lC$p(1OkaSSBA2N{ut*p(QW|R59nmWSs+LT)8=VIJiMSF8%y0ll^ zm`=2SOJsauB6&LKZ*h}59`OKJ%9A^H1MWNElOXz-?`7 zgWx=Ekn{HXl#lM-KJ-#jZ``0u_43IA)1xxryZw=qQZC$};c4Z-&bQEqG%MGWqWOS2 z*RZIjG@0?aCL9vV21&RgAQe{$OW39eSQ!cpwJRs*xlN*TTps+?3v@*?0;?JG13T3l zzR^Va^X>~=#l2ad{T>hl0OhmrEit;`mp?H>_ROPe1|1uU*lmAabgjXu>cqCuZK<{q z9`i;T$DaIQ&=X$N58K=l@#v1+mR^L=c59S4i=UdB)6@~s#AdQ|-7(SH|u;E~aeFmxSw;ZAi2wsrh<2^Lqq5MPv4XO^28niR^U?29=3J12X|E z>Q$zN_zO;t$I4vhWaq4|F_&e*#++bCPEmG7)MfMo<;Jp zBmip^hdpTgyNg7{QDW9rsvTGBP)dlyf3Ug0pYFE%W%2RNdxD@QZ+ca_(18yQ9k1~O zZq2rs=@)H~5&}Hxd6ew*Me@vTVjx5#R^|mAYFo7G?)T1(wp0kJ*}z-w0lxMm{h)56 zW+}bn{QAj7LO-&mMi~-<319y$YbpHk=)0Jtx(!0$kw>mu!X;5V`FO8M3fKJnV?qj`{#0wM0Nb-4OD&aChVB%+xe3T4<(yZH`#oVF1kUUaIk8MvZd}< zXxC3gp&0|V%fqF`3)762n>WEE!<8njF9aNB;8xY=1sB`N>ov44vbCbt9tJEteS#g2 z{MK(Xll;bP>w-cwpZh^E z%`P|-g>INvUw?+l2MEVTfQ^O_+OvW1R+le3B|EhYqQEe#sTng#`Xb8Z@l=d6>TTAI zTa#ptKO0EdN%L7XNPQ~c%dzx)roC00H83*A z2^05V$Dm!g!-C}^`$1!8tvO7eG)nIhWqjZzEr&QgRkVipZ%C{P7y$1&69{p|ok5?I zX!Nkd6D$3>a+O@*;73?x_RT-BLr{b@#yNp-Xjt?f>~dScphPa0yUoxPVHB9|&nRTe z6hg<#4YB*;O8~t|ri_16TcUL4S)Lq@|L4C)V@34ed481YTE{L}CBK*&A6&%_H=WD4c&Hh+mIs==EDMr0U#CwLkBV zGx7e6)UJJBS4cO>$Xt)EaMDe3YlMN!HPoYhoUi~so_eyJ`!hP58W;J?^lIErWHK-*coTvPO;sbE@X)i=+oBVvZWJU@V!fxPMs7P<%T-5GJWeuM?oLS5kgK0X~ghV;&$? z;VD_Nr$L_B%bh*PXrERvA)|Q!=Uk#QfGxa@6u2CUxLE}klvC!+G@#EgZLpi#YUR6H z#IN|pSR!KH-jg7^uOr6*KP4GZtno-0Rj*h!IS5B}A8j0Um+IXR%^i1xa@RB$gIiH# zrRrrhq&=(u{?LMvZwGLq2-jej2)WK$;vZL~ez# z$^-wf<15Li`W@RJfF@-GA#v%5N09W9rGoHf$KeQqyo}-gJVx0^)030El1!6DT;{5KnbL zLZX~$Ro$SGw3KxbyysDf(pQ)9zML>UsuIPc{-ZW+Z>>2ti>d$gE9d<}-WW{%h8bk5 z+(uB5mC;HbbrQG061jfUx?=2f{C5%G?&gh)Kpx=sUN!0Sg9miy3gCVsN_M3(1d@)D zX}fiz^I}Ugd;Yi|HTrpg~@o?+14)ww=0x?ER#5Cx5A_W8=(>55O{8*?vI~ zOegkKE=4v>VMMX-BD#E=*Qa=!OfYm+!{kf_dc~y}vXpz6@yL&06SIJlo65(#M|FRa z3O6t9Bi`v@)#>5>C*e_nokkF~Or8g|knR>5{n(W_`eZ0j@F`Mh z;s7p*YAR*Sw6+f9TVR&ve=4l!wTZhIn>O>%?)dw|s*WkmXDmI|IhIm(()~$ZK9zrq zU4w3Bjog=^Mkkql86&QDO*!sf2-alXz>Je@1dCfU**jZH19~{@8FT)3y@l}0v05av zHqv>h^SpoZAo(40XO$Pb!`cY#4)l-!Wk8z00Z}Il=V1#il)E54Onp9kO1-(KP2KX1 z^f_kuq6+J=Dy$Rd83SVe01pp4YL&0;=l-Rals|_I0AwsGveK1keMB2${xfJ_Dnw*? zB4~p7D8@`ww|0dTzcUaKI<-?V2AyJ|if3X1I(v%~(s^2}-#mObzjN`e@^Kwg-Wa{8ai~5%FZo;<`vZWG1Y&4#!oyz*MuV9J}~sNZM=?(EYkh z=@`7!VDuwAPF7|GE>vqt<8-t4;&~u1(gStK$hGc^^?pn|-YJHIxV~UvdEkC@hmLd0 zCEqG4Rz3&kom@h^b2iAtZx3Z+R%s%4dz2|K;#e*xYM#B0W~295`b}c+89GzzuMWNj z!v>uDL_w?a#yKM@piwRBZbrr=6oi)uW-PYqZeE@IQR3C%jKnM{~`t{~)s_G;XZ0rh?Zz4W z1hbUkwJm|rHw?s8eJf>6z)Z+eR5H+~E>H}6$Z~ytA0}WA|AWqXK(|p=7E&G27#z1q>+P&!`UJau0D`qEuh{=Hj@-rG>NR(s=_p)w9--Y_h;sO(ypKuDu0`SCav$lE@;Q7jP+K45H4!Kx%zvC+D_(SJD*e+-_x=RZBlFu63K2 z(h##zhVkDLdLP1!QD303f)dDiU5G8S$l)^En>N!M8)uV;sakCgfNOj?I6zof0x+0< zYAUO+%yRJtVp3HJWNr}RgLBaQ$qr4>rYP?r5O1kPsS1~;sl3UB;yR zR8ijznh^-aR*^R%G*DHoV&cnVxzTl*paJd^!86d+(uvWp`>W|2&6WNGRRkzF$2AC`1;=bM^5V&GvXlrt;}->^ zE)J>dmk4*s6KY>s7m>OZA$>N5xqRA*Kt$Mx3ruR`USpD*R!p@0;Q)1kQvdv=>}e3Pj;FWH&ZrFN2w zkKjK9q&XT-EgEyYl>X{@LsYF3pn`|1YAV|A5G*gdHqwKwFK48c1WE`+Xq;lV0@W0- z7MmXK?5RI149?LKv}#QDV6Oa6-?aIel2Cn*8yCjZbbT5!{t|ByT!(Ua9A=LdkJRB} zw46frncYc2pu&+uiCar8Rbr|)WAz9$fq~|=QAc~m+3oTjZ{BdJFrpz=HBMz};!6I@#{N2q4*C!dMze}3){IAm5Bq8~j#^iyi zB}3CYb1fjQVn==Rui=t6VEbbqnLc;s1o2I%5hVU*`lOlPrr@L9uUt$gxzX&tM!KMO zk~$qSIs_qtdu^9y7+MQjnXZd*PUGXqFJ$0#YjLIPbTeP+6oU^C&ehTzD=Pz5SkAkg z)D`5=qm#herszvz_xN7+LRHPj^TOg|8~UA3TDC1T51NK-`gTBY`5VHb!}AJ+IxoPL z4Q-zAi*=ij2mkx98_P!y-u8V9It{8+ zuH3xvRZWAs5X;#;GBer<$H!x36Kh@$PAAnvDN*6nCMT`LbO(8tj54~@?NK45zc-M1 zl^#=R-+u)BZP(vpOYfNAAff8O_dRU9f^$06JDr=Y5r0P^;bGy{287*%(e}ck1OG6p zN+h@(k_(6y*&E$xx-Q79sAPWc0v#XD4$V*b5~!8|oO9N0rHwLQVY_uGo*@ls$pgEo zT=m+c!1oL9pc<2yZ4Si`k%}H>_1tSH7$?A z1P$mC@6^G4d9PRDjw?)M`;+I5A-ncjE(dihs8i|?uR2P@Fr-O-9@U2WulXHQJCBhT zj1yaT^0MP_-RXi4Dh^8aSkk=48*`3K`Qs)_y+As64|V*J31+Cv(n#7JTgNPN9vA4<<@d1eI+f#Bh z9zxW>mH_n(DLLTx0+#x75&dzM9K=5QU-K2g`^(j6}L4G5(AUZQ4htv4!b!}lkfSY``|k)Tn#x4CntX?0M7B;*oJ)t5+Ard zk9K?ca&o%4pPCl^ZrXFG-yN6nIJqAg7nZ=d^CZb7KozWUketm*Lb*+XI@l`)zDm*Q z_(vczbwhWLa}8> zBa1_3jMMQ0a+c1;$v4?dX0y{2-7d1#xTCTkQ+oI#f`T`FZSs4D0y@9Hpn>iS3(Ax% zC(ym_fMmlc!`Y7&zKW>?-!4;*8aT*anA_{wr{yp|c-QL;NA$*lS~Wmo^n-LyC@878 z99YvP+lPQPiF;@+#{7avZM@Dom|~_uf$yuSXZM{Y`KhE>Hr8R!7^JtJY{O}5$!-jrlGLzV-{93DI z2&}rF-vjo1!w=3G#;@GiI!&xIrch;9QD5sz``vjoys~)`VJInr&&_PXlY;VimO0xN zVb6xWyU|bT6r8?}r3Eq0fGdxuEKCYw+slQ-v8k4@QQ+sP5|&M{77g@MQFeq# zoR#8N5d-_~COyb-qmy|bsP4iJpAH>7IWIft%K=HNzIb;IATX8IIN4sooeZ}T{cilWx!m{ul4+_S^LRuBCkO+!G~S9*$4|7}7-5BZ!zDQ4i=&eHY9 z(7}Jw5ldmb`g<>ulw#u#)I$OUk@P<(0m{w4=zeT$ncE4_7Kb z^u2GS`>~o~o`Nl_n9nb}T^m|Q#?f%95lxY@b(kuvD!$X6pH2xH~f+`sKSa2KjXR!;ha5_fYu*TIMT}*N5?jY$wV(hp! z%1}%_cfcj6#|nOgQ-ptfhJ7+`A@7yGI-=~>YD5`Z;`Vez5a7Foz)~v6u1qv4cj4zV zYpcs}w%eDVC{h{p!UqlPif}8w&(OpCvhx)i*32Dv5|R25E42<9(~_sR!Mpt7>PE)U zTyaVZ+9H?>?f(0X%9c!`z>|gjefTg%uB}j2^&`YgfRR_8=iY^GaQmhd2C1ch+Rx6r6SX#BJ|g_SUt8Zq>tfSN43&&Fxvz-%WNd5ctSa3_x-=cy`o?O zCl9l*7rS>pa2@?d+<-c#JG9RIMkRdoodGxdv0=V+L4T(;uJXm*^J}%&F-WTB$WcUp zq?bBU%MJLsQqnaNTGOp^@^Zn;`-15L7<}~%L)VgdD?P!?J>Y@5X6v7w0y{4MF5d}1 zc5WkC^?y}e)tv`W=OCr`Eb@Qdvgk#F{0E>_%uX+@&;g4R*2T8G#&@5F?ajLGH7f;W z?`tj>!%GNOk@{2e^|{H-zhVJPOtj&l_F$mwmp7&|O8O*93VFSgx?%^9`=XW%ACoZ~ z_f`#Hseq|E9w-Iv6BQ>znd9Hy{fM`|;SjpDu@a&Qegj`=G>xc;5AXL@FAKQjACP49 z<}WV6-W>XWkEj9|72&dn^l`BM0c0;gA+}efaY;AJi7N8xDRV?eigKoJYh8D*Qyv}9 z@ro*98i?T6;@TMUcuh}K{Ekc=N!Ph`JwIYmJTUKzFbnL6uQ?pKG-9 z8mUS)s+#-kpGzkbbmCxl`<`A3z5W#^=JvFYD#T+7#$shXdL0qS;SLh}wCG`zDZzIR zIiNcz(rrtZK=p2w)}HIJ8Z&TAO{cS_e;pE4Su_U_(8C<4dSDJU7_MQJ0Uhsx$UQCq zID63Ed;O%^0!-?Bsj!q86fY!(AacG+^D4B*@EkE86sdB-pTFNt8&d_1M7H$VyIVTl zt5neO%aA_=fDS1@&srWdwZDa9JvSS)s%>EBrJYVL=#m`nX~&5r`|2y#d#7R8IqMm- zuEep&Z_cAuEhRaG12xC2BZ(iO z4?1mh<+nGQ@iT9GJg5P31QVPcTbuwlX=|T;MFS#4{D-mt#!&c+L0$!mT9BHQN5KpK-k1(S*gNr1Qz80R7x9|_xxpvTLLtWMdph$2WZMBg@0VJ3O@;n8NJB%u z8~V*Q{#pYkr;2CSaWEckL9)Hk2}3R$Tv`_jONs%mNGH^|tjyh|TG6A)$X-d6_u%MV zxPa+-mdl#kN;FpSdm8{P`8)@IJE!xe@2yOtd(jVCFwu4G{;TN^!sv4MkT3Lh>-5Q_ zj>=CNQg-CYkB9GJR=7a@w6#BWFs6@=88O-C-XF+ z8d-CCmik`Ylci~16S+64*N_cGFyx-WDR$EVy?ZqIG zZ)bY6QOt`5m?+rR?I+9{nuGh8_ZA?o%by@n;nzkF(OhaoX0Pf^E zaBKFh=Tw7j3>YtI;!m`nn!6+Xm?LcuuZt1Pn5d|F5%{nT7hlSS7TQuS`}w}K@$}bB z8+{c4gdEv$3%98|+R^ZY15BjR!4Y-cLWr6t|Bk=x=sc^aKrRmn!t#jXkbru%p!OQv z^(BkYQRftIW~E-(a5z8+rJwp0(FrzJ4_a|7=HD>e-Vn*O4d3`E}0v1Tm*XyEh#WU7(tnS_n{Mj#BU`Ofj znXCw8EO>(Vj?a)-}m?k z^?en;>Zuv!?(wAvEx9zjXN-*!>AOvngDjbpFy%Oo3xUVlx{81HqQzzjedRq*ZP6+_ z$Gpmo1&FYmj4Ap$imKAh`K)VN4Bo=E*d1^3de*TwV03ocX;4i z%52H9d0+7nx>vhMxMo8TNs5Vp06zk9*_RvL17RFVP#bj#_q5%_Y(N92&=Q8tPb2=G z`R#X)@SQqjCs=0hkB3qph~>1TEhX>kWPM>^$$US^9kob;OSCYCjxVcV#o9zyRSN;S znE$X>R8YVG01>7EpS5Wap8x=HSSka#ok)0G)Q0_5{H(d?;x#!o3xzD%+_P#eh+D1! z761!XOnq9&5~enqAdp7EYca!=kN~}Ic%Te1LG2qGK<~0$bS+SOMx>Frj8c?2RhWny<2busEPEmxf zBCDwXs=mEoFrh!V`AKrE5QqXbCgjJoB1 zvXmVK=5mWr4Kr{%!ULndX;xgN*i;g)O!|JtMtNxR)QnaxbE7|Wv_e;ejD4X9bq031 zK-foOGe|ATYrQzG^LqRE%Aa@h=U5QD|F!`*tY!6MGVYfwNC$`R4?$Y1sSd0#bJ!H<%C;jGXYK1B^a^)w#x59p9So-@kA-4T9WStT#N2<#Yi-w~2EObL|?_)#wWg6}?l0a_u3HZ7aP@jCmWw#`OM8pN)0DsshT97af zJD)TYU3YBm1Hnq;a~KMGzD+{eUqX zoaJwxYfO0@>6R)mqW)F5;FTx+b7V=yn8=PeP-@)F>R>mpw{dzOF#%JtcR#{&99oIcz zcHl!@#KCe`v4#>MkR$dAZPz>Fsz}t7itI=<^7zhzO!!Otu8#0eewph;bhkETT)c-Z zecyHZzT++pXJP*1Arhe1BmA6@Y~asl?iLh_Y~7sI3g}-)-{smbnQBrk@)OyME~PCt zg;Rh&xIt*#n{MU^=6Gs8t?O2O7lYXHFVtf?b0LPDw*`$?!C^?L5~I5ct%iFeuX!CAWN{+hV~Q{Lz_EE|ax%@L$HZ-J!gDC}(QPl6O) zczoWMO$Sh7zw0`~(=vEfY^rQL=j+8up@-?;NSQ*U9EHu>lQ$)1fRbv6{=sP%c= z6g~YS@wxuyZI2SS-=Lk`o@j$`PEFfYgmJb|m)_LAlA9cnmz5^t58 zPUqko#1SIaU_UpY$^`B*Zb)Xv%}oGfF0l3r$mKH+%x;BnSSKLn+3#e`)>g5llPjNQ zQ3Vwqd!e9(m=~bQ5MK%ogAJw7?)6O~kAd^_xskss?Cmjv`*2TM>GQy=2|hIE&cXWX z_n7}3XP8-E)iW82qJ|=6Lnb5yesVFLAZ%nM#HTaiGJ9{{)cS0ZP+-hUXbIe+AZiPn`1iXqe-8S~|m-RsU z{3Wnwi^9^W1(1qVz7k`{s3%U81EgbaGD^Jbef zL!Mf_0NUV*lohaQH0Ju3yCwo}k4$Rz$#L5&^Alr{JGl{SRs~83_{Ne5!*t*~x z7ApO@v_Jmw$n%;YYiIYPt9T|QbD>1RHGFxS}At`z~a>ofZjDCVFSX>%7-5PLZ&nwjMf1@aU8TY)R8oYP- zW>Ikm$tsLP+}e&f6Nro7&I8c<;)M%eG@O1kZ2!LaeJ|2(h2-Ncc>Zn%L=O0CI-|xs zPDQPn?RPX7Mdbbl@cXkr%*QYyxHW?y8H1zkIFXm4IgoGx zi0`wOiPhzhux4{Td9qTPFmv>xQvAKwxFk*p92PrYa}}=@=^Ju8w}lNePG6=id{5x) z-<1I!X(4C`>wn}Tll_b_R8sxi4$b1tUF5evacIHohMTi1KqPi8^Af}KB+>wG7mRGt z?Kkm)M(R8>0dWWHrAPo;&fZIoiPTp~o2t};toBwz<)glr(;`<`Zt3gux19KAbkEd` zo*oXN<=z4PLeA*7;j|B@aDT0;P>x^1cpNj1#tGMjy_idlfIG(-T9P#2=#y9b=<<;I zD1b?}$BAB3v2PI<5x!DLj%eZk+7+1#)Gr<=WuAexJ8MYdwzx+1BVR|l*YgRs`@?(S z={dZUguEOyBA(dM-ZaBk<`e7aNWhznR3tVtP&UEf!YxKSUK3yackQhLi|Xo)>bNH3 zjncU~%qB?~T@eEkQt0YLl6*MrS{pF@qauo+ez+3Gt84!QcP`*cyodO#v@t4yV>;f} zy4eR4B=nn|3lUSb`i=2HKti-&EoI&WknKu*1XCQvR%WVo^++oUrMWsImgL0z$%NGR zTf>1HF`U@`!R?r(3oG;+xPw$~8TyZ&HM_K?52+WM*%jM8x7xoonlL#B=pFu|K?L7> zY!y0bXbvG!WzWXe6)Fy@uMyk`;3i~L(%SA1P46K*_!m^ODj2^LdKtY<%MSQjY>xNJ zB{Rt_(jMn{i5z})h%rpC)jkY%Tx$vb_>5hNDbr9|xdu4+a@8b_%YS>{t+<>}*6tKL z$zcbZjaq{qPvf2zHf>SZQY)lQEw(JvSyp2R7fsA?Wp{(B!eg@yx13*^Sl&rSTOT@m zD4%>a*N-ApH5%X1u}RM8s`xtrj=@o zJg#QChtA7C82ALy58 zzvR=&IsZ3fiP}g#*%fc47j$R|{9aUuS^9}V5sJ}X9h!sMxKcZXAGf&W&%N0{1YDbQ zVswG_kZFVBuE_7O2_L*V1_@Vys_MJy(L~;CC-U88#tA&p=)&^9L19AQQ*osWMkXKU z75YLO#G0zdnMe@T5vIRT0Ppv4w4Zb#i0m_zRd@bTpcO?PW4{Z!iZq;8&IDwbpfcXs zEd43OTQ4k$`}@^rBnmd3IGjGtit5j5YM#7TWvnyJ6Ph7*a5%VGw0sQ8SU%s(hh#Ua zOa|d%j49FDp1k8y#+Y&@n(0ezk48MKogbv}Dk_}yeo-%&{3^b`kyWp^Qd5SQjtEa? zzDN&+BX5j9Fn$rmYs#pGE=c>c0g2Z+PDqZ8H}tm+b{~C`+f9k3aF8IAW?=dXHdZwz;6q~v}AL3TW4jJ9nu47qCx1>|#&vXnMCRXo;i-1}Hol;sR%yEfT)Yc0`? zVbb*sxZGrL5+cdsDe+Sk-B{%&um#B!-z3iwOyqXcBZDvg?;Kb%NzD9oXvFs-DtJO5 z_2XU_=6f0a?S`1Y6mH_@NQ05jZrC3aUY(r(d*=!57UlLk&y}I@#-v6^>VLT@hlHQX zxLI%aI%=Qxs0aH(KKtH*TNb##Wq4oQgq`@C)fdcaDF3b)k>wOku8m{G(yvT9e#9j`ed&nZzk9z`;iE&hxjVtuK!J#|CnTYiw4grWZOzZ9X!s&n;w?wgVhX|wfo zK;d@ubD!w;KST_2}t0$-SbUZQZ%5&8|iGE`p70*$7}5#7FNyR4t`dX`rNq6*eO zBm5;X2H2|A`ro0TCWyEeS!(<4LSB5xu6~cuA!om|cOA}&^vKW6l@ICKngJAtBlTDc zCi+y|KmAwYv&6slB3;!6TYRDLkFJ%R)?WmgoTb8f$SQQ89LyYi%ZD*hXZ~yp9+Z9` z&|}lwUjXqi1njDRZ@+4Ntnkqok)*ZOKMoVf`Nn^>Il~KJ=O+%d>ZK9!zB~{3v3qQi zXi@SU8W$vDs$Q~{vSXe$p0N-#5qv@{?`|BEoI z1E3>DH^MP>zaQ`{cH~<^JtMWVcN%ZCmdXjcusg#5dv4fvADBa>ojt{{wy;RZ6|g{< zo!A>;U^rHb@^6Hn>-9Z|V8iK`m9t6=0|o56S#PSy686i@d-ytD)mFL}Gv$U!(mih( zTY__7@z(rB|EymX!^P&YL7nrW$kEzdW;cV;&X{ zpZ^H9Qg(z{0yJHvJoje=g71BvMmhA@+MGvrrkgZ~TXGfyDiQzy4t@PLf>M#Zj=m*#Nc#04?L{b-=L7<1$dpow3j4-mDUtBHg7y zc0^UH^J+rXjIofT@`mG6Hgg>qoB$O_6$L^1FmEZ)NGoUu_*FsoOjR>g!8OdB%~{h#HE~%X8fJhi1RVoSGn$R4`*lC0+W)XI7dGJ^sCj<^0{Z0J z?beec;h7|45b&a56c>$^pPOcQw%DQvL^a;PnlD@dz@UJ!Bg>iIm{wtE)$aL0s_CDG z^u1+3yWO)=>J|#qI8Ye1A*H#qtTWPl zMC*qOZ+1H@va7;z#Qrj_CUKm)<63k>37o;{KZ2g$(EAMr@=)#8r+=JYd7`!xbcF0+ zTK5S+mWQ0f`3L`It3t^{Xt&-lPqP#Pl0EIg99Rx0Ve}E_M->1yQSsyaou7M1C4Z7| zL*aq&SP@lBNZU9HM>gsn{M$xKV1QE@xVEuYo}>J@{r|$gOZ#u~DLouHlV>r;bjw7E z3`Yu=oMk+?bj=bRt{+p3e;3)eL(kyG1Z>SN`238wBgxR!uiKfF*L7JfufQvyB(Z~% z7UrXp6eTX^1StGmN8QRD?^7zEd>DbkHKG?TB!(#F4!Z3~vNXNIkPbx^ zFX>8>0oMha3=furn^o1q-jkM%SwgLL`y%kmIet!Oc%->2%0fciB^pdZphA=9M_Xnj zWfm;jM|#TdLq@AZ9(n1gW53|(x=mgc#01*d;K~YA)!SPzc+z6GnU$WeE6+*c*}L|P zmMw1A_w)=+Vu3nAEP9Lq!Qv-Qi0vPs-4R3$YYo=41j2UPt1 zEO3#Mz|I`gvO1Ll8Q)UdFTg*|c5-Affr)OOyL)2RXm%oB`fMIsyR4d2g__&x)d16kVpe8o>i96C zv>M`2zt@9zO19H3a;*OVLJ7A7Aylt2gqjiv@#Fdf&Pc(FN>A2#WzVaqy*~HoeO5mT zWUi-Xo5kkdzv*|*U6g8b)efA>9Wp-87ND-C^&``6NrV+EW!KD#j&e#><-5+BGz__J z6X4sMvn+-u_&9IfD&~ixN^^k!LB}k6o5Wf>8f*@DU0#lL83O66YS{m%vL?SMP=Ajr zeJLn7P)`+!r`BJTxH6KL@JMY70HA%V=hfnA1}y>U1XDn99*gjxt`^|PII7bm_B7#y zV)J;_kE8{7TSHRuUw-pkQ#&8zR}KOsdsa;GO!>2_hhrVd8z!T)egwrH6cdx+q|L0G zZXNrI!Glcs5G&L8I$TOfO`E-zd71NcPQ71K>k4+kcyz~q^mBwoWlMwj_SH*R4)K~C zDhh3%Ro3Ey?8k1_PEl+jvFzU3Ec!E?j~6M_Dg;BVtFK3(t*1D*7or6uN95POqBQlw z|2a-Uvf1q2`bv{E38Ue<$(43Vy08(TO|*dMkjHL&CQqQ{a+$}Us!Qo}Zox&K23Chw zu|$TiRnQSu%ZvxcYNlynL^IT|F5}A!?L?tE3Opi~@f^0sbX`liqW%iM=Z>c7qPY3) zU0^z5tR@X@zuYjLn0o%88DYBeCXmb)hfPi&wr|Ws_5?vLJ-|(SH`ap?V%DyV+jMzN zgLd*ZR=WN%x+ox>i8V}a8;{QTyX&~2{R`u!&IRjR>xMKGt^j5yMB4YjXwCr&an)Hv56%{q^IpS+OiSvJU+EhLwQJ zd?JX_sDx8mDKnAq%%5^g0d#(|04(F#IxWG4!F=7A%wcOsslTH)8 zpC}AOE`>Fn7Om3vb5`F zQfGLf+qj_tr-Z>6G1*tH{=6Dg8Z50RvY({8B`-7g)CqETyPJ$Ym_<$16yp++ zZgvTwhxgVq{d4Tx%$oL=Ar87}WyBh9m5&C%fMR^!9Rv^y&EjWO`25`npCWKF(C57p z^U5tOGQaa3VT93B@lAT^#SZh^8=z&0ZUp9)JQ(;|HuFWE zNBWLk9(%bxI@2~6L1#Z>%OZwCy=*u1KNfO5)>kDU`N$fV4_*#$_ShM~zEZj{m*8!c z#Pa=eZ5aIu3&!@rNAy%@gzMIZPy2*=N<#dy^3G%$nSdOCt$%yC$k+j&O&?-?f{4t{ zd_;S=@qzgV^`WS)4lUFGkIrN9Hjk}BX}j28HElC6l$<(*EeGKJdExvfn-TvS6oQfe zR1BadI&O@{!7m>mEUk^9ehOORw={_$!^P+w5WQY;`dp>jK`6jHzQ_G&u(_3zkJKq{ zVz{{A^V?yxl6+Ix#*e)701rZw9>Hv&`{98%fL!9PhT`IjR=U2y3|Qzj9FQ=<-MR)> zd`w1m^z>q*#1?%UDjJP>qYf4Y2;$g!#YwqE$fW-Ypl8k!oJhs(%x?ts$Udk9x24^C zzxlD6&1Y7@`k)lpB-%^6==mSJ4c2_p>IZIL(^3;i8q!i^h;_IewzlMu)>v>jC7E}+ zx&4<-)3&O3gK5&S>=~3_+fuvWkybio9@9Ue6eKNcJKs3iGuL&y(lv=xxxR0njMRrr zhUSS20vq360=AhKjM51^`3|R}TKGCHjr<9U%uFul!cw&Z4OiyUAS@$_Xj`rT_pA)7 zPbT9Q>tKNIXKH-ex*X8n-s>?Iz=a96Ky+r*UG0i%ee@K?I0)k~->K&JbaDy$!v{S9 zs4dD~9Sq9fu68(pO$se&KI}U9OfwPnlgU}z%KX;WZ61peUAKGgE0hLd)9%1qSO{ZdMCQ9VJV2n^(<{u1dN$CObG?eUF+B zyzF=X5`2A}_Wf-D28hIloLtQTy^~52ptcLy=8E7RI4v}21j!B}v(3jLjw121 zNtX|ZHI(Nb{|9{c5J`ac6CcL$<(BSOcil6Q23hIa(6qx?kWVLor7jJV+@+VjWp;OnpRDx~#y74fx*#{Hr& z;YHHF$07$smiF&|a5ff)&5tDYg~-=UTuLXLlL zEHj<<&Zm@SNj%RmC3G6-6+;WJ((#D>_~8x9l>Ps;^taVd3GmnW2t%S*g2Hb5b-Ao} zhFrNS~$@^Civ_xfrMw}EalRLj?{0G<);eLRJnz7i$bIQ{BWbx*6B9zpN=VXG)TrNXoM3ecxj=#fxb%aW)H5j045WF8AtpknN` z^=)^nNM2(1rN5=KBE7LhBOJ54N!)^kU%n!(f4@+FV(j$=Nd2e zL#cF+F)jUUK;^TXAmre&f`wJZSm1^MO(YG*o#_BVaTe~YGEq^6hmJW_of6N50u}y zwY;BYmm_0$WOSX>I3v1}=j0qd@rxC$!oW|pyydK}h%7yf>A})n>hwy3s9*k4JUc`h z2uHS{*kF+|j?ec?687Fr^l>z1ufH*u9HN)_mTrR5FMNm-TWjSq^xjtYgOqsXuvpb* z%C$Tll{Yn-Rvy};Ja^r$Zi2un$gy>}X;8)V$8@Qg9G}1TOVMa6eOZO2+ZfH|b`WxC z7_fC8FGkPwdd=V$N|{ae010&B4U2U z>20VWmZGs&i#W_!h*2OB(t*$zBzfL5@yQO4jZ9A8a*fwVxqCaFJXnm;U_eh6FG?Ib zs~QC|Vz_cpy{m1IpJQ8B19zms(^1{y1@AEC8R?$^+ksHzQkVf6)tWzMYRsFfr4vJ| z*cP$hE2qhfDm2)p^eG#>Q^ohUphmRg#7Ci{0IiL~t-)QT|IjM;FaPy#Ruv7;eDJT# zucC%AvO4;2+9EsqX7QyH^w4@aR?yXH{g8AB+}~m?~Y9X z7f`Mt{5Ca-Lh1B)lOaU!22#W#4%%pa*`Wdv}RmEq|G#{+X6)5nEcdg zqKday-C}PoHE&k|QgRl{nz){e&yKpgWtY?~f_LW!Dt{q%G{|BqTkt4Rfqksg>=e5 z+p$Q$wbzEf?*sF*CmyBTSQP`x1}+)D@TY2Kv<5XdLCqFn8yOs>K7_pYI# zF*5&b;=VD}G666Z<~18WDEkUIo7cq-w`wYhs7l&kXWai3A50+5vooF`V72Y?=|;q* z$O9HK0xN2(fTKe}=evA*GDjR3)oJeE%NuF$H}zDfi>8zcvN9k?VzZtW;GW6KCV3Ld zns_8rDIVWTFC*UpVA-50Zs}%nrHQ=b#p7bIJ>Qm@a(>v@VS$~O)EO7m1(9#g^$B6| zar*`+2`_oToiS1}B4rG1n*Ym}rqoPn_f(|47 z;p)c(`AtW_2UQ7QknfcdE=H{QaMHulY7U!j9d-KJ_9_!lF1Gx`?pt@8LRp?OrhaQrQZI3n+LG$|D zq$VDabJnrhYtzCQXn0C_kFSDQSl+OqzG9DrC0Ms_CUSGM*S6^pivflGYP!k=L*z{p zcf2O}Ee41D8NKITm%6XMC{)tP&PJ$!4HUt&y3Wh6I?Kzf$NE%sWI^M1_=rI`w)E-1REQ1;G7l_{KLQ z>S~R`W%%t=0z-AkH#&v%C2PwGe5brtKr$Tv!x0qIy$;IG)Paf%eVS4SsOn(0^kXrUa~EyY?U&v& z=10CXa(aZ+^Vx|bcjXKHF~|@W=3gXNS+?$9A~-(NIj}{*M^e@+3O!+ZNP;M!8%go6 zuwS~G!21&9000|F)Mho!017zNuS+}f5$+rcv!XjpoXbX6N7W&69G=`1dJTvu6z)4v zn@u&c8`CShqw0ay)BY+dB2sms8GPAnfdBwWs6m^&H3%)KGMEH6|Ng2~000g>*iBqx zC|PpcOp$Jz7KF7R9FV{ew(0mWERf`056;G@rp?yOksoNEMe0@?Oeh@QsOREC4NFQumSwbE%_!3LryloE}v@HvWTBL z_~OAuD4Ayn{)c-oSV5A?F1_$K!8a8ok!Ey$=eO z-WW_5mfSh%a=p4ZOb7MPD#bPzL$npeOZ*PgB254w_=Pno&6AHDZd#ZX5gcXnF7BLz z^WxOcN&X#;01#q`UcCX{6^7t9M%xZ58a@JV#7CRh5bO=wQw6l+2jNhtz^#Q9v1#iY za;++kbs!TctsgpEb5WC1gH9)n(|sPxKmVzrjitt3)a-rp8rLxJKG=plGBq)hkC#OW z*DSL$Di&ko=wWgTf)-h1@$LR^P;>T$ws>|1m!XZt3bAmpK;=pSPjY+g3BXwh`upOj zz{Wwu6VIvwheI=|0u`D0u)kq2vc6EgXZ>yp*v{564Zh?(XQGNoxlL6-RlBtl7wih}In_k$TKC%~)V#jz5_5oc_ z#tl6qX|EN;F?-Sl!K;CDHK zv_AH^8V7mP)|SbOWU{&p=RE;V52%dKC?wn*syKln%GgVWTK6Ao8*kH)!#!;cN}|WD zuK{*5=Nq%MFh}Sf&pxlPt-m;d>tdcOnKfqWJ^(pD#=muuj)uXwSW+BHj4a{`UzWnV zBp^G$aC%qEm6u)ibK4YK_?($OI@Ci1U??DYaUmI%o^j@GHrwiBf`Z>-rG7RvM(9up z#X}2~oHFQ&f8!TH(87=s!g?~>WB3+@?xkeZmjzgTYrXMtrrpA`pl{+YTX`F}UzO;D zO<>Vmw?z@i9-C%^<|vhAlaF@>*U-bX%|wt5*N1==*LERZOoo*9=FX`qR#OZ~((o;4 zZNQYJg*>H9gQh(Z>Oe_y+I9F2e*}^u6*$Co5-)F$iA`DHeb7yZOlEkkkb{}4sQBii*h) zj27q|@Pb@!@XNg;E?(pnaym~@2bc>N<@^R>{BwlnBc{kki)p^S<(9J>zuA-j3mBKWCxAg zp2GE$V1NJUt1D0mO8y$eD6dPeiqc0sgI5I?-n&Qub>l3V4-5NWH7Z1;+!$w++ossv5)$HvPsasw)O{fU00RIAMF!5% z{+(jGsYC8Z8L-QeUkS1A62kS&h&~874jfa8eB4L=v9S996nnXJHI2@VZW2epds%-? z50O{~UdObt5#(kuad%;559-2 zCo)mf3q`Lv4z=hHTxf zLQ!#&j*?h65=Nf(AeW`k0A~@G<$DUy16$C`rVBqLXX)3x);@y<;6GyIpPG`3YH6T! zL}*KBG`$%r8AC0QxYG(Y5r43{FrTlc{^>L}DJXJUoZ96+2?u}bfh(+GW*l{^xr?li z0UA^?B6PNt|I|SsI9fy2qtAY!+Hi{5rT0)^n=mYKEGfkH$Z@V)^2d1Qd)H5DPRELq zH0u!ZHfO)%!asHTAt&GN(>nghkh3LwxPYxbC!8buYNW;dCLck&Y|3!mN;Bd}^yGG~@A;2VUUz`QW=o+oc>CZVOWCUx?QYf~5 zdLVW606FXxi0j31to5UVZ!9}!xNZ4xRWF4-0&Ikumk_n?$yGV3wt+o1XlmX(7OqMQb zZ*pLZ7tKHku%HIDxPU5wuFoPWCA60?g#PXkM_c)yLVVxqcaDCR3}WH%_jX4)l;~JY z=*2y*6T`zy2i7z%`vnpNP+;93b|&8E1VDl1s<@ji@45(!xi>B1;oT1)7wW}@9`F_K zJceF>R1Xb>{a98P>C5<*cUZ@$S7i`_Y6T3$xh%=B{a|Q`8aW$?U?abt5Iz2vsOzYF zHmr}zRi+3M`K{uAiJ^FWROQ|P@OZ6|9C*<~@IUToXQ%rq>teal(c7ph&F~i80 z!&}pQZlGfVZZ5w}<`z@bK{YMdN-PJyv|^_*rre* z3i*9%>9>keW{%C{qAfX?m%nh921bpsOkNu74_WL2y9&FxUd9~tE3%H)>0N}F#Em+L zlsl{Mu$%gK3j#(ed=h@xVtFyZv7R5WCp{)~@`4k{0?g@zI6d1rq@~FwC!1EPEO^iO zQ8Hho^UxjKQO8azFaYUl7VUgWv@)Q1hN8?4le; ziBVY#hzR#au@yL|5Wkq$R`>zT_vNP^&{`)wif&Ivy%*l2%V^~f0f5&VPUAz=s^ASHm;4V`cJjW5E;-d|!cn3c*YP|nKJKN(wgWFVCs;(pdk_-rpCs6cwF9~BI zxS~RMxg!M2N~tuYa%_-5c)mvO>@bR=RKqV~;d=(Kk0!=Ezw~BP9F>pe*&dF=B;jL3 zEk|^@a!GYfM(bc5Q>y=wA02OCGUNL=(4e4V?E6`Fd4zTY-lIo~p1)Rl!{hMfHmhcd zF=-2l!9(m_fz*YeT;q?nOcC4=JlO@OkC(j4|b zJk^sofaO|!-TreTzTQiABS$O@^&gnZG;?xBhk`NFr1^u#Q-+TsRs?db*i+7!_n;co z7fe~44D&C(I<+{iVK%OyD&U~3kl-n$nmA|apP;(PeqF4N+~fi*czTCaoB4?e_ot7@ z``*`vMwNX*&37Adm8hzRmafYMY9?U!evLVJmo99uzN|Cyi)8R4Y;Be`7hlJ>{Ke@| z=rl=vW1S&0(18zEG|%fo+YiY$mcOqA08jjmFW*@)BBUOOa8nXhN%p*<>Vah}RJ$Jd z^g%lna`)uYjXbZulT`edxu2sCQmhwr>V%q`-kWRiFATl4uIv3ata*l@lj{`qmUc9$ zyXBFif^L0K`Hx+f);#$*0Z8Ab4&sAm+Sw=p38R-GFF~9L-s#+ZA%r(*94qPqR+}jY z1KAk-7QA$qWP>{QZo~GnB@hA2B@`8=9D@_HrF`4{R)hi04p;IZUF2;pSGCsIi6c#> z9@kWRRCj=bFJH*Gk#eW6Tp&Fs+{n7eRJhet2#U#9caUHsBJvARU(37BP?!h#?$UQb zZ@EF*?|RKnC)icKX^(_4!pOXv>m$B8?yYl8u0$+o3*mY7P15b~h{R`@6{zKgim{!W zsk1@5K!1XN8MBkG{t}Lp@FecYVWFKWcY3AHGWw3p3Nr$sG)FkV_~8BbOt z{ta;)amzX{?G*U`b4(+4rz*LM+z;t?Q@z28a~k+uWYz`H--EtzSiOUcymyp~hemTU zO2d2}E9<_D1|-4gEMNooVQ%Z7F}N=87|WPMQmDPJZy+~ll)GJEa#$+jl~#;%(6?f7 zf6DH?mWcRaLj+dSw0Lo7dOpyJ1-Y1$gR&pp8C)&%`*eZ`jss@H?dv&%z1b?Ddj;Ki zULGVC+=9L|Kx>;z1a6aBt2MzAg=bMq`OlVk+5S1zUs`sMi5Uc?+GeNc^7TqUM2ZPM z`;oYEt~Ref9W?1ZR|YyMi}bSxOP zYeT=f>;N5cvm7|m8GYd+S1j#eY%=V|fVL+iu$1z%9g&(D>L1BnkbB!OhCaoih@vtQ zGUtDeixOGxASW0$S9?(-4pxJ|jRWNtG0GD>LhF;*BDfm&eSClU#tu)8+ElPFRl8$NAA*H1>tz+1w$y39j-(5(W{nz z|3XJwpG*&0EfZ846qVHd5R!Tqot{~rR5NOFJa;Q8NRs|SzGo-eF?rp8rrhda$cdl0 zQ`NLSl;{9~Ti_~iNNc5}055Kgj-v+Hb4CuJ^78;>k(1*u%x@pxGyWG2$U-m1{1AEH z=!C)AqM94n7|ft#kyPYj)#yc6BOc^epetsW-Zq+q27QoLk{~e@H;)7~=IMPzj7JAH zA`Gvdw)HqNG5OPuMn)ZsavPj)Beq5XBW zGCCgFf%V<>t)hgFMX@URU6@)z!#IDKM(ou$@N1&4cn0dPxNPgDD=G@u_J${Hsq-7h z;$oKd6cD*0M!JlVj9V)Bx5|?b6qGX2|AwS;;007UYE!hBTsfLnW8e;Ukp_zu1Ca#M z!sP$>^dBX7R^#ok88btEiOQRKRvYe5JC(DV+}<`CvE9gV>$k4u11*68LzL3aAO#Q| z!5bd1<3WLfSx>nrdL0hs50gb^OX#8#9$$VFP&yl?BCl5S8b^yE;CMj!e%5i%uEtR3SQj2G1IiR*WFP#((7Az^-q#$8eeFA+Qrbes`U>k z!)&BJpY`=Oj%RiyDFCew>#EWk`+AGX9$Yf6DP*~ZUeXhP>5av_h9w9#km*y{!`=|L zaT3L@!QBJi=n~|wXkPAbt~9yfbT{a@ay9}uO^7}ynaDY9zA|x8FQp(>r?2+@N@IDo zSlZpphESH9f_$hppV4%cUL+7H1r-?dbI&AClZpB7!Qk^D%6Nx#Rf^M@`HIc3@o+t1gwBtv!0-y1u1tWJz-QylRGPSg(E)?Elf=eo#7=Zuh177H zVh$QB2Vkjubk4mK_)$5+oU@6kh9ddhdE^K2+QAARsIM&}2_mTIV0JOWA5#rcVd)YF zm-0jTFn#@gz+n&7+vZjYcwb#UN9}dVx_f2>bnE_Z|GA%QZR*9bEReHaQhTjuQ-taX zON3c^(e_t;g`K%V7>?rpkEftp?}ZAK)w>vuaq3URzjmNU+$rS9+<4_-^fz>l&QSUL z4?6bgrWj4a>5fOY?LE~4pBT~NQgcCtZA|qb>i76k#SaX^ ztBa+!0LK^%4Yye(Sws=}1NkG13_>w>=T@4JfH?a?L$*;s2 z;(d&kmK$kAft(7VZVX=;4Ag=-> zwY^=jFhoSpCY?b_th|RkII7>2+$OZbJns{p1VURr9LYoqD zIl$9z>Jz46!Ww3Ts6ii?GQEfY&v8sangkuvv}N!G_#rk5k?-*K76$ zC_T=DbnCs2TzeWFJDa~t%0fS-q(TLjI&Q%(Uuzf2B|LYE+%{xZ{pg?J72gzqwpt~1 z$k@mmC`9XsMt1fShl^Fk9s`~oq*m_m%8~C%hG075FGyp}XC(|lPqXxM)cB{-#2b+S zU7Wt5>ZfT#^nKH#+#>uivWeWA1Eq@cUR;~STK?%$H8zb$Iz8c0J|5 z2umwIKx6V<4*`QT>OttJyLi;P!6O{o6Ny>er;&iOlP66vdVq_xkH3Uwf%t;r?D6_5-dW#uo+$rxt06(F2a0 z_a*eFHk+jfTJvVGnKS5ktG2uYR09&RVB-YX-P+Ti%WZX&(4;>BRuO7%Orf-XCIMAI zO)PK*He4kCs74!lzAEuZv)h)=yVddH2;R26cCQv`w)b@{)d(Zx~c8Q#A?b?a&|Y=Bdq1IX!bBKp?yC; zI*;`@Z>D|^FX~{U?ZEj+3wc!^d{@j`G+W@?!uDeQ3RFU2-R!INs6Vu*PE8WZj9FQ4 zVJj0TJDWuv=EzEZBa9$_on8Q+ykM=4!{Ahcry1<2ejAW8|J}c|bl?*pBfnSpW+W=Q|$c@I@zD9Mn?HIjBbS>V-1;yluoHT=GNLnU&&l+1F%{RZIP3-an0w zaWOnZLbILaCD+Tv9Pfb${yDs(ld+5#-sEipey~2bUcuH zF>0*P%Z{UeC$r8reCMm*WQQKmtxC02SVl6kL&6OS}lt5F6cv1P-xYc+&WccdyVpKP{BW?_1+Wh zFmI3v-7nbusb;3_uYJJrzD<9 z)86s$-x)zD5I1(b0{r?R z+s(sPN=Hx?TjTjg(%j-#XjhVOZX=OyF1tp&Pi|T-b#fZHH7d7LH};UgY$q95!j3Pa zmZ}k6Y<`ajm+=c#t&~VM-KG;0o==5rSvtN4w6E8MT8&9a?~qeZDZa zfeB2%1Fc<56bBAdk$~Q)GLosUuGwQ*m0YU+4ybltg`6A>5CqgwvstF!BbI z*-7guT5pFyfaHMa^l$(7r0~?^N{w8Q1{b)j9Vg&oLGlFvXWlt>O?VS&05Pja%gm)( z@c0QQd8StcoSox7p0xeSIqos4@W5=-5H=thpH-M$WX3x68f3{nOGX`Dx^RpRT(wED zx#fpXm^c5c;tgk=3P~BBa%BkZ*D&5xr69eC|4_&4t?c% zb?aTKe;H0nayCWpKD|$EcJjZnZj}=S%ND~^NkK~oCkDF>w?+^;K;gN+k4Rm^gunvb z0XTbxi{6713WxmP&ze}?LdwigYtoJ{x zR=ELT5(5Mg&bOuJcUUb2Q01DyRpYf*NOP@@#|Q5tGIVf z&7a=UETZSewOd;F{U(D<#sAg54p~*LWm*`G*3!a)f-J={K$(AJe~A{R?k#1o!^+mj zLjx~+_ztvz@YPYZWw0mD^g<5hS4EL4E82b^z|g+v*km(c&uO+2JOt)7mi417;%%-P z|L_K`3Gpf1Pwg)$_a{m?e9ZaH%elt1@y7~uq>x+!X2hXKJ6*O+BY#^Mx3LggaQsjR z)9j9Bbe_~Od<7)roUL&um3>+g)OR*H1X7zx9{pf&%|KEgtL3lIh?gwqQiwn>GeIMG2e&B5IJ12Y{fb2*p!AXeV%e}Do;xc_bI7Hxm=6r?IX1%Jh54TQ z`PS*(#EiS9kE%JWHUtueupxEcq|8+VT`una=cLnM*9Y!YoK5r_vBn<#ZusYyZ|-WB z{wwl*raoHX&$RpzWF3<}10HmDQY7n7oWjpS$FgUP`2ebzxX@~lNn^c_S1MwTXD|4>4Cdl{zhHY zkFD6qgvFc6?tZeSbypAYug6@|KNXfTv1y#Z=^s>w>i!fXoZ7|y3`oB$Ow3qt^OSCc zSUXorOe|0|A>#C~9c?^)_Cp;9qZErr=pE*1FjOK7Tsa5eQJKnTzChADf!beq# zYBD4~JnnP}=UkJac7<*wU=+7|phl$Sl<-Z$PML#ao6LDk#LAPm{Zeh zN^mTZVz1MqC~UJ60-61QD@4Vs4>79N)Rs~mf+rTn^5~L1v0<>;w@8wk1_Z?^AcYz_ z8nzA?Ychw_{eE>A%RXBuYOHWVI$6HTf(V`Y?Xpc!F<&0wAaM@;v54nmaK{&=2Em(Qne6+l{5*A zDsccrc^G*=ybKbi%hv9u7Do0nYlxa;{a^=V2OKOQV?_p{EHMay(g!+@yv|oM&f1H5 zvI~Fjg(CL-*yXru8f|Ie#;ApDbU%aT)w%8 z#bJ`*eRQLcietwY-&j4>(Ll=%m19q>Iu^Hn*npX}G77Sj94Ve4O{>Ei!k z+y;nR{%oM$gXsm$50+EJGR2P+eo|;IwsVi0;%=^LLur-TGmslFOR;9qx`K&nM3+WS zX(oYfozV?a4PzlLS{3=!^lmljBaGNu{UzF%mjWagf1cCCJSSbC#yX%(B zPfAEnl|s1;nW@D)SK=1 zKiE~x*%oH`nJ`h`k;I@2M~#5T-DPH+kHewq)H$`>QOH%h{Hb4A%3X2;_WcPK=qVx# zoijL?w&xNx|A$#9iOmG)99oxp+4q;H$FpsH{B?JIkaU1Yt}a}cOYaRQ+JC^V+gNPz%}+Lv9?Up)xfN}+TQ6EE|Kxp!k4rs$IcJ}e z-?J=&&8NzR3vy)CYbmWS3R&X83=I__{hHCNsxRCOF_%_`bZ^vLZ{FppMtM{-M_CYv z@FS-0-ZteQ$>1eVSa?*2X#$|9wr)4n98W9P(LUGAD7GVlmoSaB%Z>gMva%_cL>q1`|e&5w-x73`6IK^41vKrhTE@21u?1! z2-*A47d|R}i^TYhGM>e@xEO;gY*Yp0gTUa=b8|#s18laR<<)S{6~b<2+#{yX!^bW3 zizH-vR2r`!3t4eTA1-chALn{Gv#*J*g-;NPq-VT|&&Ao-K0}S8U-A z=V`hRdxniNVxAxuO`FYom^W&LengzG_sNjliBAM?pP$}!%am!8BBU}9Eyw$U4S^5^ z#=y;`^d)4~E%J+|MZ!3)78P+Xi_Rf5s5&zmUIT^=q}@&Ur#Y#q8K(wY_$?!EOx{%# zNf3WSJFXDQB3oG-9{W`RUJKi(l+<5<7m;Q^#Hf)K{qAv~2TFPBNkDu5bG&@FM^svcf}aDIGhi>D<}bCi#<-a@1s7#q*^hDi z7pZk(RP??mIJj+O`P**+`D38Yo5O_PH|oBZ5%+f+A^@Ea-=~|jO6mMN`+_mQ>tp-x zd>C%fUdzFm;pm@f?8)jDh+d_09LyK&3!fS>odqhP^N+9UhAXF!+hzrA1(n zhp@dTjz09*N#N!>1^yo#LMug6rZCv0=QQQpw>uI_5Ts|s`E#W>?+R1c-};gO5?d82 zi})ri((21^JdcV{p4N5AMassL3S{5l)>P^%KF-DSOZr~NjVH=8JmUEXC|5N3t-SQ= zWRwLJRbSHl`JPx;>)N4GBapvdf0!ihVlz7S_VHnZ8wW=9@umZ|-QP)@x zckUbSV2Q>ETF6U6*WYrrfZK)f_Bvr~DyNB&g+NWBTom?003SwCRp`A4;$cM(pY{20BKVbIcbL(aNz)f3=NFhDIm8UCIyk4?nD3!(Vi0bm8Zry3cJGhZjM zVw^-Z??tVUfS-8^p>fyCoD1k5FgS9;Ww@~xwg1rCB&;+lg#P#LFlta#`+g%Kcy8%) znHC&IAi(^>XO>=k5ZMh($8H7^5kR z+K|9iZJb5NSjT(R*Zn4M|Ag#cwtOOCtwLCV4zJaiuNNKj3uhI(2!$~{Y243Q~7;l1rq^T z%UpO=a7&M+kTmY|gzR^C>FaH3xo!|pDpk!lCW5{9w zyGFmLeQZ?HHB!R1TDE7r;3)U1JEjBq0U~_hU-rq;UO*m{hZS7C=K37}&8rRtm=ie@ zkY)=v#N##Cw9!!L4n4!b7kh$F(O`o{5mx)yc}`P9*R9%30VpfsBi^k>P}3_nwBRA2 zZZcT4Y&;61{b|g<%QEFu702JpGP#!G)&}85=FF%hx#A=mm063ca=)+5B;HB=;ds|Vx<|IbYvjO^T=<_7OruL104Q(o}Ee_a|bI>HP@3u7!c2f#cGvXiS`G)xQL@q3z5 z?VDmQD!H>l$kzTGX5Nl`hDuLzs+03W$79b7?#FvZu!iW?MfVvy(+qyl0- zVSm;aH2edrccN6=2So@33$0vVImH_y^dDAB3_U;nJ7DV-P*)|s^q0PX*6U@g7h~Br z@Rjzsk4Aa{cJqbUM+;Pejf6v&*2le^8P|Cs zc|Lth10JPoA*#s_O>1BDb+y3XV0~@p~~H zR>=evBdOlR*R62q#mM$|PR`sBP>Qbva}tYj-)E5Dj582+Rf3eg?vtIa6@=Ezx0;%vx!wr@bV#UFIdgJfGtaA{9^A|TC}|O< z;DJ|;(-f?Wu7F5C^SfW&Yp73|3OwV2CSUdu59{lnNG7ggNBiqjVIW72ICxAD7OBb&-L zjNre@fV|7FdPv~DM;vH-wHd-}Wb%AmN!02YPYQ3^@N|w?{pBI5mC(~-8Wx*iBjvrb z0ub*gpu4mJ;U|wK6&1Y$Y*Xb%HVIYYEoTKuksrYq_`TLJ4S3{Q!DswMs_3$ zp(-OwR1si`2ma0lbG+og4Cde>{30Hr<&+2DuhCk@I074c-cNUAeF#bJ{0 zmf(9!l|E~E{Qc!HXkQm$rN?esi8MLen9E6oKYGj2bL~Pv`JlL@i9dlz&6-IhOgI(h zx(5X1$mJJxDlhys4Yo2%Q-yVLNcr?{EFY;K{e4UTDa@8)nhiQbZ=8&BJ~4;ar7-MW z>CT~Iobzwi#hd6!uxdjAiAGaU#ug2%z0(3Q&*bP5iPIh#8jj9faXYZD_m7#WnYRof?ehGQqaH9-ZxUZ%K_fl)FhHz zoKGw~1)~K0@fx=Ji7KdI3#68uL$0??r(B?ev5DWj=Se5zsu7^rZv9#4+P?L3od0mX z@(+|rz=63Ts2Wa%XuL!3kt5!3g1R7^0KKJu6L#Zq>%!{FMeS+Yo}_>GKD5V3!a4Lq z5yDi1L*&3v-Z^2Odu(oU&;VbL@Cx{C3~w!0Auwh+oXs@lP>C3C7t|8Qb7BRBX7Wt3 zc0l2|RA(Ec*0`T!m<~&CkulV&fjox{O(Qp@=1%lqM>Ni>wzdI%^5NyGHnCmFrv`_< zcGF6k|0*gSz#pu3b#e?!kzfuQLbg_@lOlPU9agC11mb7$rV zjgZbQu@Tq}bkunCe&)_D%uaKZ@o=^EeAs$xUJWiwNa5YBn<4AkU@_6wnWei;sUuqZ z0I5FrQ@vR|FJ*HGf2-87OHg}F((^DXnIl-wt`2uzSDyuAZ865$_Fi}JQ(1Cqipu$j zVCVj!W^ObWDA65Kp&a^er>&$)m$_^D)*;9Y=vcxLE~tapSKyauYe$=kn2zLKXt`h^ z==~F~sKap;2H$P5bqn;COG9#3@hak;^_%(&N&a&@HF9Un?dy<}C<#gN;jzG2i>GJp zG+`hJ7lHFp9V^WbwO!rWz>e&QFg~#|2#=6@nvzCnni-yLNUpP}sl81Vgh&_t8m}tG zi;sKjX@vUNnqn)Y6_y==XgJY&>)bRZwFljJUX9D@W%p9*<#$zKY|EJq5qslh&++-r zy0yqB9M7eIvqH5A>_vhn;u!bd|A%;n%p>YRs>>G_5>fp8K~I{l`Pw*{i7|zRR-n0_ zMCiJYTDv-VZfnu2$dorz@#d8P|HZ;EdahX-u5fDfdJSlI97&@9U8RU-)nu0Fa6gNvr&3ACst-)pEhr571_Cq;cjv4(k=S_5JkK z`0M^b?yqNdyPIu1^5DFZ-3EWI0#<62-1YClZcGj*$jnrS4<*yv<}g3<7A~u(3O$ZE z)fGl5?$4+Oo<%xzLGG$?$yVKSU;0L{d5+%!{X_ z5(56vy_>1^R0Iu`=I!DQ9j!$4B}*YNDN^PtXU&`zkZAhyQ~3IVLam_1lnED%&f80d z)$r!{*(}ugwEp`J_nw%#R)X;0hZCpqoaD;@QHJ{WcY&^8^e33e z&6R8-FYzeT-)@kTa|o-oYr4JZgfD}6J5wYX!rWNcXQUe#Vt9Ky~&sbfZxOG zXE#UUigA;k0ZUuh%{}Ztqan<0oziN(F%bS9dxBYEMRBSiJ>&L4D~#+AOrv%a$bnrW zad?e!4spN4eR8=xHd#bQ=__m+Npl~cK)B_yZYuJ~M zyWEBS2r^Hg zoUys%Qr2aEkio-7AA}NfQ~CgudZ2w3St*yDZac=>z;59&jIrrsaG-eMhG^*SvtuH=4GGAY_NZb8_>_hDUv@ug36|JG0g zVUV2piHZLdn<5BC(o0b$P}}3<_F1lWbceThr!&Ky+)eq%skRv94?Ltte$C*NP7l&8 zOaQ#e`TDi(ymP4wm^C0MTy^8!g-x2ImvzkSt|zyX3be#!A*G)TPKAagYP_#|2g;Nh z84DZVlK3ryBc(+-fK9)zxZ?DS?;qwG@NZQtS)Xcf&X&^kra?=k`bcaE0n6Ci=M%dQKhu5s!VW)eTKmb<0 z4A~m*&4I7Nn26$-hn*@vu(BBql+CFWSz9nQ2kfYR?Jsj6f3j8q-Z6~6r1{zIe*rl2 z)Z^j-4Ys;C0`nF29%oXoE(7tl4AJZ!jxro#Y52B_1uARP8+2O^9>q)4vz_ zVw@*_FT1ZBtDk6ZVH+r`&@3*yYZmh%E5W+^2B+m6uhObZ=Ym3v?gp-YEZ2i7jWDOX zd{Hc9ZCB;FNAt}OV0H=UDC^&-sG_yM2D46hGV=w+=}Y@4(cNn-r#E}VOjDW&)9(Yk zUc-SmeFPLX);P`qGa7KlQEa%zJIyzI#FAU1_;9VNahW{RzGlrE5$XFbQVJ_HU@IP% z-^8ovO<^}Vl1yuVR4W<<$RX@=pCmpbU)t6|jKwuXFI?wPoRb0Zj>HCq0N-9~C;l5L zjG&bCVV^!f+gSt<*ZJ7(CUMk(h2^O<_YSeARnk9!R1RJu8vUAT%8DuM$aCKS$21%- z3ot{89HZ4Cx7L6mt%(Bx2v_n<)3yE%yuE1TFecJJ1omh6T!>Pqhd-Yctzp61ZNdro zvM_1@P8Ls`dH2h>D%#i74K_tOA(9}3U&`Cqljj@{E@S5Q-wh0)1bs1LqIEv`1uD1cE07&xX(ECclr~kqrqVfYJz8`7uatZL;?4| zAuwfPpZX6BUqxO2yS-gSVcWdLtu zg3LRl&pnusCeE@}fapW6kFHYKXbkEGqO7%N9w7RmiCObqo13zstUpTtH$ce00tWgK z<9<#xY(2Oo>VEZEML9b0OM(F1BBBKp7yjl{C9Md;v*)^&S~?B5%S)eS4sm}EUrmLQF4L5z|?tSA+==->}``A2b$oNGjQ zp*Z;e+tO+_D5d>$?Z?8q@62Vu0FKBVaY|OV0jGK}VMZnH%co9`B^C=!VC-EA7H1J# zb=Vma7YXRc5us+H#6%^1HXtZmR?!o_(LaynP@4;p_WG{h`SVg^a0I^4A}mShaU$GhC8H*aSHA zFC6#g&zBm%{;q~3B5?PUi+VJZD^TvwvDmG2BzD`u0n#OHQB%P?xdQeE76_f+4;r(5 zaVXclgZQk>uiW9Yj$u>kK8Q>*Ny6N5BDKo#97inPr^6V8cAu9Zas`NCvJOvQbP248 zFAook7*E0P#J^r^l>rm};xeTLp=S75^{cn{TR2OkL&?jJ;QiA|#v)2|9Fpm&!0}(D z-GC@cjTuh|_=vgSy)HU2@UX_Xx&X@zUPYfgY3r|3{T$5p4t@cGVDYme7D3O1ajNCk zBEJE8Lue4cr+LWka{neQ8~o1OL7Og!g!q%G{(*HP(xqrFqz-PUB794**0+$&diI!u zs1h9+TCZ-|3UG&nFmW*Qms9c?{ymF>_9zJ?FeRFxNM#JOaoV5S<41`#v5&YuUsHJV zMe>jRJMgi0D8sTRD6nN~oOR+2&zM4ner5MY=Hh8njl=?5Ryu@+`K12pnm%q zi&I$@kJ+&wBBahr2X^|u&SmkCdbTk!^lFdgN#&0nys6{Py0OYnXqP};9eAHFGrgSV z7=)$0sNN3$#*L}|d1c3>#~K>ToWNRyMurfg)rZHK(0twwq>HWe_}C-f@j-+Ap6cWO zx?}?wj5r@_9>Zs=J1)5b+7?}>suCaaJ^rt;NTmtFB#r3?I(&T|kZOW@OsS@TEClD5 z;jM(j9G*wEvNb=m`H|B(ymj7|Aak>(uU7M9C{jq;=+t@Ih9pw-_RQbt<=_Brlq_YO zZG2}}=Nj?3{IGAP?JSDL@M@}7bn&0zDX1arw+NZWM4Ev1NnY}xHEtkt&X*775zTO* zFle=nF`CaZ5+gGQ$ELkFW$KxA8=rn-@-ksy&&Q38H{*r3tPb5&d7xi75syq>>Wk5e zHml&w>e~~F0FDe7<~z9SMI)rUW4r*G9XB6N4PyH&OQFAhVK=dU#vQT$#mcX0ZlA>J zALb=#7j0Fbv##g7q1DG32tE|cmp>BFP`*;)uRG52g)1tD%eLnaUBo@30vi26la%R0 z!DWCVy_+P%}3Xzhb0u8 z*+0ISJul}B>ZXX^8aO?UwvlRc&4ui-JXgOK-rpnsD5@72< zilFxeV)?6#O$LAuriR73%mzS!Jr+Fe3UA+q@Sok=Vv{qmOl6Y zzmnQ`uaOo_uwjiO)v8)j4@GJ{?+O7eKx=ZZ=~Rp{ZdP!R0$h@oCj>LYal1xcq6$Lo zYu63;)611{RUHOwZ2_y6TV((!mMRX7K_Qg&c%1lvG2?m7hgCxf)0uVcOR?r} zi92B|)<^R8Y2d^7_U;#AQI0$5+JVL#47b8JNObLjlz`*a{)#{(gs7q`n9_$(Akb6m z$vFlA-kz>}2J0#vp}KDQ+ke?e4@iGal^NdVlnrxjGp*!Oe=JB8a$_009=}0Q4BqAS zK20!RC0``1BA^8zm|-ygTg8M4Vhl|Q-Wg>nVXVSeC+ zqJT4REs-1%AK2S!Dm-1U$d)hw02~5ApW0-UL|iNX003PhY;`2g3AMHu-dH)^26Y`@ zK*Pj@nHmk_%BF#^w^O%nP`EGvmU{OoRyxVqgMQ2L5H8rx+_X`Gd;0`QmKAXcXDwsAi8V`jsKF|jG{@!)4#X+eV4M( zcNB8X>mDY!yLU?Ayn_B_`8s2r{Z+y`jNV>R%_WT_01wLvg>8Z(p*SZ#ZW}$;7W}tm zPp(zSqK7hZWpYm;h)+D|{i_z|_2(s&s+k?*5j8A@1Uh)m<>Z#upb%eNCmJSA-^ZM$ zzfZQ!|3KhiibdhcLOQ$NkL}XrnxF9 z-O@Xz9=xIJspkD4cb++`>^Xm|$WQF!N}&DKq2F_1bwTp%>@~*$!cv-N%Dx#chV)_gx4vB!&7uZYgeNQFCNnwrhWM$#-QHv*Q{cXkHFnC~S;-8wJA zj=hUh)q3SpOJEE}L_&cGrR^k`$gTR2cD~)5c88(>aY0`oky(oqNSJ>EKN#>`1zs}J!{4_ zK#|akSwc{Xyr@Z#F6RSHgbfIv93s!WH~0c7>g`AF2}xwHs!!_tM)$@O@>PA-EM2hx zaF4z`;F&MffCy~go8%GR6fAA>4ah|RcB)U!s19h$Df~caSW^P*=w$RelvS6&pPo3k z$&?h_BX;>nLB=L$45+$fgv3^U{sR*OXmIg%G@~I_doxi8P_>Rg*+VyNB<1sPB?gmi z6&yD2fi3am&O-R8z?*kQdD5s?jJw%jg8#m-Ql5-3)p(3)1M2R2$9f*m?w0{fP~znp zk;vc%{7Rp1##{QOc%=Hh;H;;D$VnG#xmSj*1I)YSXH?q4pg~Reu$h4A3=Bw1yx#P; zKk`#`-aXDC3E1bAuzhr7y&1&LyXGYt5IhDwnc2b;YAZ#gd(+y-?Sf>u2>dVC7hg*Pt-<-w`Adt9NTng3716=StDYl>ADMC);+9383844GP~<`}()OqtAk)u+kb z5$Y8R?s*)Q>GWnYWGGqt4~#Nqxjm zC^+vbJtr+!ovn@cu3H5rAxEFVA{x@eTZeVNwef96G>~r$=+W-z;W07r#=SJJ^Iw?x zd!E7^ALfW-p^CKx>yrwPb7%HM*L~F;9Ld_nqb-RT#_p`SO|K~Mcyp`?r`igGZGh?fVhn2%a?4%5nsHj{`zMr_L+5){6!&Q_Jp3i{A;3vpbk z`BZ|uiNg?I)pqn|TaQ(T0ds!|9) z@j@{}J=yCe`Yxa&pXU!|_Cat%WrRx0r``pMVYgI4S)+6UXYL#sER2Xx7k)!`Gt62 zOQkZ34a1cDav_++u?2%#Tx8J

{1MgKur1Gv`X=oV4b=mcwGxdXf+Ed*O;iQKwE~ z->wA*7CWHZ|Cs$_pCDnr-6;}fO1&8?NZT9NDTjnuew`|TZX-G{x=ugJer-y%_(rH9 z>qWcdFkZh3un_$j381L=dg%%t%D`$w<#Cw_^J|g!q_^2dd%5GCtfCsyN$yj$VWy(; zNpp(JGc7hM%>!JRw7MXlBllJQ#TxXao#E=mJt};SfH<$Od_en6x=s3|gOU8ZJr-Z8rShZB#%Y#zqafyYQU*2bKC0C4~a_PuyA>fnZnvry5F| zy@V~mFMPBY+!b;r{y{}f&NRvr`p2CyN?)*xgG+pH zL5T#0)Fda|r0K!5Om$o_`d_F#rVVB-m$I#_;)KYehU|rgP{#yJRnOa2A~D{O&bdh1 z8d3!$av4W$LzUt4IyM=WgiGoxYa@a<=e7Ct48ZTfnkTgqgCaw~v%Bn9u3);M?upRF zKf4sHe??`9a05Y4jM4E0@8M0{{>HymdF9b^F#HTo71Cp=u*bg(U1l6=-sH$;833yd zTDjCi{(9MNW0=>ji7K^Kn~W&muad(e%GV zxb{AHR!MIDAXkAKIy{N{6=TTNI@?%Tf}2RE@HYA03fW!pnk_k2f#35JVk6eUJ=RhJ zwWNvnV?Q?LqDZoCrk|gCh!A?-y_W&JDMaP-rDH=tb*-=8pl9mNp3Csq4+Jbp{Gl6Ug}*ao!hgJQ>Ig&@v>bJTzOyX3`UaeR zo@=SB)&~d~es9iky?M2HT1ciI!!`J%2R@<3@0d{8QboIrkh+a) zzV@nVe+yvq^@R_741Wf41rZm*P6(NkcOu+*!lA8JXbCbME$ayiam0(sRnEx$N-OvM z$I)q^pJHb5I4c|aV%ota`7TQ{A;oX*hf3KHEofdT69u{aL?G3tHoc#2x}4oiO%>;d zdN4VlL^W?n04bTqTN|X~74f%+SlR&9Q0i`^^$o8vsa$nq?!Jy0y2S<)yDVbO7-M$d zLSW=&xiIZbJ<`1oh+d?)I-O9W7#`yEBT~)pg_!tC&(HW`S{*Pjdp}0=tM*}70qRg8 zK{2(!QavW=l(k6pI0#1)sKp=djE!qJvCR@N7pTuR12i<=b0T_L)-ST+CUHxa%RbOA zC0tj#RVY?<14!i!Q+)Ek;l^wYCYAB>vwy!`JyeRYOYR;{c5FKGzUXv zu$dGR)RjEE38Ki|&(k2PQ~{_qA~9{~CgB)Mna^8D^4;T5rqlwClYK(&8IbCT@cwss z<9QS8-aVfOrNWNZy7x;1^ZErBQtkypW$WKeAAvIZSX<+lfL7SNr&>J>nS8GSp3VL|{UE4Nth~xEP5@+W75>GX_`!SZUcAlW( z0aqLBDehrE(Jt;Lw%m(!89)`4y$1{MZ^9L_U3U)0bfjewBbcTg} z6zd(=c#(L)z)c1%?hR0#;MBjSakeWc8a`i>FEQt6urv_z|7YOx1>V@U5}|6{)C3Sn zwm5RTI`<`MAh^_>SsRA=o|H*XzW2bJJ)O?n6tKFg!`&?S2;_XQ7;-N_PblX&7N8&B zJw>fMybNk?xGj zE>q*ac4`%RewNyyx%oX&1UA7oG1T3DX$be}!vk7V==#DZ)WLASIP?y=rBozC<}3Z{ zFU$NZJZOrlEWZ)&mcuP-g7~24xZPu{q}9k@1M#7;@o~F5`&#G2ksq_);SiOvSAl4Y zPU6hAzxnek^I_+PtR3Ub{vPX)tF1&allhcX%B;J|%bVHuJWYE|)1%lek{dzi}m7RPy`RNpj ztNVE$hv8@N@=|0Z{CJXN9Xq>DzRr<=JCilllFYNT9cP8nu~W&!Cc8OX1>aEB zLY8*>#_&Cf6rW@aVI`PbQ2rN=zM-LllMD1{ezRe8uN zcbDSt6+HS&g8B0Ah6nZjMH$H^>n)vZmZpS7)Kq%JqjBW5b{+31ki{veF zi2@GZi0yXat+>HZf~c4K@YBp+MN`Vf_68y$st)X?4Nmyo^H{?!xaoiL4LF-L3#nR? zdRdS;TtRqv>_m}!#zv-41A5}&@}$8x*8VgL6(PUs4VJabVk6T(1(N{03Kl5t0E?K|DEF%4Fej6(~ ztHd-{Uz6j5W@CL$X?P6;1|oD{#P*4Dufr`xSKIl1!1-eVCpu`?iomDk^kt^a~D6J&dqZo!$tTAkKL@QHqnTbfVdJZlU!Gq}!pOuz;*RZi;SyRYe3X{7U+?B+Iv-nXHQ@@CC|rqW7$2c(x9;tv z`tl3uFK)i#HA_)m&@o2umB7Rh>(Ubw)vI>BA(UKaMNPXA#r(kR9w;@z&$Cose-Q5m zzT9Q+0bL1U{r+O1ok5?&>Hkr;S;fNq2<_wlL4rF26b&}eC**KShnRLGHK*LH{^>6= z(O@a>>j^akB9X2&l^6Hf)`b9^-;Pt~YX#7@0k3TcUIzI=?Ybd~j;XxCN_?U#*yrJitC202AIeW}4fNRa9hf=p4gp|P08LN31ezoEGKEky!O zh*}|{O`5X*Fei}qV@SMZ>o$?G!ZBsBJi&~5o=p^8fGT?YL3= zvrwh{oD|dUqzl$iKqbhtjbC@C=`d>P#e3B{G7T=EO0>H72*L(ug2;yg&dJFOLbSi|4&ajwy!t5wzx1xDZ*PF$r(Q-Y_$2NEq(ge-#6$L_ zR8qkB0{X65%QO>YRPK{G#KCU_N^y;> z&(MhVGHs}|lxIw){b-Q~j(AQ@#L(|q%juhI2+uD0JT2Fpod# zj%mPiI0E5N4b6{_KbV|UJ9kw17D>JC?ro6oX-U!1_LTdIYwW3}b|aFs%QfO4L-Ju#tCB~ZkAu2l@B>{&OP!rDbu z7CvrqYbHq3K257o(YH*0V;u$`MCjxY@HTAkn`ODGlk3Nsdd;e+@F7DRvywur=i`Q5 zwV>WH{u>hJd*`qr`J{e-L7a=wYNHqrC>*iZ3ro8Z8eA@m8ubPzWkIEaL89aFd*dRe zb#pH2_ACrB7=f*->9&bc*rLbePDpm{3i*Z&Ivcv}gbNn;8}0+YaX@sG2@uUvk zS$x-YL)tILH@i7sQlpyfqLq`VcC&v5W;_%iy;6cAWQfvX!o4t&3tuLw zh<|EFDPVnL-y1F`33lzq)N~EEq3N-jmQh64d_*VfC1}?b(`fw>Y_h@yewZ0*L?&T}53)+f@G+G}OaGBomQq9O(qR#^-c3>yM>p|RJ@2h73zv;qGIdElx&_}lS z#sTLISGoCtoAekJ@_;B%SIqcA1#O?s`z{lb`lRHGBFpF#OX?wOQRj*=+s>Bac!I?Deks@l?%c<69WZzm?|+Lf*F| zA0uR??Q%w^<*^Og0HA~MSu;!PA+752Zk~Vghdti|;VgO%8?qAY)EA2f;LwnWR&Tr{ zvg2~W&e?E*CW9pfS{JQ0a9b;>L-5oYFZmEmjUp7_L`_4-xcCVa2rx#yfsne)T1 z^Z2G#F%;vI8EbSCAi?c1niWt8F2)$jx&S70X%=@xz#d_0g|~o4k=+aF_LVMl|23P< zH;+#aaVQi@C$ZpQZvTn=-L+1mt39wY3>!npYe9$1{$?^yf-ZPXe^FaE%U=c8lC2y; znxWJgRFakUFE%#s;g*(!N-vNF4dfsMMCHlJ0^xZ5!K1c$#>JRdn~2#45>lQVB-!8O zW5a!)d<~0hoDg7+=#NbL?)!3ySaP7?UfeQ7ni8e)uDLjdQW#RdC<;6O*jGjHPe%_p zON+j-^G^z=DG+IzoL?S(FzjFp)EI5@-^j&FZ0<@yJ3E>axVbE>;X`==w z_+Sl9LqFyHYlbS*zhd^^F=I|0&^J%VU|qu|B};XeZ^g;poqJe~c{!p4nE7_mHuNZP zux|^8*3E7YrFHnk2cg_wFNea4mi`%*yTNU)Rw16c!9z~xZuun?F>)CkB9& z7SN&{E}*Ae#O#G-7Az&#lfblXrKKIqJS;`L3Oa;Xv$QDURfID9-K~DCi5*`TaGg1U ziiowvoMIJW0YUhU;^wEk>ITT}ieui``Nrr=XvHtfeY_147%FXAnBYBR$wfoX3%qdU zWo=Rr>`>OEvjVxWL483tT3cBd!CB%u~hFAtrfgMim z9@V2xSk0^4$(8nR562)EkpKV}gaM!VX%L?P08ft`i$hfig6e#TijX$>cxK*VLM*$M z1(phpZ;^=^-cnYZFdgLj++x53pNsPoNack?x3%Nn152WyRS|ORvq_xMpOi*&a&Ft({n>_lm=9^nB+EB~@Qr#=PbuuH_d*Me7&&JMKE?(8yzs~<8c(&LYrZw+ zrN?XcWh&zn-Z1$Z*}fZiu~fkb*?xDhW6W{b?;c;Vc4K0Q3)1m)S+XEb6xg{~Qci69 zNc-DL#ISSdYTEvJUDVgq0vK<>O%+ToQIuI;TzAZ0#IelkULI*qsh9rQs=&5p-brSP z!%8&{zm1FxaKITDQJ1l((yxeL?eI4DyB58>w9VuEXh~r3bd6G2ggWQ&uw-pOaD;m6 zR3@g3Rr;Cd+By2fHl{kG!nQ-UbSy6gQ9|fIwMJm*FeXDI_2M*BnDNjQHlWlhQjrIs zFu>oK<#xYHJt9rOkya8bYC0vt^rO%QT{J(4K$z|KM4$&hilc~H{cst#_6Cehkj|Vd z?0bPC4=T0UdxPP3G&=bhGX5QvmYci8Xbx%@Mqta^{wdkpmh=i=$yt)Ta3BpChX5Kaw7R$Sz)xR`LA3&o&rkIq?>oWN)QM; zt0%PbU;V-;Zy9AfNqeJLu{4DIV^1^2dsME0*T&mBsYVyGN_2Z~E#$(Ejvt76X}cErBO_8Mt=7%1R1lRuuMSC3 z4KV)&NKL4?dCU`BbTqV8(5*5=2Iv@G6Q`y)B2*V)*BU}69tfi22uHm2g23m9b0 z-x1W%7As#v$@0Hs=ay)A(iR{ih$AO+(q8-AYr_<}<=Di6SvJ1P@{vse z?4XZ97D}cev`0;HV+50Q@nXlVN?~57^>C4vg=BpD4nzdXkQKfd*TNXUBRcC$&-9_Lm)nln_!jB-nhVFf zqRi3?_TK~UuyNcNELWE~3&-cyLbn&vbgU>Rg9UjgQUB&js;cGY06||ke4y0wQ0V{v!L@pm?3{!8){BCeJMtS_JYC5<95^(Tz_0z{WXj2@Rg-F#g9y^RQkAzkrj77y|hvRV)tUpUe4 zD^p|n8AoM7iIN~o0iYrKek}gfaS8dB6?d0=(tI;mLyWUYV71fAdxV*FoU}7n-gwk^ zbDH~`A+RZ!BR~R)MiBuIyE{kaqwnh2I%V_1U=CxU)UDIttat0Sz!VYSrJtJFGR5A9 zO&N|TD#HEJXbC}V7dL|Id@iqaGA6cPK@dF?DIEb=%V{UG8q2_Z=ZK_F5~e_57?+fg zW7~LoT}t9@E1imN`=oE6E?ubAF8`Coe zTTLB!J@8iC3d>hu70+e$-wIw-wFj{1!=IaDxc+OA#L0tWQz zTlR#s7d?)uG`D!+H>xh9T05x#L*IaDokCp;f)qawy0X8Lk8A%G2h}bR`JJz@+h0Xy zcezguA25DdV5ZS5VCS=$?F&LE=opIrOYVB%L+cMPpXmOJ5+y|0J*k)m<^@#!!muO@ z!y=QBDgyuS7u&$cW_o-ClmTJjLkp1bE;(_zhJJNqv@9D0GM%6g1wWatSD&v>FLMA* zMV=7h9E55B+_GNTr-N5d9rf|)&m8iHRC@hx zlIio2grKvMgF6z}=Pm(ku^7w)x>ZN_T#xPZX`XlBbh}Q+%&iknD=LprSmQay2Q_Ls zAit6Bq+B(USD8#UAAt`(iBkET3N_P@%Z7pPO(4I0?19LzAxBE})F@8byq^4OUzuMA z&C0w_%-$$rc@)GKif}x52Jt*rm@d)cQNtL|spb|y%3Z=Jfw|14VR*Hl7<-3+i%0v1 z?c{%b8p-7QN_pOm?B}S;`?O2Xu6F_vWY-)#9xwyrA@U{1ad+!xU8w$xw(O`9qyy77 zaBdcP- zQl4wdU4dgAA~ry|2y;u>##ZOt5Yd3r$|2fW#Coeh!bO6`Egi$_t7AObLp3{=e->9k zkqE1tcS<;4b;QvB%qKi8B8J7_@0L!hDNK+g9j*1wnOQ*zkSzq~ai#}4?9FpaT0)vv zmXP3%Yjrj@?}WJY90@{%Okv*UHo}x*oaQj`?sY6eMfx()$yvs zvwc@UPReen&{(kS&b##0RSB2OK@sJ}?duM&l@AzGW+Q^QLSFE19vY-H_;bZj!mJ8y zNRAe`u2^3phCE*s@y3*-&5NrztiC*;NV`Ed^}~>I|A)E``rdINDpuhG#w{yfB|yr> zU6d{i^3m1?C+b^8Ow2ziOwd9kPKF&0gA(B;K_PfZGv59NkSV+iF;Np8%5aDM51O{> zU2t*~Bo`ZMnh)NOyi~_w8pvdeAiZ#M5HqkKv1F0;1~WM15L}2G{hU|+ei`SsQv`SA zqSQ=;MBA}0K}iAkjDg{>Y$52rFX@f8&}8F`1a&e&MWSR2I?I+l|JyI>VT)F7$c<6* zSwdkgvnNO%J8hyD{u&>mc-oCup-iMX|FddDT=5{?rt1i?d7)J<9=dPp_oOv!Co=2zHUCb} ztM%H;8H`LV01PE~*J9)qH@XJ#)fYGGd5wrN#gugIEb~+xSQ=kwr--wCU);EI|9fH7 zgGZ7b@6E4U{#Y>=MnSoO_Nps*bF$m~w4%Mj0Cs7ia$gLr(Wk)y@=u z^>2u3IoDl7pMIQHcRHB-)`TvE*!An&<2eus;%uNH9QR1?uv&s$QASa9(&zwTL_PV@ z$PX8q*h2oFfSD8OpeJYP5k~Ne#nMcd80zK)vUbal+Dz(zwOzMas@EL|Yrvz86*p|D z67#r8HrD{Sd?P;1v(7IngFiHy6Re$$0$RRDsW})W45)H=#@ag`+{M( z6GCaJ4x6$;rF%{YC0h+@wbZV&?Fc{k7VP9|mPE^J{LW*IlEA z*6QVMspdn4X z)#)xhP384H?Crpe)S~aZwC=xu=`~+u3*yv)XurDCnv9t(pEI$KZ8h*>ntm;DuCyb8 z0Z7nJQoKdnQxxnP5>=wvry3yXt{s%HOgIT^lThNE zL7}ApnM_B6FN*jRZ}Yx(`+dN#lm(ey3z)A>$2=%&$F@Q;_j@x(GRXskkne2N6*A73=1`fx!8VFLV93gX9@ zjy)ei=Zg?_&zaGqGS9BX6&lrDe@TsQCVPr}LqR+|Y=_lOPi{P+h3U3J28IwVXE3n8 z$+>j{d+*@)_h|N~TG$t*+&E9-rMy!0lHT8hq zDDX3+eZ{ifmW5uz^tl1920~0za)+DY2~4@@k?shMXsLQ7)tAE`2p<-c%eLc+cDV%! zTg?V%zK20t7g{Twua((Ac`D*KgZ@9|l~KDOw)-Q_*jf%E4@772PEEv8hJ4k){Hlehx}W>2{eOQ|mT4>W>w}z7V$Ncn65=B}OoE=& zogKQgGtuMu($6L(l=?d(H0_3{Hp~jUoS`e(PYa%d5 zeL0Rd^nI>G$Pfi#bFCBW%Uy|RRm$+h&6|yI+mH&&DsHZfUY0{vj}3qG)Su_?>R)j* ztNs=z$1MuS51;;1^o|hH0ERqe6Sfu{LOL*D;8-G?{R$0imc*%7Cwr-e^8%oE1kO>s z99H%CLKe5qh?a3QIkA{%T7DKKpk@>Q+T+8yXDDgh$%nl_C)QQROJQK!um^XhiZ_%m z<>tU(-3h9{NRAzNfqkpiKfynW`mXwiv$EX)QmphM) zRP4+$Cq@CdbP;9!A7obj{iwKHkRo1qCpBT%X*fb%+2U*8lNG@v`?FX3d%jet- z^$lincKFML-C^u6UT@Ad>@UM*$TOzcCMQ($LI`1TCI!!Bl^nQ@;8r{_w;(nGrEe(N zn7Z`*@EjX3k>@r6tpPfF@0a>*;U+0e;Q?khWtn(u?En|qjwd|r`X=J-{N4GxK=D;- z(xtxQAtRq&K3zY}=HMUeo(?b}8wGznC7NBP{R2*wb&pcE-7+)qk*yQzRS(zKi|PIF z**}-bv336|uy%Az2|_EGJo1MpoKP_Vd=VM?+y#pqN;*!LTH>VD{X+GL%n^2rOU}l! z(T4)T3%2npZj-H&Y18K}P+?OU|+wRtUXu0f%R`fhqJ^uXr>#}C_ zRVM7?P5=5BsrNZ<1ENUJ3JD+WEY#jA`b*Z8B|iQ=dw9~7k9x4<8)qG``SDX%DpJ@J z@(nDfsXaD5?f0glWjr#{97v{>C!aT>lAR@z-7N4Du_DdBHS55yxpbBLPSB6t$`_!A z6b!P0!9@}w@A5miM6!lu?_mUGHx!U5+G|jlBh}MD{$r=j`s8Zjd&*(h+TStY%oUR< z1hmXumb=N11&!+!qcHq!v;g=exp+3QNppDia-1|7f+D;hzt6+j{?t>aN7t2^@+qu| z(p}&DhHh&{SJxT|!i%>}^PAC#?kwFl^MtPgP_y>*H{Zql6Pa8F1odQd?-_e|btomG zMBX1k(z}g&TW08c{v2z#8G8*!9Zx`!miQF`LD_4@_h8N)ED^S_lhy$8D`vKzvakveSou_1bcfhPwig}AtaDqkAZQV{Y#;N+oUk&~@Fw`|6O-|ZD* zM9SO8pLS*Oye&EYsYCZe9)LE-r@yuM4B$&015Fr?Lrt4h@&LgB*S_}7frt2NVwVxn zVHfgc_p7Lcmq~DShr~7LIh8|qyy$mO+j<%3ixQO#Ec*lRi1+fOw*4tU|2%jRA0FJ1 zgph><9LoW9^aiz<-oEsoh_s0y>!8!>-v&VaVVVQ)RH0Otb%TJc_#R;)gRUmwUWKt7 zODV_xeG5x#hAFzxT#3PpAYj8=0~_t6XthX}qaB)~|FIHzoHl;Nf}fD=VJx>85Z7Oq zeq0k2<2;g5QM$Qcbj?-Glr$?rL^*0lJ~i!L%YyviFc})$vbDs~PfX_)$tI0^CiZ*y zFx{Cb;+Q^bX;P7eA3(0hmjBV`Bh3>4!?fDq7>Kn{+ZL0KwQne)rV0K!7I|h)+9Av7 zDJV5~GZtrqj@=+$_u|}?rJ&AAP?=)>Nw;^)-lvprg=~lsCmr3@BFXgl!m{O6z?$a9^__JPUbo{DFhSWpyGpe482_@*^i^CXzho0mq?Vy^L1Kr{~Qw z8LkdOuX)(USR}TNqGR1O4p5nyO7vv^d6Ym`P8^tO>!U5*)KMM^L}Ris1FMA zgvx#vOgpSeE4Qi7=s40Jnh?kxy&EkJ#ZI#uCZ&8~A{ZyPDu>7aXF3H4Yp*h94N0PK zQ+yeD_OhQgJQ+#f6B{thKw|F^>awThZ6O=VWc<&6YXP7nXIQWQ3gVSuttB$Pc9jRF z&^&3rkq~sY0NODaGlEwgK}WUf8hmVXN!JiK4VI_OyI)bYF@Vd1RK0?y9CMX?xu zdT}Le{dgTr3V?uPjHd>89>IF#o+CbAAWV3zNwZ_%;GcQ8jPe4?#dA_CX-JA+Sd`Rw zUCTQJth$65IyEVeE4OkJ8f8rL-G4YnWHLjD5y8$@FZW%33aD#!^^mnf3oy=(ISv3B1ParuyuXK}Tb@=Z6_vG|&@@ zAt{TjC9o=VzyJUhE&-qWZbE+m08gMfj>$3qC{ZXxY@eNSPoKLTy?XMDumCTafj04O zPq2dk8ut4+g}_-ZA=`W2R_S{Xom4Y_mYe$~MHq&&ARiyGno=7@NzoiX;SpJz5DjEj zax!HKaX>w500Rx~x&JAD@D!_=g07WqR~+5Ta)r@5;I1r=|M!%KGBctzekUh+41t;O zWv}^oY+igzJ%&_nG)D0y3KQd|^!4<%&l)zrP-0l}0liNPT0MojuE>5J8`xk;$k42a zEWIHIBo}nY0w&R@7x6X4n3PDJYp@t?=ETQ95W)% z`G&^HWt0(Uz)Z3sb=c{Ypqx)T$O^lhY z9n9aU9Ct~;>r4~xH=P(@2bn(1?zOf%4&UqKg%g&L9&brxB^u);h6YJ01@P$ClmE<93+K$Yk~6{P)a;-ES}5 zPl=fCwJiYI`x_ha*u&*_Q(m5b7o8nP;+uQ(xvgs-+n`$I?&Mj1*V5d;v9!N6vu4%V zCUTc!&u#cpiUe-o3+d-RY+Bz((%&d0+}TMyI%NPqczI(vNA-OcA;$n}2y7)^Kv{Ty zJXhmn5)WhLF3M656&Ynk@8dzwZS8Ga_u7b|+@0ZO{bGy0X7DJ&>55Po4wP2ySKTOo zn{veIN$d&J-^CX$xb^F?m^c4#6DnQ>DuyewG7rKZjgq0xQl0me4s;G^qOmfC*5Em8 zR)FKcc-&G0;?C?pdbp4kPhJU!91>!(ax7V2TfCyMm$dV3@1k*DSnrlOE zHyL)ZK(EQ*Q3#Ci;3V+fc{m(S|Bnb9;U32GU`hKV(*4w+Co+MNV^rx z?K(bBInf=?G#gcZP~`|KDAF?+3iZcm`Ja))!QBSXaIGpAL`5GwQZdzzGF5y?OW65tO6|1yiP+tHZhWlaQmubWd}@IfFPQ}gOZzNbo8~bN3Y@PyW3ZC#6MH(TgG;)_ zfx#)UOXd@!7-p-D@f?*MYuaX^Q;n8S=L!)IFfN<9#Wpqsz3;Lw4`H%zIP@_$aT6%W zRgT0MCt;x5a;~&q72`j8xOmm9ZUrz)hX)|jrvdX6)GGymlyO*3Pc83MoJ->pC?EDK zE+1Yui_IYel%3q*3B(`B{F07pAr@58ek~1Td5r~W>DfCNIFJ|+LOdh~)Jl!Qe2}{S zDN6jEtQ2GZ)(i$3%0f!#Vj-VIc5WchqqKQ*xrUM)5dR0kh^8wc)WliW-TS3d9pjI} z@2a32`J84JZy_L2Cg}lV322V8OFl{{*APhV{^*@yJ~Yo~AREhP0}Q3jBvgypDIUUW zD!+yRML@d0W{^kH%Txlbf>O_hV-a8%!*j;PiwBKI9|m<^f5M_L5x$s73YAOL)W|bf z5`E=LSK-J|*t<(zJb_QaV4;|Pk(gm2a#mYKW)#MJkAJFI$Xl12_b~#kzmt{hGq!CI zHz~`G0j&>339=1`oH@X+pdcv!rn$W!HE#vx!uUQw7BV=EvP7`#%?Qa*HjdB0Z_y2B zsQ{q6_itZ^uTa&Ik{tVE>)HQK&C#iNZ96g(yvo)Vzvwomd4&fb|A%)01g-XiUew-z z^r5<2HMra#S6aPyu)S+BhwWQMFK0!cz~ns)EMJ)8r-%3Aggc0!Z+bJXWuN*J16*^z z0H3G|#C-i?;cqy9{95dSTso9FR);&Jphp#Hydz9E8 zyvcG>(La_W6jxgf_PP5}{pCKi;C(sY*KfYy)g*zJvPfTw=QW>Jk7y7JR3n}cYBDDm z=qTvol=gOui?~NAKYRW3? zujz-g^6o7?QnOJa?vAq@oW8P@_9R(8_QWfZ`>;=VGjl!j;Up`DDEGmb;I}_!5h_3% zlLV>*&Pa+m#rNEE1>QqMh*0|ZE(ENOfAi%56zn=n0LRRB>dB;HOlfNd(eFz9h^6&(Cpb6VI z&g@JW5m08sZvMjZ8s(#!=R}rKNj2+i6lA(6E8U-PD9;NCJ!7n;{cgvHl5gz|sC9{( z?=zGdebdC>?MH!WAUtEo|4`c_RZaY5hEo^U0yWmE#GS=X#*r>>*1uOOggMA9)K70%NBF8$4;sFk)e&qvMtaq;=L)X$Btn!|%td4Qe4@rEAt!Or&3X3JrE zm}Mr~1DLA3dbI@>>KD2`t zklyrJern&BHN&Va-$2H0szdD|=}-rZY&6v85m7u|J4Eq56ox4=4PE5Jg+Hnl@rL|l z$>XbOC=9n-(Eyra+n#C!@#d%<=#nT?f*-mh%Bw*aqb*7$l&RPhBCRsdM&JGRmY{qw zNF7cnD#cW~ya6Cc^d}h31vb$sy5W1Sn6EZ;#LP@E)fyNG+jqK-&=*6+>Md2Wm#zwc z&CL)luiviT2a2`WRoH+9v2E44&y1*(J8*4YF=`9xiuG_WKm|Cigr(ws^Ii=}>e0mC zOW*X_0CDjFlsPn1bj!*Ay?Qn; z8fXdti$AW{5`Z&~{m+#Ko~9{7dkLktyy)z^JeV+#R<{ZQdjQA`N7pM>ZS#kL(gLR< z@A_t|nNFb-d_E07eo4cs&BDW(R);rtyaWP8iQNc)hdl&Mr7jB*m^@Q!t%S#6JZ=4; zvJ?p(jOq-`eJ=ytPmcfdD?&u{iLC_sdlL}F`(bERG0enH06_%Eh2Zst{dRDKqpC^)luiO+cef()Z*%W*sqZ-)y zYpRILA!RT;M&f=vICwJMI}u<&B|HlhZsX6Ric(BRO*?Thk&=~2h`MN7jJA%NY+P>t zwO^MGSui2z`CujRFD{;8y*n%Zfpg%WcLa`?rL`UAss%slmepSq)RmWz@sb)J`JHUL zu&sv4zu_1lw2b>J+6vBu*)(=s!eeZr_wkzPB&7sC@K@g2XE(ookbLxq^&hqrU(Z@T zCaz1?VX{Q=`Xhn%XWUk-^VwfzHZZE640H_b2(ITcM^KjfupuY~j8G(EuQB+E`o>ly zztS{Unk-e}efTGr#m5hbc{^fNj~mNyh&Sx1NsK?dI7Jvx4~mUB0T*tuI7b(vC(?6Rx)&Q1WpfE2Bc)v>j1q-nB`K zv9wC1?P7{B$%RhpgHB6N73z+0|719(3G}3?867X@b<{+W`V&NWR??%i7KaSO4*Q}G z_rhml0-BFeMgg~xYh>CuX{HQ^P*UKm{8)rakswcKtOF+mqsX%U|K8*I|VDtP&LseU)+b`IYi`H{>c81S@P zDV{7n)F&i1b8?0}9}olpkL@pp^0+Ln*-$s<4Au801Ox$`Kx|$;DOeROk6Zhr9lCx- z>3>!v(&8bg|63Z+wQvHRKd!x9v)X`K>;p?a!y70~X@WFYwfob`o>LFVj5uek)^Rtr zJw7;!lX2zW`+MC`?8^H(4a)0}yhlkI5dRFRmYg_I6Fgat;B$PeAOPf^@6uLp?${ep z0FWS2jtA4KD9Qg8LR3L>0r0n}5T(cY+t2S94!&((pz-DwVQWq?n>b&2VIENWVXW%b zli*5#^mvzUVA}X_AMrPVrP2>m7;WhT6dWlIIZiC$1zLum#YX;=w%vna-6e?p@PF`t z?=Mf(WtL<|4Q}gB^c2Lg3p4M7ArgT1o`Tm=<;3S|&@Zx$DOZnMq9`Mf9bi%uj6;{K zuB;Q-fSYeAg+vfMU6_JyE{)A86Gv+@G%7(X9ZQ-Se}DU#phYH8>I(N5T^GRwf9V2P zW40WtYQh95XGt0{D)#)^@T+#Vof%53*3kc87|kieV62-gwb#Y(1Uoxx8lFfK9{=u2 zYn>&ml1(1tTq?wt@oZbwIZJNf1czaI2kCG1v23dLre^qHh~LE5!HU{GZtQJ9smqI0 zyRt>ffY(j|R=ZH5T65_Ac>IBfDP0_-DNZr5ZCJjx#hkU)4V;#M@b(Z`l3zADX)&a4 z6sL?%_X0s#YlV}7XJFzds)f}44H!!mZNPY3+ekN1#fY=MPzAPZ+ZxDM(-2@+6s`jm z2%XxxmeWFWUlGRp3X!ZPN{8(2ix#7?)clLM*7i!lq(OM5PXAwDC`Kt#E*hK2uRyUmgKOqr z!UH}=_OAlGv2l$4Nou%#cR)G?CgPc_9?P6Dx-BD5SF$nxV2L5)8(48jf9Z_Vx7KJB zCMYc!N1GuJGS0dgw^Yfptvw?>&zY*lXF>g^@1qb3t}GW? zT-?jf6*A*6ZM0i5j~W`tno#2LR<`nZ{UCJnz<0$(4xs=q`~}aEDkZI6$Fg26);ad) zx(tID%hT18kCS=Yd$BY9<8HDX8QKc>msr zC-aGpxMUkf9G!;1Q=%(NDo39c_=uEo34PS^+V;JI&( z(%obT(85QsbQk39g8zdCVU!gB8=PFKzM%Z9HsVp`@bcBy8wyJ$PfB!d8)KT>+$E1G z=H!cso3Mg5YxFwH*@SrEyEP3pvQ;#{*1V05jGC#!TgS662+_B&FpOIhq}}TP+F#r9 zE(&7Cq=gn0_}M|T1!S*gOaJAm07jOoVuUCDXQ)E@g(`SI0x#*#S}Xjicpm1I(mNrg*@0a8Xv0OaDp;IEK9Zl zqtv6KNp}g7HToh45)MvtOy>>bEoTjq?K{>|m~O!r$sbM9>``^}Ox1vAr3g7aOe;Vd z22KWIQXnQ>uZ88JBf7k)Esd9qz2tqa_E@T~bOIyKy-i2pcw4%pAB0Jy8HUnA6&2Qh z5E5)i7eW(JocBD;?R32lOk zi^cJM7me?49hZp!0V6Sy{Rn^3f@tm6lF&DBjCNxZL$>mB5M)RS+TetwyX_+C7G%|5 zuY2uM$>edJ8FdJpY(Z6DEYYi6ixw99J-Wry;V|LH001m0L7U(;2ra2Hm;^Wf{;E{~ z01sEarg4SG956m8`6^O`K3R~m*qYKW{;x)#UInQ`?FN+*BINC>Hio_FvH-gJp=y{} zcKP^zO{8IVWZ>1-5MOgg#S50oLHC)EGMr)d-eE#dwpKN_Fw15~TzD`=?0z|aS1&i8 zE?{x(U@(dB+Ft5g0pN)YzF-ia{u{G>tmmOEr|z785|ETMu)70~%Jz-SQfdMdw;}4` zffi*+zN#{MX{P&1S=P7Ti71_CrPtfsxZ)3Jk>;rOv{kj2HOosHQTj(?phCpFRtS}g zBwdohyYXOqX<&G{Zf>ie&{b<$;@ZLXM z!7v&H++`1XrHqvgiGovkQ4bd;TmFCcTW>>gXtSo z?55JR7w zYCPXLMuv$|T?nH?m7%DT?t^y}_~>kD_4;;Vmi7`D@~I895u4&Z4O#vHk84l19S!;5 zgsAkvO%C`dRFIn)c!&{EUjZ$m0ZR@@n%!;Mr!^tYXLWTMJ-K77n6y}6w8X<@YVVnf z0ao~MZvqLurpSqcc$sKCdoP+)`Q62Pr9aaIHM@wsCaKSHd-YrQ`kEmp+WhlFjt?1@ z>i>rW{z}3A*uBc-Ok+OLkY3}*vW4|SEYmR^FX^}Hf8wJPMvktH31jG-TnL`L?#=mh zmNn7AGI_D|Zj3G5A>&5d?uGn1qryN~Ar;2j<<_NH0cs)gLU&&WMHrY8fAImmEdI8d zRM$qny79H#@>$7^EPsE`*L4=6RLhg7F72lMA98PqY@g}s1F;GRVWx>KTTNH0t^*Ii zX7r?IWY;_p1dnPRdAe4lb@&7}B&lpou;gG7jLa+H8|?8*-)fr6I{Zr344dft5AEh3 zb4c*~t0xaQ01V8jjV+Y7W0Gut^jDo1E&wDON8({D-yhtxu03{#>M6|uFZ|AEb|U*V zx&7GS{*a?x`98n3JdQSc9TQ(g5o+)S(BLDb!Ape{3?Y<1l7vA;+K>lx(bGr3h4aC| z%YB?Pd$B=e%#S$((75l*n^};lo*VjI22}EO%jS0_;!o)YHEBD=)fsZfUZu6Sw&pWp z{|hu?^JfpxqgbN+=|vKy2yKlZQY|)t_tXcoLCTRiR6T=u$>bdS&{=QZbXZVQ#T5qX z>vaOyb07_K!w;NNi-1!q`@^S5aiA*o(s4CDR!?DCHf1Jik6wlM1GEIX280@BOi8&WPjuLNkjali)4P}@A_bk@&Du2`pc!TE~h{q z6KQRm0cwOMM`?m=Pw)V?O?2fx0+G0meV1Xg@cuszR~xqlJ^-;c(P>UcS_AA#$1t4L zy#Y%V;f>Q7qBAv z$u>UTDusHUV(0ew7APbF$|t|#nC*f7!=60S${Zb+ZMQUV3mG5X>v&jF?ETKlZmx!z zf$f)Ko9-KP$8n|ZG3;d0-K2h>;!1im?l7+>=77czeDj{Pmqy}%R%Fi)GA=1%jqau* z6;MSqufGWFY+{Hz;+5Nkxr_!%ZHf@3XrLwraxwRF>c1l%=WCT|au)GeDaJh7e+#&` zSU2HzY2mCLroLX7r+ZIfBEz$Dkb-0iq}8DeFeIt<`#gG~PL6mbO`~QLysV`K5@#&x z8epLOQE66_r6x_Ibf3(a$CG@EW|KUS;BCfBgXCh0iM%5^|5~z3T-dK&*{Kw~g6zI%sIpu?;L8?oio!+%gQUV_c~v#s-guS$Q0n68{Yj zuX(=5XPp&4oyZISrK2-|lQAezEXSfey@P6Z@z;~)kT zPCX4m?rXqTUl4Jw{!wpJ>H4L~v{t-q&Fnz{6goj?FSqcRG&gD>IqdT8HAKqjkByr{apzE2mSzC@?CbATih1%u9j@*plt&F<9r3 zWm>25(IjBPx@05pGX7~2w<{<4PSJFD-)=wm3SUo7a{X~A{PBCa?Kg%zWyKa_^c!r1 zEpJRrzkec~Fg2ntR z*GwHxw$VIMu1rNpmfxK+YycrAfupPt<`d35q>U6bPeP`7)@wB>Wwl}>u z$|zp#b~75isAU#M5ST+c%EIS~)iGH{q1asmL>w?osX5_C>YR3d%%HwP#lne5LpC61 zQ_6JD>(vNPI?+GE7$%G)M_;L8XDK-ntovS&40Vg51HYV;NfUD0S2$N+!^U+YI#%u? zuksMmz-uDv^=54Ij$3s^%T<3wg}}J+h0=Cr#11Hj7q%W&1*8LJRd5oFuB<_ycW2C} zV8gx>rB>I&<$s8zghmJZADIY$=SxI~a@@mz>NT*Q{_%qv%y_Evk^^yQ0s=f<>(eVo zH@$x|&HpD)%@o1qttX|9{44FDOjIW5+A8)br*8s;iw}V~q{+qLqaM@knY5AJQ>pKe zU$BwB*Dw~xYT~*)W)hO!)Q)EK0{79a&^Ut0i!4*Xc2LLTxv$D zelV1Y6ztL9u?BLTJwK&MnPql7hRssP`AXfUgJ6pME_~iSU2q34BB;h|3si2I zL$!VEH3qv!@3<`KDhrygML05SI;7j~j=B|zY zUTA=stK&}=UsMBRo`>f_7u**9RVJVY0sNeg2ZczM9>CM$_Xgar7v~*;#f**M8&D1_ zTn!u~gKO#t&K~v6();l8-b|1Q|0It=5ixv(MdZlHgVgsG628nPVK1Y4g+&5%b15g$ zNUbC((gN#Gw)5?`rZTf`lgAJM8_u~w^m{vMeO-_)U-Q+um1}fSmd_6k{9aFpR{6K<}glz zLCE^COv<`om?6X$4-qwzrqNb5(vB`={6O{8_{ZGH<158;|L8k6x8m1MR+VcmU3o0u z@8^Vf$hJBTdN|=2lRI5=AzfAc9zpKgjLH%5@M5@SmC9@r0=n%c($p#j!RFa4V&Hc@k zd%_u)ATFF=x6q7Q&sHQ4E&1eb!}(eM*)3+-LTsjB)lSXOwWMj^uDY!1>M0Zl zI=LOYZ#vZLsM138rSmn@OwA|>*WqlKOcGDO02=uYaLp3Z5M71c%<2+~wgJo4{{q4_ zQB>PmnqVB>8D*hw&*keY|HDY$w{5$T**^pQZb9w=K-RXy)^MuJGeu6`<|UX`6f2MJ z%=KFdDh73g>yCRzxz{(Zt<7Bc%|Of}0GHHRGK6s5ZgFNlA9r1ry{IK6G{%;s;`{&j zXU@%8xHB)8!9=_!6|B{xDAX_o`)1l4=C|Ih7ejob*Rdv(WJLtvWKI(-03kKOXG5l2 zUEyOXE{RT!^R;-^=BN5P+#k$J#sUmVZ~niMtI5KWEGiXNg1~slJKE7#a+p)e>R;>) zY=Q?6*TK-z%hE9ZV&;u;KUgS58_iJs{R|fUzU|%Yd*4Yomi%>S&Y4szxO~`lm+W~k;IM+z*1a`;>Es+mJoRF*JB7Qix23tMc7BF zvT!x?QE_sp7O$xQ^eP&{&xy;8+}hngl2Vz152+=*ko=HxM}LXK#lmkC8-ZTXV5O&HdhpC zCt2XT`Prg4tO853cw{P`ZVYoH^tz_EAI#rzFc{>ZI)aBvS)Y)e%`pfX-^pYfP((Ri zZ*H~#u$l&dtDc|_Q!q&u_JMQcH^(?Q0rV$X4R+LcT9)YqoJF`#cNVWlPAk1|IKkUE zboubwz*TEI6pkXU5UXCy@TWqno5s&HUL|!?oM-D91(33 zz~`{aq*Q3KtbTs%J&vDU{r!yCg1T1ZjJuTSs@E&#ai|xXobULT+4Llz4o6FwgWmR^ z4bavD1u?;_3uda6w{syP1RBxTEwM$*G`39{Gf_c1Y9J915`L{!ouyme^$Bi!KT*R> z&`kT(H`YMvVo?mQHeHR1+HQZFdkodl%`@|qg4;Ldx zx+toD)dCU>}#W1A!HXsT$`jO#XEDFX@>Udn%TV&!kz1I+sm^4^-5v-r(NUc-vQkVtAYjaqEXwSC49R zW5EXO1a3Ws&wGFxsEdn4@yr>=9f^q)vvJoeLknuvDiEAt7nZ12MSigkbrIq-a9E#u ze|)#3Q>4Z@PeJujk(yv;>C8aa%SdF2Fu~1%&%qlX(JzOEzE&c zh4$;bWZBHOPXsA_^<-}^@_TR9(iivS>G>JtS%I`PEfM3R(GhNH%URod6`l*7`)I!~HHp2Rz)iZ{{bp zqk;Q88H6N1I(*AYJpbciVM?i3*4b0c<3{n@k9MNOV6&Zl=M+Y7f}q+~Ukf~n z7X}A74Jn_VhTlIO0mG`i(+Y+fz2x*4%hGnRz?;uSc4C|P8p{y+NrI(ZuEheja8L~O zQ{}0F#bq&0Hdzu$t$cWSgfz+F0%*~V`(B-CV8KkfS#vOxZBsQhwQQ&C`9*u^ z^-o(8U7%CRpqb(ZMzV{8<*GjN9ao%Qd*v1p#l0tWhkC~QJ(-$;3&Sc-f-G9w;OBgy z=8GRtNdzr7=77=QA;z$fv)kbKf)i7|`Oo zpuVE+Q&n^3tt3fAj9gkP+TAYeVubW0qeWXXZ6O2Ayt1`~*sJ`jF4&j0c(x#=1+=P^ zPs#yH_$8!s8WWx!3=UZa1!J_NH^7Ufh7rQ8C1iGQ!*yYm?$|x&6@X_cNRmZ7A9&7C zuiS?l*Q6=(tP5$CxEM)#Tkr#a&3&+yut%Y5$e~baW}xIfmt3=K56~uOrO-}h6?}0E z$J}6yT3k6hO78)MRXBaaSh^FEMd;Uh#Bg^8gB@qVHHNS_Z^zChv=F&yfOGAV=&)F= zBk8arQ-R12HIdOSOKYE!ay5e*lOS?DVr_6CFKbH2SXOc_-E<|tQAVkIdGY{srMfU> z9_;0x8XlF^I33{=q7r=B%X1sU*dzQZSiOXY*Qg^`rKJx-l;~na8dF$V1Tq;wuG}`# zlk5Q7Z0c4T;&nGXVt?!OU+Ygjw$t+gzg1Zi$Fj}^q~NRXh7Cr+Wl1#@RzdDG#U}@% z2OJ7gm8NxdlIrtD5?U`iaoMk$4_zCodaVf))LnPUaoureYDTjt9lbs&6Dc#iTgQof z!K7PWkSnA{+s17OarU=fZFMbW{D4A^7_Q0qfD6hEc}EAriDiLfG=dx=a-yzOau+@g z9Bqp??`Z!L?YFv=6e!2z?-xTq9k*9!xeNeptw}?2VpIyn0HJ>403tWq@LSimc&iLl zlHeKdG7%y8Uvf>T^vMk`ImH9Pd1_+e^l|5Kf@NJ6KBQf7q zot_$WL6~oODR%>JTRR9 z0nhmR>p3jnTtAmOA4RV|C^_jEDGm)}IQ9w^>b*CwT>t;||7jX-$IDn2^$ZUfgw{GZ z$VC9Typt`)GJn_j>nmW>`~jNKi-e0#7=6q(NA9Mf`3+)etb5Dzh-jc82;wCQx=Wiw z*WTZi-Q3X;nUR&6Ja>a=@<;Lb0mHZ$w*PIW4x;HH_hTcack{)D8AaFdmj_2LDuE*E z0I61MQDm<#wEH52@wfl>>neK~qBJds6E=zE-gI*V{*wqy1FmCjC#$^1L`dZHhS!;v ze}L3ge^%0(v;Cr@B_8jrGXuJLe4W}v5v&> zW)GltdQl*XNdL=ZrR&d0nvRi=Nj2*1eAq$SeY>?o`rg(*YK#V~f-6Z2Js(TmWQPT7 zaF#00f>yhS7GImQ>_&SmR_mlx)e;-g!mKAsd_|bI(jI#Jkf(kSl?7NiP7K9PXu8BF z*xzb=`6%A13=bg!`D0b#fFjTBTAlyKw}NU>wi0*+vfydSXd1y1!T66n{ww6=H9zeh ziu=)R1>bkF08IV=oMsQ!qTG#WQ#(%*;zuhJ&p=bmw&$8pNDLNn|8G2CGJL&d>IQ z&>QsGr)%PvNZZh@-k)^&%NQI&{R~a?K_%MsNX}5|yv3PDmsGL_0(V0074i+oc+Yc_ zAaM>VMW9JtpHOi_E%}6H(mH!&NIxa0E-2DojKAg#qcl!naULbIX{XW@c=uahk|f3w zJBF@;PXsa5o-fU0^uHu`%HQvf^PnjO`QwY&MQ^iILdsQm`muO9 z|6T(-1*vsZ%B*_33GO*j!)zj&vO0T9WWO@tQ9FH;%E;<|7N-^h->>3CJT0=cl<+>9 zYPqN2vO9>*_~T_tqY5Mix}b%=TU_z6Z?0jMt-c^!JKhu=GIKbtcs3~BXP=q!xaIQ+ z?|MpKGoaT7b>fTZrd1{B0O{ZwTc+BST`iaen|Y)a6+%I zkk~D`bvQ{i*+~0ud@h%)6JB_V`3w{GlJwsLp0!SVZ)mcyUM7fsz3&BGM)wo9{W?Z&Ie)EF++hMw(0R1? zOuW8|4Zf4h+f~yBmaztJ30b-*UC(quXH{*{RG{d25h75Y4$ag0v`qy7#YduP-LsL& zYJ!U7pyswJ&MsoPGEjqEdILm*kipey6fWSkAiNa1;+EtaIQjhX7$r0f_4RH%%YwlO z4YNA9f|en*?{05A+ykJg&+7zi$kyC4?Ptcuy#Cgnrg9Q?>7bERM^XAHs{a(5IBNAM z&nR#!0nNW*bBO<`PVjVYjmLMW){pynm0=GrNk(rE^LS)O_^)IO0(rH+1C4Jt8s|5~ z&A9)+{)mD0|1ll)#pmsvD& zAE;A5x-w;Vx)Tt6sG;!7rqGIK)9o#t94?*w&u?&d+h(YxFEMOujZ$>ZB7U%N8LFga?Yzh+@IYchQvOF83d%IS{fnq&7{Rb*- zR?-OEYwXc|MQ;`%KGmp2167(Ac?X69u1ku?%GLM_$qTzeGr0KP@ zyX1BC>;>04o!IX@4jJ5kWVO%VBgK3nM6~O;aVp(&o0#>X#6r$+&ECl*OeMrxkTIaKGKnFQFIknkRre2yB`{o^_z`GUW4!} zZ;~W=BCFhr#b~HL|5alq^G!LCjMd{eO9UTwaJK)}!do?a#~3)O`B_u`5_vzdp5NKr z8;32%kII*HtS6nDr0Bm;s|9+D+M_3W%!$^{qiz$Co1I|L2UD{Mw{+0!B%HZ1Qw!R( z9d7l51t7gh5&?j4>!|dBzo7AToQP^osDpdNymxkm?&BUl)j;ofxT}-@p%aDHC9!x3 zTe(K^088B{zp9w;4>s!Ru#WaEqBPY<@5;xAFXm#C>&ZJpkk;R*%va3`F_%*Wi>5oSqY&Pw;;^qn45EgS<|hJ-fu_|R^rDJ-E9$7UE#E5{mx z=Ra8Hq9<@((Ck~OKTw9C;n(r=PxF6q`BmPH)-dl>=OhBE^GMQl!u0ZA~zk5qb#-VnHhjwS*;+eA4uD0z3xX1J;q%VV>aSU0lYKsJ7CybMqJ~T zDz`+2@_^qu^+c9=|)Zv7o21Cfe*^K@vC73d66hQH>eE$if=dYR~3+#OwKes!p~k zKH~vhx4r~vNGZ!3Qk|qN;QE)&}<|-@oELvgDE~h7Oi}-p?rjPPdCH>h*r&z z`R%7aUr=>5?>q4>&!_wvH1mfXPb|!wm$Xv(RZDL7Bb*GK)797qx!Z}__XMmJefMvM7T-t#&vM!zb zYuLxp27$9OWo?H@w$kphZ%~b zLYHXCWg{Q4iF=#2sloZQ>^63MNXqmTW|JZJ!0IN~DiR-S>@4(rX$LfJA3~_qw66BGwFM4FQk{r88f$MRag$%pE`<6j8j*RAmH&`c>UOZWa>5 z3#FRq#}ecRKdc0jjo$h6;aZ+W@z`L0x6+VP4S;Bwh7N?157PRM6)p4e&urDEN88ql zpz|=zy>s(k5gsWy0RzPr*DBg$y1^AQAI&uCY3KEtH)$+)iEU#D{RuPINkpD@%q5HR z?Cy39^UcNcEmmU)fskRUZj2A`jdgxbQnZzWbZ;`s?x6*CD$k=oKA*eK-4WzVD;SvZ z0Ync_1mf$8(2)Nzjo9q#pTBNN<+-m!e)~sS(sS<3Xp3xVr<+;_$4W#Q~ft)B<4(U>v|&o z{~R1911i$*>Gw3|E3-^tP8a7}`52UhiwfQQy066h(4vck2XM7kT^DsYk~F;VUtzQL zvI`!{pp99!MBi|i!u90vz?790|{ujz*vr~}e%tN5?EL-~TCdYRV z)I8-{FiTCnq_H(msyez3=yZeIdBr;KV#6z2sFWt3MsVZtZr9HFl9(vd zX8BrpO3aUd&UhlZf0qPDHT9{t0zXV${0Mq7k*UHzzHb6nEK*PMgFLq>*1%>GZ%(}w z!!pyf-($M7)lH2R_mq;8EBMrndP>h#%V5tC=OSaXAKwIktvi!v36N&uG@aJl?fYQ; z?~oswX$4fD8wkPq{IIw4LB-*8OHy1wTl)fJP8}sMm#tl(;F^zqz9v-X%)+d1_N5N1 zEonu<6o8vJKe`TJxc6*P$g*b9PI1tRHy}c9pw%9DX7bT-$hSXJ5 zWy&6w{bvrtQxhh$K8i{o9wN|kUtN4T#h!5u8D1P8;feT=W)Xf7N(LMq_0niz!<1Wa zlEu|3Aovj6a%W%^=9?Vtu)rGUGm|A>2k?oq5tpoG)dEZJC0?c`tEdKQ+%l$R-Obbl zo!ijSqrzm0;Ho&E_+o_h$AjPj=W%!ZfP&Nr&!HYIaHt>+Kuj3_xtON5ssS`a{>J

-6-?(#lq3EM1@x6t8aolXvNteFA_5< zn$w>X(Qm!wnNLHZ(@-No;{lIFWW3hN7KRL{b5*4cP)cJRAsvQy{x(Kg#rJY}Y#N9t z!PpEQJPee2QAQPXN0~+l?Si4yu`={O+Xz))toFUa+V>nmnI3ODg>dzU(NNPHW%)@@74uqF~!rr zf+Aleds5;`{A^#;5UV9S`xdzG3au-jfjF554?D=pG5g|IfRrJ!NJDeK#aOUrVrmSh zXAhHN{bDYM;C3{p_xQ+SZUfVRDW_{-O#uc%G1B{FK?t`*NPot}APcI8u^2(NdRc!~ z`pl8j=CAs3uV7}Oo8#|^oQ_K zW6g$khmG1qIpD=xuH2g47lmC$ULE*st(xD#Vwnx$hK|>Lg9`$qL8Q2w+*=$F-!m?O zYP@RW(PhpdLN+>SDM2~&b7q=)0w%ZljQ0TI@Xm_73b=%nX!?-gP0}731E+H|e#2sy z&!a*7IrMsN^uRNJ8JIt;K#_vZ)U{?Tp&z(G)ksH)KOg%9n%NLzfH;4`E2G99rAD!z zf0#tCK>z?1-$9-pWRyf)EB^ohT_y?ClQ<<^p~o!j4Md!4_8Zo>a9gD+&0CTET=&;fLk|C!(^0WmVZ+2MpC#+MWHP~Xm5S^Zcc4hXC z-aN}l{w&>hsS9yL?W>bz6pc+KL5pb#z$$-=6S9y`PfYRoy|2#CLum-dzlbAxXDv{& zfDOOjwN-5<<=2ltQMVWP<3JSt$P?{qC}L$;7!-FH)ALS+=+2a5t}9bcyfuucoj*MD zESe~F<736@-Sq=?TXTvhL|BfqZ3Q;PyD`(IrcsqMzK3kgSV%CMrt2UjKFpD&K!1s) zXe+#K#>LiX+iV6?h-1%lN|qM1*}^j)w$yKE-inZ}RXszLneE5pw?*BOa~D?{hO+%F zn#W~J3%?^f*{r9O$p#ve%Y}M?EtxH_rTMaS*oDJH0^zQIk8AFj8ElHBOb@M9%(vc% zLNRQNCHo*>8XSE-))!6!#BJ?}1bUzU-d*t2=TNoqT$cJCNpHeHNt9rBMcSO>$l}@Q zn2#$iHfLy822>F@ty1B{Ok_(x84o$b-<|3tFj9%F*88H|hHZ%T(hNO( zg4C05=^&RQr|!oap}yMs$Z-^&N`%VWQj>dr+JR+&Ypt&-^e3+s5T0L)=dHOU0C76$ z_*s+SSpLnnwfPZakExG?II-go3SiU5%UBoh>n=QAO&VH>e@Xx!O=tNfTeLJa(&Soe z+zH1?`kv)ZiIMDi)|U56{c?qb&rPMDc6TWSruhE<0zhN|w>I~TGV!}hR>}%8o&-wM;{3mr z4Ef7K%VleI?5kuC4w@bM+6$AF6*{SHq2FkyY<{QOksm|Y)$l$V=8cg&6I7mX5J!jV z8CZ=9!fHk(DD>_CKQTM=_qsTXfI}G$f1Th)K4}Ry=oW%p`Ko3C=U&2?T)Okd%+6NN zbT#Uz3vC*IG%3#uk1H{olj8^0{^8u%bz3dfrmY-g%!Kav{Z6@@t(zL2JbvsFc-TBU zKVxIspJ<4=h}-}c&xdez)wnyoW!T+1 zRA!wP8{c9PLBkX^CLrr;Te(Pn!*$eM=7Tdr;6Mkve)t%Yv*{7 zHTypWS~!r^qZ-^HTF~}j57~R9IanY=T2<*Va(`KcM*FgC#Dkz$PhM0$a4FiqV;PkW zCKn7-!FglVc1IhDccx&le!1^%%8(7U;^c8%AnuF$EM4@F4XC@foc2 z+Hq%JcXkCFufJcGCd6qJ$^ZLXB+1Yjtk7?YXEYQBml#Tdo<4Hw8 z<7cs#V}^^2MK;NURVKF`2T2mh}*dC)Qs-2h!cqQ9H!_)w%x(mLVRHBz1RAz??& zT>*qU`fHexZ_99=8(A{5FnR+EFe&rjZ45QMl~=jQNR$(FuXyqOd2jq$JoyrgmuKm$lx-H`hC(JK7j-sb5ecNi0AW4% zQvd8uj3hm<`=KOF&a9Kc`os zw@VSbUblF@c>l62ymd(61Ii(I`kKUSqo*g&atu}tTx>1i7gIAnT`R+w+)%*MkiMI( zU?p$ONf>Bc`zKnrE=541;Z8*tva5cB2R_;MQqx<`CCXCGLt)X>*fMA96mc6t4&9a; zSOWlz0NDqDXP=u)uf#fFj1$*GHgvpdY{bG3Ftk-g0NA8V(W2_T=ahpCefgHIefL zV+XlM!Lb+S8*~iV=&z*8`G}FA_Dh2y`+pzUnq86?yOp{3nGH51UTf;T2kmUGjeTh}>uMF1KENcO@nQ?l}cVOkU(uFk46G*>wQp|I;lxLwl z*;ALEf9;^=TD07dBgJNXG>C%Xt=Bw3{sP05u1zoiS+nGt@236>S@2qIqgk+hHy}kx zZ@=mgCQYIW#;Dqv6DJ(~Qfhn|#IxXJx)IB;%}Sv5&0O0Y3c6GOxk-E-+9MF4*#}!Q@Ced?(4MkE@~QG zc5Gio4wwp{P);M->+RWB{Yn?G1k-NC|98w;afr4-3?88Rz)eP`yS47qq)2J6Gel}> zpwqef^Oo2{NKHFMot3E~0p~QH~+IC0y|1>}dIh#Zjz3 zvw}Z!7ocT0x`DPoV*$QBab6!Ay!k#Rtcf~rOVgKT>C!eXsn>IMnx-=;>f*0&e~Q!7 zRwp&*nTW)ZG+6*g)G3|(!u?T%gr-^5T^TDib0m!?{$1Zb*Pm3+QXab?Hspxavj!Rj z7`^4!m9#spfhq|Eokz0+8B_bDU_czwbAI9?s}xY;8Gz3l*o5KwGjzTcjWa|&0Xb5Q zWiWoljEyu7ny9T$Q?mxb1-kKtZ?oY zj*CFZgXXJcgoY|pudOD#N1$vwH2gB!;F^IA{@I^Ce#$)BcyxaU5kk-u6v(<&@$#w_ zsV|$KeGGG{igpHT$(6dXcWfbEF~hB&`uWmVV#ivAN6loV-td0!HyqUumBMm+vh+w3 zd)$kH>r*<2C&tn60XFw*_~PUCK}&*Hmj8fltqO^gA22E@TTdS8w?dBN42-eXeV8-b z!q%85X2dq>(#XV_Z?vPnMuLDh)Sm-aKV1JXtuF$jXMTDVWM3n*Ac$TQf@-0{JQ|iGXogv_k-K#JhU3_RqK^ipyKsopUaGr!brXDo| z=W-U0!u*(C+3Vvi_PLo_0>Ds@-4D5JMMa^14zj&or0$8m7R+qBU_I#*SyyRJP?5hW zmrCKQX`$?9X^M^rge&8_4+mc9V8j9W2mEI~!a7ZE8<-TcwLQQ>iZeAww#v;~eb{$? z?UW5JbL}`~>yMr7z<$`ypV0wl@iv%=jTA0#3wrNfeUUa+7^uy;i4W@UurChA8Qa<% z$NP2y9q=mse^=WHMj2}PD(YKXFIL%L<~0&Bh$f}_{?xKZwSQ0GZYbNy3QO)P3O{2| z#Y{Q*(r18N50IKsrbIyB3aepqt!e5#`ip5LwUx7LVorpjoyRARhTyl%*_Qu>Kq!pfDv<@GrdV zj0$=wnQ|iBsw^a|x}-lPLCdV5l$R3C7)=GfCapG@*&%H3$AX_;i-u1st974?6yA4Q z9<;+xtT4D0CUg5~GXT!YWU|A4c+rF_>VfT;MssGKWYC-+h@xZ$-V$=PLj3dj-)Vn4 zgXfK0l-l1~9xBLkF!A^yeXs>YhI z2{2`c3^cZYJ>_tT00K2if)jv!YbKuB;Adx?>n`y+0Bk}qOaYe)09rpubgl<7ZCSG1 zfB+Tf(`{aVu+z`j>@|XJr0|?+TXu9U;=VH>u=tJLSmBUTf5HF4fU};@1!ef2C$$_) zA*H!BykvS1`nb6n?9aKOGDe#%#A&r&{YOi6DT^#2*c?3!Ry(t6nJ%hn}n7HjO2f@KwQvNq16%B{F8d{1&fYa$vgw0G3T&3r_<8S zJh}xH!SqYo*v=QlTpwLleHti?(d8cZ3?)cl!FGbAby(8iZ;g}Jd2<#YpQ7bdV$6ze zad~0;+rQd8!8!XYb?f~-4rq{Dw^hsiF%15_KboMVtE94`d{PP~1EL!KFqRA>hVYf2 z+ML$fl=!TIAh^9^OvxM9)}YE6W#=3>8Ha9@qk#{dGR~9Y>-k0?wWJLw@HItF4VvX+ zw0#7<*TgdcB<&^YjP({u`)GCBZ068+>&sRNh)16dl&?txH7R0Mgb|r{yZy6rGP-$8 zVkM0zqAnkNoJ_?^w{@{92c5ME*JW4~%Lt2%%ijTT9NyqK8qM!i-o#qVxQPSBu095D z+!v7|FrgMc&^-e0zZ&fV&>fG$4eT8IX2UZ#;Nvk+Z1y;6_IFtIa4=`uNP=g0`EK#;U0~fB_VMG2R^)m3SA9%k9c@@4)={b;H>l>-`^G zqkc^_Lg()ae_+J4%<1{=oJg4Hc^V`1=}`0Lq@DUa?fPBqg#sJKQ8u?+Cx0TrE>w1^ z`g87uRDQekTLc_;h3OO)_hFUFe`bd}*voKxHH?fPUjf00=wj&O0Vf&2$1ytrdWK&d zC^Fsp-Cnm2%MBarbUJbkNN1`)ssskK;Pk5l_xI_1hpJln4kXc#?HNh`2a*O471v%( z2MKo|HFjAZBzGLIcf0rFgH|l+cjiaH6D@sDEOcqDEeNQg^tr68F84lKPJwlbF%=5l z@jQ`v95k2%tytktUpX@ju-(HKQd9SukB%P1;%W46PyH+D57GD%KgG^s_HZ_Z-10D) z{gLb3EbQH49B!1QhM1(8m@q@$d`hJk3E+%v3o2zx-;9(DJHFx0##F{=@-rmvwVssg z{vZ5H6oKcsv?u{P|5DiF)+Y!R{~#}3|1Ps0^6K~qHh@V0{bqF#EMzKcG%0w?9?P^0XW&f(s*yUy%Ev1y zvn>wP^d+>;ujz~DT1SCyKJoV;SfoTTz+N2lRy#>HiZ!kw>*Guhi`XBX%D;G5gfCQ> zT!KyEIekkw=(+Bis!P}-U$uE@Ao>j}qyuYiqp_T98+KA$;jbB#6bCdg_{6#xtAO8R;iE(=%_7+S2HzcBW$EaR9h6 znT5BoBR9gAUo+C5l=#JsY~iqgYh{Ao zoSxM@41=YM+z1PY@&n{GCr-ils%8hXZ0txmOqchoSKb6&ma_My*WYA zqun` zdw3s?92Pn$Zl;QUTnCC#V(DsVR+Wo##DagMIjKOptB`-4KXjH-9=~>=VDD`#QL9q{ z3jMXIHdra_M`)?2_DYLHru$dswjOLo;_9D2iu_}5j(STP>rUNAwNc2>EjS4B7=GAN zK4s+mbfX=3~g94k8j09qo>Zcq_-#xKD%m%4bgvwG1{FPl-+SAzle2|2m2i6kma zHm?jjbq^tl^JFhUHVZ>1FhttvfjWv5%NG25&pudwO+nvmM*k@6ABr4X{b%=|kN^M@ zTmhavX%L?P08ft|z*LaB>WX@tdAqlj)lZ+tefLGyb#6;r$a` z@1zKu!dIS)NS3SsJ~3>hQFHnR<(sQ_0&0=b22iG-!`NfzW$Hc!YSI#QR+;?e8z81h z0s^xw2sX*=nn!PjLNSU6zoAkYb;eIc>rV<^=%v-H80Dy8DycAgsF1)Ax0K!8WmPq2 zklPw>mq~~;SFY5G(s-U2lKy#KkXsEwlW#S$<@=Dla?KQ_VqUF_dvl#k*u6h^!puDI z(1u8ydE+VY(5lVRHu%4_w4yurCJG(265cS%kV5tCM$IJ8M09Z6Cyt6ir zbT=4`j*jpx)1vfIU}Abg)wlN|mtZ;16M3Llo{qC)&87-WbSgZygcYnC#TyCnHLLGn zePZ|;7e-2GlxtQ2=H)10tXodNxp`SV-=9bnc+7S4-~a)qaVC*^K96nH6a-_ZT?x^> z6bC6PY&Tus8ce_2ula4M8eWUv6(j!mt2ti}kMHLbAHCXA=ZKxXI*|H3ZEJ@%4y<#F z8Y!sT|Kc)k5b;pI9T0fJ#(o5+L54w#_pv7aVlG28u}28u1`Vy_bw~JItavpcLAb&9 zb9(G$v2FwnTB|vRWHLY2l25$?sQ80MQ1!!Ey{kNDleUnxuwM6c8mG%LfTR&)0xN$nG(0OeMx7H=X_8vIv94H~J#0221MU z6gGULK0K|!ImrQQbwKU1Q37jDg6>5F%(y7cjQm)$iMNA>;1>FUBCLtpi81xZQj&Jo6=srhR+P)m6t*z-70 z{Rk?m2|P_MbFIR_*-4AT>~F=;rLF8goS_VTn@i!pAMBfm7GYZy$HJY;!)h83SCQU8 zA@S6Xl76_QGx2W~DK74QQ8n=uSpZ6sf&vtQ6n4933~b~{aK5}hyhHq{TJ+e(%;&h> z4@}p(vE0<`MV_u%V=pCfX?>eP#6yh^FH(a$SM}b%u1%H19#uCZ+bIbDb1+)~A4fCx zd(lT~6eHv4g5?1E&Dl1h#_pV(kwLXpXl538yB7-U7 zO`x2RI7J%pd(O*w0bc}55I8DE*G*+GJ+hY0l5!Gs9$`0>YOxweF(r0Jfc*66NFtg! ziH0-F)h+$K5z;v}dahQ+C*$eqRmmEPnb>hb>z9qTkW?6X4avwGgi=1HFh~}@)A=ad z`mM*8&;$2%ntxqdsQIbCsUfSK^>rE%4uF>*^#z@sbt>4iJ;6$mSCwGw@X|9a% zjI4H<>G$HGv>{h{3x?x?%MI>bW6;<@eZq(0Uqfdrcza?R?N1gvY1I0Y;`#0ifiM*g zUiXR&OrZ6RxNZ6UQV>>wzpaaklfNLzNZ|4ua9C|6`jN$@z$?t}+G;veFy;S=d`^yj zlFNZ1F`zTL&CaDvSU{mK;BU*x4JcO4)DlTYnK-{ZOV-D~7MP`7D0SX@B&;tlF!6f0 zwA-jDJC)$jfCIh9q;UWaK;Y>kYfhD(v3(J3*jGfzIb%hbFYyFU3}PHYwrnjJxueue4F@5 zDp(r^<_(6GJ);(g0byQZQ>Qfh>r5Ps4R@KH?K@c3>D7$M4rtbejg<#E8{V1jWvggX z`N6S&hJ?|_#O@>c6Hl$)7C%Eqm0CWq$9zBN6(4Hv&Yo~vfFIlE4iDg>*UVRaOZq6bzj{sf3VsMw+6MT$Nzk86RRC;dTl>s zz0NNVDqL-Jx6x_G9~p=ChBs!8Kx+MF^>3w3o?2VKVqFJ+6xS1qxWo_Yi35~rzx^X% zXd)nyvvTL|hqlH-5kdh!|M@e~3&-wP%Ev#^fd2om6gI#9P%`F4D#Py@q7nRE=mdML+w zDK6yS2I|XdJeL_?%NyqBNqnrW|F%cwIYOKYcJ8?2VF#j#+d6!`yAstlDZb4OZVj&4 zTeLmw$f*noY4WZu5l?;4&H*$%Z8{qPMvN9biIwchCr~f&{F|yUvXVu2k z93_M64Z$8GZZ=0MNnmrHQfv*-P%un&<@JM;-kdO^at@)krhq56&OE}q+~D|&B5UsO zRoQpj|3|aDCK*C%GH=ADMIz-;4H5{m_^>?w7n@(V4Nm1?QTrAtT$W?*2c(!dST0!X zi=T~;h0SY)9oAvFGf$F@`T=9-8dsjznU$a`7#OQz#$F!}+W?PzWwSHusS}YGU^!aW z_}r;W^C<%oas}&O_u}!dHHUb2UkQufKTERVJ2bacR$b-T5mJ`5&ny7uR$WB&%nJ}` zCP9LM0PPGzNIB=-n_b(BylLCb)zi*3IP+u{@h|0bvW?T=b{0!j&|`^Ddn!nL(JTE{ z4G3@8dAhlEEE$_r&LWW!lFtYKqu_a*R|=VgFIVqs@FP$*MQTj^Tp*Wk3M;?tG!Ced zU9%>wj*sn2Jn^qKxw%{mqFD=MkHea zHKag-O4M9)f7VrS=Z-P>|Dmq6Q^y0~ZPB{i!snRvjX1;| z8$T)$H@M#C-Iz)0g;dSvBb3FMjv&Xvx+YuIPM;&qjd3m=5zV$aBX{uN!6jm<*UGaJ zeTs%-(m}wmTMpwB%-}d=+f)X^CtxXG;NK>1S``Zxg<2OVTr7Lyb{1WQGE%z{NbW~R z80VYQ$DYL<3f#_KA^^VHh7N+G+{@c(SebY+5SJVYpR%D|m8%{`u!+jMj_4Omy!DFb zw^Yebs37$*SeP8^SdS|#?_!v@%SkUe67mul@J5ZV>U1Sz5|@RF@{Hf ztnX=zQsvrX{|wr9cqBr0Pcs&b#i_Fx$3BdU*nE(OmQdv8@lwPhpT9hk}Tz+ zSeg`GQK--&_Oi1+)B+;oSStEm9P*1qk>>P1uH6a~R*0sd^}C%TU6H3$E>f6T0$W=O z*6!`u9scL|CN*}P(4UgUga%lOP(kURrFHaNv|OIy?k?5XWUhnrIMA>D?~#b`dAG!5 z*7OM_K1QbKTI*);aVPxnInm%i2`k`P7!_H7W()!27Z;qv(&+#Aq_TUoZxO8qBaV>Y z<~#Zlx`zw|)+A%YZ@UN}Ug@#Kyz-LPq-QLD3V7Czf4QkfL{`<9DQ%1@sRVf_N2;vh z1Sb=wek8kYLw{VWF#rm6lJw7yRRxCn0c3>MIaBU?X(!VDK@!*z9Rl`r@8cwkfP}@T z=6PSCY>=kWj!Z%2*WTvMv_Wz_;%aGNaU6cn8aDS=a5-m}1j$M27*b>-V}k0OCD=zX zI{3zx99b0OT1Y}VBm9L5=(a=^#*^K*(-5^Q0_-R?Jh6~8T@dtmO@<+iQC|;F7|=k? z5N7Rk-6W0aq|90gG3iGVs-jJw5()FKSKp=)5E{)gE^@jC;7?Mec1G^p@nC#F73A%E zr?Eo7jnhn{_nTQE6i+U@hKQ~vMAoww<}B{1+#{;4HF&W>cHtsz zh3p#HgZ`l5n&6Nqp|8Z@!TSL_o2uI8dLbSnoiyvL1@L;mH-B;8cF$~dcZ@z?f45Ip zjv)yU3UonuyAtivSMkHYuws){z?T@B)fU^9D`KI~eq<0w;;ftW-6k*k^;mb~x)AhA zJtBew@%mX>T(&0(6Ep{gw0OgtnMB-1q+pOS7D1?qZMoGA7Y(#mcH z4xZ5k*yQ^Vs#c??fPG=4PZI$qw@|PEoz?DNJ-K9ibnZVn7cznG(HZ6AC_kLc`!O3S z{9|Wo-n@s2xYr_P3T@awI4?npJzxl%@xil%<$lBJy8G1j+g(WS=BdsIonDro1oL#N zgn6v?e?_MPuvPekZ7$Bafb$NFPS%UsiR$WuY{`~diA2<`^|-y0)Cug=4@*1F9KT2q zP%5H8Ri_Ug@A(Ej&v)!hAtVc(Ab-itJW)oDlS%_xK35r96@%ggK2RV*FBr!gx7Xfo zBVJ>@+IDPPn;O%6xr&5%PHJ13?S+P&XtP5H2=PLAe977Fu-_5kkgm(rz?%|v-+%m{ zsk4Bw*xdC|K4VvEum0GN&|NPdd(!=8^!Vf~2&&e{rxkIl{Yn>Cm~$6(P6BVCMkM_H+@D4eN$r}Ge`c){ z>M`9KC~MYcVuO1M)n3t!xbMbMzyJUf+yS0HZbE+m08gMfB^ol$TADm%wV5K9>s?8+ z$x})7)o?^K03Armt|-Wn`5_i9iuE~K3JV>(&aSKATwXhmKR#20{TZ^dkY z*(mljew@J;5#odh_H*>pa~sN+%-OOVYHZ6aot4hiJ+h zbZ1mgwOPCcN&FfYMnSlJzEpMHjfp!zoYF?T{pUiwx*EF7!hk2oR?-wGJ=8ezJ?O-2 zIw(7h7cJfRg&^EN<9_U)E@T5XLs=Vex$qtPWEk%D6bM}*tW-T82&?-vA0q=DQL>c1 z-_$vrF`1{L>`q=)9F2KTRVANz4wU+AFWxG+nixT#T#RilN!S#Sm+YZ;I4AuV=V9W3 zWRPbX<*$SIGK_+5f4y!#`&upVC~jT@1YYw&EtR7Q08z_wxVtpJpAA5W>IYT*-)OsAbXB3FcWp;WXjb7u&Pbs0aog9He{~ zbY321PCdeIDY54t02R<1yt|>)Mc@BBGP5b^!@b+-rLDKrT71bv`Uv%0?^sY|;1&=* zY93g-49tk95kPW*b4yyN`#C4%Sg(IwOoh!3-QKI`@GG0?R#~!QzCM{qcZ8OF+3#Q9b6LR&>Qomh*J2pdC7k6X}{rj+`a-@DXCMx`KJO zLG2;)v(R2e*Dn?H2mUuff}53{WOL%LEbRZg1Y#|C07I0oGd6AR`d5qW;CqBN^#~GQ zLA0;nzd$z=MV*CqxXNU~mplC8PY2j}ShW}NqE6YLwUWh@zNSEG6IcviFn1MXS|{F6 zndW}$z;F^3$>^~;bxH2c@m@Dbq0XYqwHn!ow5B<$$q~v`eJTm{(W!;K=}Mj54kv1JpYq5@>%c)@(!kA03zoRvYN0RDzBbOOqiR{vx-O z;lpaW%FV1Ed4A{DkPgP*-;jZQ16y2hJ}Z+_7rpG zx2zI?ap_zcB5&bSgc^9^D7GMu90S&y!86tyF*K(8JH|Ogsw#=l9(T5d)t< zEt#!>-qU4l0-vvv9DwF8Ek7@vA@`Q86he1-jEnL5Sc3Q$9mvygI>fVKb|Kgqp0hj_u zF|&Cx=#3Yulu>i#7-kY@hZB*0t5#^Va#<81!5i-Wvl0!W1NnDU^2y`v*bFtBwKBaN zYe)YsRo#$56rSU^7t?n8nJmd_#xo}p9%UGtEu_J=FJ`T#L-e%YqP~nFF;qR$`e)+s z*2o`oA@c+N=(?qLq_tS&CLM$2>03!MA(XOQ&<{S>kLv6SOY5`Fd|az~@2(%u1b zNxGZKjCj1{9wJ0%97gZ8_u;LUFxZKl^DAFY?(V3j$o36h5WMq_*=j1ecjtmjo?q(< z1$u$izP*{wLUR7C;hg|EB}V^Bn1y358Cgq$3MKSMOr4sa#lewv4w%I+J@MHf4jBMq z?2Y~(Gfxyp4yFv~+s~vYv4xiPG5hCq(mGbyZ!S@He7Rx-vVePOdH-V4{nv`=2Wy}e zrPP8%;XYZ3#K!`oE6uufE!V^a>grhP#XoO2} z$ys~ew0<*t`qp_+EH*@y45w`;SEYM)-8SHTd}Np%CCk~cO+anen(HVp=0!BVT|OBd z&%=gvrCN>8>vwDA5X7~q3>_S2Vy2Q9Jo^1zLydM6Xw4>Q>MF#aosv-WiiH}4-CYJ^ z!H!SE%7em6l>fk=hr1}fr3o$l$krCNHDmQ{LjAA*o0(9e)ua!suA6vktp7%5-Z{Y( zA6h2t;D!>qwc@`MQHVI-+#iUCTc4i4(^1kxk(1L=g&_v-yh8I;XZ;RBG?An(>SIa@ zJ=5UqdGH}*P!8CyBd3_l`U>Tzr{J%wI^CZ8G@LU*d0td~QKbcZ*|^_c#iFi;js2up zV|hyy^8A{W%gO~d+g&TUE3})Mh)Y~hnxrDQIuUKK&K7c1>-aBK9X;l|FHr-{`WuHU zA%RYD&YdL9-P3efyDU)?8zDAzlJ>kk=T74)()g!u+-10^KfZ}^-BR{g=Fn@H?^7B) zWSOxg9}1IzhH(&_a3a&(8QC2F?hJI8Ym*r+;q@)TQ^HmUk9t6bRzdW(biFyNR-n7L z(c>B`J;DGRE#mO{J!lRu@`$|4@T%1T=e(H!1WehIotH$}Ls>e&=F>|GDyR&Duejns zj7*ClOZ)@xKihMzq8{ZOQ$_sHftWG5nIGq1X$bVRB zJ+^o}gh|Erh)5>-sD?i5xb?>mmG#7UcIj2e;Oz9eTO*G+(*k)gjI%`ahiZ4N0jq9F)xMnc$0<7Ql!ql)kVd@??VcpXhenGt1efLl9GMNS(0YvMKI2+ z&pO%1y#Zl)@tKH?uaU;Vdb4F;LePmiO)k*rIw&H`;S=d}VorEWvlQ1+(lTOWP#8-N zRpL`u#T`I@p8idl`2P)sFz}xrQl(Hhokd=?JeZJ^*~rpJqhE;g&^~OsQ@vFTkrsH^ z2|WfN*;I}DZFa<>V#?j}4UW=ktM3xUe;cYaGVhLrW&5vm1T zN~;1s6o94v5`PIQRBrsWC1I^C&C+$ni;Efb&7d4TCkE_Q3@ByY`(vC`?k6zh9MYat zOeu<|Jva>gG)NXJG3*&8yh9DRizr)WrjiHcuz>}u#7_!v4o>s%c<%MkR))8!6H@M$(QoirM1s@O@M7u_H$%6NZwW_^5?K2?mi@hK@j2Vx$?rmb zmhjTQhUnmgc25>R&1)B-UyKJ$i}#_(Y*}|NEIGg-Ki)RcwoSAirv&g>y6+23WmzDY zc@g%O!s)wvw}v#l5WcDlQz$`Sd6m%>u|y|O@*_4DFvGM4Wib1_tJGPv<5a$`BIrs^ z!&wZ=8+|cQ|KM-jG3ljP8hl#MM-2hg@yr!v%=>x1^k4;;L|H79^C~ASd(K4=ye>E6 z%Vn$v#K>ok#SWXNhR#q@E#ruBy!hALm3nB2xx4QCd0jtf>P_EPjx-3Iv18MWg_WB{ zLcLjTqA_-ag+9{7G$7?MtfGZw6A%`4t7GDTcVc|zaCE8wi_t)+-3}~cdxH{9;Jo9h zEyF?^D3o0x*LxqVd;zRBm;d|&P%jx2dq-4aHdzM)9*WI`Y}vbU)Z?)N4SSyk#NICe z@AB;OZryNc1QC|$lt`O`inimE9Tv{WxEDe4zoHQLrg0H2oRov56uI((0QJ#lSR zT@>_eH2^o*;e$>(T5^l-p%$GwUx$@6(v3X>9VD3{CG%G;5fRZ5_=9%Gotlg)>$ey% z@x07^v??xORG4fYh3dQcNL=``3zmB#B_Yvuw)Km}P(FUTsoi8UF}-WtN%5}W zv9hI%`!76y2GKe<79bUbsVQYU<*MR%6_`(*v0q&qu7jMX?_-v70WVKY2v}g8k@oO% z2{f4y-&2_fYt06g`P>%&ls-?reS;+<*o9x}x#?sngdVaQmE>=vX>v+u&|leJd$#w# zzNGV0llV6F`H{K&93^{)A?He$~#X;{SQX5-UWScc;dgk9EZMk*|9`m541BN{ z-F5Ep!QSF1E%ypGgjdmlvN+*OCDd3a{CjYS5C=D4$PUR!^Ed(ia}}Zg>+NqM>rTI2 zl*Fc23=ub6i|Pyfgf5@%h@ipEJerS`ni{?ghpFSzE)o~g`NN`yxi>UrGl8&p)I=}K zb=phqt0=E7mUE##2Pw16kd{L>{=WVnhK{YMqhBY$83Zy*^75{QOURK}B>q zI*o)hKmY+<0E&go%7E=i?V8efv1onN^QyJYKXYb$PHa=CTm>af-$_nNUy8Nv-i;UF ziF*$~9-wV;o#->0@c;l+K0%r!H3%)KGMEH6|Ng2~000g- zh&<-R+>}6$t^#wP+iMUoLvZ~GC?rR9c?KQruHcl@C?j*Bj^G3AZ5iJx83B^aWfx1( zN*W)X22apZVS7l&{^zQZEYOT^d_P%NaW&2n1jWZhA5&Q^2FlLnVOQRt+%^*948Ju| z1;%^lP%EVNJplt4ZjLOS8iTHB!YaMKk~;FnZMxh?43Gd6(u$t|qSYAKv__%#ep3iK z{D(9`+#e+ejEd0G!mOGLdKr~FSg3JlmkAZ66H_lD1{t+&&=&P|6PZdTfM+AeHY!i( z_$prj&Q%t%hto+Tc$lHYOJ7g?G-gj*-Fh;&c#xB5j?NV3Z>yiwBoS4)hA^U_9l&l~ zd}wrKDV>eTHCE$2^{n#x+Bo>GWTMPQV?(AQB8zoOt`1g^FjTYZFm`CQ!l}~r;bY*( zFD_Y9VA_HLgX0JJs;2r26C8c}c`}ap{t@Uc!FH)mFC5NrR%XGFi0`HQxNdHzpP!xS zO`}*A4}6jPqw|=T!<)M*gD3xdD;9){m)}sgH!pqUDEII+!pS}aGOGg9mv*~=o`Jua zkb@e_zEc0Fp2x$5-SwzIQ#?3X0mu0Wq|899v>P_;N#5RR68#lV0Inq@Tb^3stM z-tN2z-~J{=5@>i?(2gzynF+#`q$}Oxaje>+ott}>_Z<1=1SmGc=RRJ2fk}**zH+C$ zO8gWD=NXx_UGkxjvyhZMQ7LVkzw0Vm;!J_tI(zdN4*QOSq5d0UghwFV&8)y-`zKE8g0pXs~-LBXkN&N zetdW)#eKx4x_=mVVEb+M8fBY`34hk0;XFo87$*{xkHSGcOc^!W8|y20535^zVoqfB}ArO;+f zcwyg`&DSft_r^@U?M$y*p1o2(TXLRfc5WI}NR3JP)<60l(cpa9?<{omBoU)fa}A;I zuCZS-W#-*dXJ0ImFofK-nx{?5n7X0pY%3G}GCb&W>Fv)sak0VfyK|FYo3M7G?>8Ms=}!u( zaCs0wIvzxSJYl`8DN}kwPg(qhs^j^IAfgQ_xZ)&VQ`3y54YZmvC<{<>W(~K3d4QR| z5XLlSI09`KcgU%tF;sTxK0{~FVW<1bUOes&KM_u40#@^x(rC~$Q^flT1{s9cS&LKF zrUF{e3lB?iayrWYe)=WRg>f@?!bQFg5&(I2)3xcGTfS2Y?aGFPG|RE%$Plp z8z}kJ)N=W$uiPoF-e(N|{{s5fOQ%X_K;ZOm!<&<8q5j;1u5!(J+XoMWLEdtR_xcB- zjtbFBJ7yma>|Zq>;sQ&}**;XztAYc`Cr@%!LP^M^(6~S{ypbJox7fa;Bq_`5dRK-p zqqymm8zP-R8O(j^wQMJSTLt04@j3I=E9;{m?sNi6?*%1(jc7T%G$cU@yGU;fgmpMj6WP4#(b4N@$_p(_rG?gv z(Ak-*i|tWEJZGWlB7s)25ZH-~Km#qaj4QMjW!NRqEcwk*YVL44Of~M;%wGvLrk1mn z#K@vOYc9H_-c%$-%8XpPkZ7+B|C>Na3MCj!Yt2@G+8VzCb43RtIG^jb38^a-qEvSy zV%JUzL>@$D`#kO^XE#DeZ%82v}^PrRaNk^Rs$A&`bvh_j$L&o z&rGH#^UaeSYcJK$L?Kt0eFtZ&q*OvOLUhWG*EE6pqs*3@x7UQLb#p1>xOh%YQUF>( z0>@Sv_msVB-(cf(z$oLg`NyU)ym$Hvd;=_y3p3^vN7@okim!dAwSwtA1QMou3|v$7 zX&;9jMEP@%nR;AcwEWie0824F!h*nd=C=l-~ee1@98S}WM1lvOrAYv z#A~O{2VE_=ykgN-b>?>48sYZYf_1|H0^ML+3z^M;O#k}i{)U2M273z}pVc0DG?)et z!W>c~{zs_trR|q8^-C453y>S9V;aGae;`Ty+KG&>Vi3!vDF%W%@+S2lPZxdLDJY_w z7!bhmIR+yxSMv>yJd}U`o%&Ecj8}nJ+!2#PIM)_cybDLhs&NU%C zE1-l72E^YUJR{u#!8L2K=&^Q5Eyzo*(@53rkzzM)7r}g}zrm{yd?r>8UK1XgtoxTJ z&^pj{YEkt*E?tl;YSf{R>mhH!c1ckrX}w z?Y<8(v)F`TGF<8aq6o%KuqJl&_NouHD+`dwe6gL z=nIF$-?E(e#)Fr10H7^4{-_Mi0sQjFI^|q_NzO6LV+J=cIViBv?@U6$gSSX+;PGrU zKOm0seXhrDGpgjXIYw_@#CHTG#`z?uWau8nC66%A3l4%vQD@N0YL+9_c+QcXafN4* z2&>7lzyJH_N>s&PQ9bH-lOl`Z+Zk-m{VFUh0pN5hOnKOn%r;8kw#t2Ts>L|6e_6L} z=dOXiFZt7oLpR#f*MbHjJ1he$I^y$(BJYVPeU z^P2S&s;4kHNcgFm{{yPLpz&Ed3b@{1dEDUaw%`J*E)ZNfHtM_i=@VGycTmG^)x^;Y zW#}8?W@<79N0ob%EKq2<*yN0YG@faMf86*QiBmeeTEm1O>SXaBx#>aBo|(G*0jvq=@P z?(qK7m2qE6HpCVAzZ$}-$7UF+E%X;?0g_ltt-Z}IW2`Fkx>vjJ5}@m&SQ>h8EtGbo zyS=+x{OCX3j7c|(zMl_BftDhZ>XQifzxB({mxt+4b0gsNl@pf)h>(y&s;ds!oqLRQ zX~H0d3g^|G(28i_Rj`Z82T!Zg;JUFrff;R`IxMT4rUIE#+?j9PbVFWxx`S{CjL?u3 zgXls^T!mf@9KohOgODm_Y#x85P$;BrFBmh}c*Wj%3Bdo}?hIQ)uB}|sCEL3F4$=bI zDm#g$0)$!MR!8^l`9cxyJ!FPnzY%VNqXQybFpmuDhhNp>&kL7$4SA9nhEOeTU8u}C zNrY(!zgIHI^OJ;9qnz7}NW@+M);dPy)}aUtU=`Dz6(fsEKL}6oOrNk<=FHq`qYjbM0yh$T8Q%Wm?y;yg4B~!18M$1>wq4 z5~a)l5%FeGM;qKwN|a8M(3bA}$C6lOW8d#udshg>q1yxeJdE7r``j&Nb8aAaS!N*P zv7A$wN9Olwo@GM$RzxQ&uTm@k<{9SG9fciD{d+(Mdz26n&CmV=)d!N`AkbY@Xk$U@ z%PBB8w`$I8`x>jqKFw31|AsT$r{*^cJvd&goth^wIpYNUU6}*$H&)^AbK*(Od!)R% z&&RTebO9%L*^r-vfElii{=y;YxZF84y>tZuZ}VE*x96F}!FYf3MuBn~$t|5WKtWK8 zlh^GLCSxIn|41(}PapXlN#JF#wV^;xfB%(!f|Jq8BMh4_1>8UOORRNZk&RyjCGlra zj?4H5k-x-667 z%(j_{4{tVLSLZ-BHt6*DjM{y@UhM-4d>w9yk(GX*f9u1bl&_1}Vo2}&t zL#=>ZKo?0#?vA(q#n}XDxc7)cHUS-O)GKrnenLs@uPJv52mwz(}KJEUMWT$K@DtjS8E}`D4 zW_XKMp7rg(SUeZg3h%+74#f?bGv~eir6dcg|5qv^$5{R-*-ay!v{TZNf^Z-r(mhQ* zqV|*;u8&w1Q{dx?pw#5*L>Vw1+x|rjKV$MoaTQ!fxEB3tn=9q1BPcnX#JgV~EKki` zffy1apF@GEP43@ykb^*AGk=!7mgKPhbxPM1Ky|0g>#m-Li!9$E=v7K)qLiY*&fy|FYX6#HPOKDZ7bTOx%`u`hKaya zr8Tq=$`<%-LNOmB4E4gWvGNTZvYj0T_%19GdT7B!;=Tbx3ZO7Kg)Y;w1j^`<8x86Y zqOxcrp`=@F$BYyP6m*)(h3L&+K^E`%Dc`tA)$nJHXJ@4 z1biCDOMLW0$-TR6MfWis6lfgtC~w$(YZb41u5WUzDs1?<*L; zx`y}>u%oc#+_W2I4+#S5#uOy;&{6^t!2Kcp9I5Bida1}oQGRtJiGG;8eOU9WiNE*o zU&fn&=YJ9$AHHwh7#_w5dlHb9t3zt1&*n8V1Cq-yBI1PiFAEMpG7I@j8f%Jh`g@~W z^nea|DPK(#zsG8OU+G4#9nEsBxmsON01R6QnA-4_T{Mu{5DUUlN>qJLLgB8u>jR9Q zJ8A9Li;&l}hjOt$-np}$o&d@jry?DBq#|48IAH>4@WUFJBOFc3ie~PTW7#Orj z8PC!4nM~F%k8C_6mFb_qg4_gY#Vxql#+ZcQ- zMB4VE#b8~3!|Zf#c==OC{R6S^cZhRqip)=M>f9>3T##*iPkx14l;hgc>*=aokWfPe zW-E5W41X`Y0uL%s?fZJYE9~L1$K%;VS)PD5jC8<$VOGK^ijvyjTL!kw<98!}Fdow*Ru{_!punBON*C zqZZqrFf{&g(AIV9kkwBuSeH|&g(Kj~|DS8NA4YIzk^6aGgZ-`V6&;><&S{MeCo7Q< z!YDJZ2vZ2gX1`g>JO*%rwAusfzac&?((VG#UqRW@n-16DXS~ z>GyC+z2&!u9W}A1dp=b^+@6#;-8VmaRE#7BPjxpI)!IUW-kE??$6hgzS4fGIxT# zd-1Mfk)X8&tGeei3*(DGpsbRF+`txL4wfOz&us9!JoZ0n@+I2G(>8E4Q{e45jC3?d z-H#go7KSvHYA=jpeMkWH{Fyx|N$RfojLG_i*A`osefqf8G|$+UCwI?bT2HrmrAx5V z!$ONm}FejqUq#r+F9m3@SoHZub1vEMd24xg`o}b#-$0AK)1M_4;=+__r z&ycFwE%vno=GZ)>(@8&-tOl4y@ZiP>k`W>-?LdAK<=LJpNZ_RznnA+63ZhCq?UJQa3;{`|8nYq8P`J<_Q5) zL^co9M?9ZvRgouPowqxrG9|3|NwuvREN#Qwh{6VzL zg#cVwdibEnyN)Jn^>N>RK-r9Zud-%2pczhw>d{R4hBx+@y%civHTwiu0LgI@z);P` zI{KEI(TPq#ZGfRV0uK_?U7Wv^wiaf~yU*mBmhcV&IE~C6pd_4%6ajDj6tQ&ELu@$c z4?@T!UI$5WNAbH4#Lg~Vf8Qt&xColuWJ1$PFEgCQXz?RG6XZ0*BTA(ua=%-I+x5i^zBd=?+WBVu@7Op$xz)i#|sm2L@kVh*TR12!iBP~*VckGdA^`i4*Y=M zc7O9&=wgu)wq%mbjIcm5Yts}}I1;jn>HH{<(}Y!2QP~y(gm0MR_!~j}H*Bs!12P?m zqw>H(q`#b5F+G$PakeZgwVy%~=lHC6MIB>Q6ZZ+^UMyxjy_zU*%}xpqYrn792#^Vj z)VB7vr^xEpP4U<;HJ5UuNEDbOnk<;pynGhy2$ba=|B7Yr`8$i~m<-7-H- zEYAp!?mU@{N0gz#J?4cFSkWRFf#&@O*xX3E%JbtxKty5zcP9S*Xvux%qx>I@bKN5& zy2XW$aQN6;VNBIYMmd0vop*IBerT+eJY|0?1a8Y4Jo&P~!n0Of;l?ZbcAQHDcKCp$ z9_&HBk?W7;!j)-Sv$5XoKcSxB{-0Df{m@0Tl^<=t+x1+hKQhd=%?atZ4fREf2U&vH z(RBU59Ho_%$Mz-ioYbHGOgh^0-K-H>ohf7Z&POEn>h_=;Tv3JmP zGB58&nH+IMyeGPF9L{!#VKVB5Uy}NBmRr>gZjDNOus7!E1O0` zxwSiEg}}MGF^0V@6?BPW|LR+|zhNQEm3p0FfT?eV%S>xd>;$)KF;)WEhKzP8X#Xxx zqxjo`vz=?9WhWh_v=vjqpul?PY)q=vfbXW!nUKV79AeBo#0_G7D_lx&=+3Uep>}Qn zGuUyMi&FpSIf~am-*=CL!Q&ST$b~7jt80{oswy`M45FQ5TW%RAE~AUZbHW)3h~vA) zGo#W=u|?I19Bg!@i^Z-Ugm9H;H+daSqE-8o(vry6nEx3$2#noSTgfd9yfd#0Z5e4_ zgF|*!DnXQ8{((L0$R~8Zedn@x<%TR+v8P zl)qFn$~Y}KShcnt2>9yYaJ0-M6S%`FPfZ&tGKA%mVQKngeee1+$Eex7TzH-F9Xwiz z$Mu%IJ|GeK_Ut7e%5_7NA&a-g<_DO6xMe59t3Ze{FH=;_r4~f<=TDFGdSRhvIqYPZ zHPo0pLF!p!>^};2*G)YUVWMrG`HlNbF-ih9*^vUCly7(Y0N zsWm1D!fl&GEsQw+q%Eu=R8PHGdU6hhrwoINv;463zC8iz-c3&`wqE*_kdfm)}xZsi%Wuu;ay90 zEQ3K6Zk#J#2Y2X>Z;u^KpzNdQ<#4^CwHX-cPvzU^qiV^#6$B`{+mNG4-7zI=6Q@y5 z8^Bevk)_jU8h0e&zcG`3K*cr!nQ3a};#{=LVpklQr&AldRLs>vT>P-RJD4bQ{l0Sy ze00tk08a-Yoiu@H+uF5(;|GPrr!s8vog?2%Hoe@8ISirC_z1O?O#V)M#f;^8z2zL) zG=;>AAO3DrD^tQlHC_B0RU+oQc~+lDXZK$&5}a$`K}S*pJf4q>QWul!`xvf?+Y|bYVOWg7~iiHmNc6BP<*|03#d*H z{lvuNf=gH3;Mo?K^01Qe3@G|57?+Xn$FuAk8HJl_y8GsKw^_h0^wBC&io z6tNvbe-$I#O0xV(m+UQwC@hnY4eTF?nr`Gy(P8o1{A6)?aZNU1Wd6d5uNc zm~hyh(0{Th0Y`8JXTl__Nx&$LY_iOEIO<)bGYMlF6}*85NXg9Lq`_ILdqd*`K~3RT z8k?tt)04dV#+DN&V_@n_{L5+f)hK|$WVx;8p>%)zZ~e^err)JiAT1+yla24H@pnVf6$Q`@8>Cq3NSO{Zlvk2~Aw(Yy$+uJ(R9S z>7U9XUEU1EUiMvM6%?P{_~aQ`a3>}6-@68n@p|E$a*JIOwwabpM)Hn%yEklaiN@E! z+3$*F^z9RiaY1HkeU$?80^v3*to#)QXH7hk=jMuUsQ4LqPkEaDO}P{-(-kHU*Z^cY}0x+ zIdxZ}{?yA|*l;V;h9vnVP){GxMj9L!0PH(KITzz%A$|_N+r@Wl^FVbF7{*J;f?Owu zfw9Ky)6%G8YHLlsrzEH~PlhVL%tm2RSO9~kGzO@^$btN3I~~elH{Yj|og#E1mgIu} zLjrnz259XccS?_7bm2x_6I1nHQU@rT*8VRRV}84E3E?1;UjIUZ7p zc-m7C_c)gNG!2IQ&oR!w`**EEVvOEGDFsdzF03A*^Ee+f#>5pbEAXYL^uxU6bIE_S zEwsbIy;n-!gR$d;>M`D4GW^9+I2M)02twzI&8iLIs1P+tOYtA+%Mv()qY0ua9v(U@ zJGin}I#$W7AYJ9JN_886#eMzG-4JR4(FcCm{!WzuD5%YxutO$lqKQsGCW3$cIg7ZW zI%~BJfbrFVm37xfOS;v-NB{Ow{_CLrBeYtiYJ5Af#b>DFpF`|AucBrVOKCJ5iYa?k zk-g&UK?KC>NitU1S$=W3tpXlAyb4VL^)ZZYc51>N?+KMiG{&sd)?&s%BoCrr#X;fb zqD7U+=9Og1#-R7tr6r}a`O7?PSAE%NQg%;Lvgo&Y{79S9*dT^W$P%Y{{`0YSScr%tu#+@CI-yD!0HRB9=7o6|V;-b56D#N&YhR!RA*kDXiUL44 zFJq*#zkIy;Fj)*Or5vl1OARIaVDAde`?#_xcm`rUflyHdkYEj*-lX()j*cih0T@39d$ZSDVz*INnrEqB9IQ&R$YCYhVx&uy<22O$daRf5@Fypr^8J;F0+YAKhmrQKo!hmkqx*0Qw%<`+WG@rdwkgmk{ zH;FFNfWr&*}iC?qS#9H02uhx6fP zqzY+A7qRpGQ{$-R35;bqO}(#80>Zd`EW*u5dBph~IB=%X-{)F3D8PEZRToU_nlJi#6x;rf$*zR1%98M6V}2wn4xO%f%Cekc&{k$NDa^ZEc z8P!fnS`Aldj9vaKe!f?oXjo}3%R&EX2YG$LgqjI|J-%Q+(ILRI;<7yI7@0#_s}80@FKiR=sed#kf|o)`)0l53!z|_jhXDDNvgE z{aX@x3gG<;Zt}QT(gyZ#L@TRrk=M%O`^G(v8X*Z9`O{m@Mmv!u7{{2cIU!5E`J;H{ z&xyBn!B&95zo5t|w?G3rG@K(Q26Rb=7;D8m99h%#9NrJw{3&N_Tb^racj~x6F)h&? z%A~7Xr={cH{<$|fes4AsB@JB?_*m~;|3?+vn+|qN;=*khnF_n8b9I}T!Uj@934|b#9rT<5FtGp81>nO)gR93IXYUFlnk|&y?5(^6=SSH zaE>{Dud3;Wr61`EEMoik{SIduN6hldAzcL}-^}7G@mQDF(l;{;-qfS2l^slJs9{&t zN;(*JMi3Kb0Ck!&k90%(ehr0JzX^;R<6^HUK${7Fl4X+64?`914F;6Go-Q>|mM-`N z+Hq8Ms7y#spgA}0#zD!6SKX-+1T7v`*hT#ekO@cgcL9Jl^;Acx&DSv*i4-Or|28)T z7oTW~(x9fBC4Zo%hjgU2U29kJ<{4GtvI_(J`OEgDZ+OP3LPpR}IqO5p`4sUEI#HD$ zv?SxPr5A46B@ZI+1$ufsiz|4n@oxALkinMO3GWG=>{3O-9T978iW1TCHN#t7WDoq`@5Z|gZDp|ME`evLe= zYf4({G^Vmz3CjLm%0|6t*E2Q^T0OOJlL8U;$3hO; zVdHPwg&p=umSFzMv>hoZMrGDhQ#PONc$SHZ*@xF3*PQS;J!KORl7_iklWAP8Mf#vgW5lhhfZ8Tj9MV>{14FTVj9x4a~E67mC|Cd8mBgiJCjCHj?jV019-8Y^9M@2vY@ zuHeMbUUNt+5yot&E=?tvqAL!QVq6cMM2tykL7b8<@iN7l@X?Ts-8e`o#hIwAnci_N z-opU-%lL3=rewA0J_L6rC$-3S0StaOttQkZ#Tvky{&_D;xp$cZm2t5HCi4Qj&L8D% zbsJ!&tgw}Jt$S6+D|4~S5a=fv-|?Bv!B_v7%bsTl-N2EPhw#v7io(l24l*|CJk_{) zEtvsh|GT~yj3Gs7FPbBo;1M#E9%c{hYo@#?k4iO8E^bpC4>!4cEZx zXIzkFY%$DTXuwQsgV1tqxMqnJUA6OnQh^%99`CD648Exiu)zT<{aZ=zmAnxSFK4m56+Y$2FH!dkb=n0Sv(I~3Iq`U#EF zR6gvBaV8!ywnDT^2O_SuQaPh7J0%_3kcBj?y?k78osVm9zQ+HYYVUbd#7MHUYZ;rd zL+(2pKJi{E+$(u9{rOxOqghpQ&Iu`rQ}*OLRP8jTUrOB3Pt-ofQIi5Y4jPc|M>TR` z7`WZN9Rsw7N|)p$KeX`I4p&`N(YwSq0k>-^YJ8}JrKh$(8gbtN@N|!6IH_V+*KxHm z_Jb7nDd^!B$n+AUcws`)6O%~8h4qsWBzArU<8V@CT;ckUZYk|tjocS#{+x`2sxWrh z!1a+H`#dyfU;eA1QPZS^hie;V%oRg()nwS)`L2yyfC8!H&F+SK4;k4V`Su8Q1$!i*t6KguHr#<$}^tGENhySG?OM|hqdr%mAGMPHH2(EJB3Y$ujpKI#Y{V_@Sy7BXk=3Ypw^^Z;wfkx!?!Fh2tzIK<93@GydSutO}^o zL%)l!1*FI0`LZi+`YHaT5SrSCZllR#=UJT`dUBA{cNwO`9-z31#m%%F&;T`Dn1m4Q zl)$)@LkXPrkH&67_pwySmEq@tB53}d`a;Wi)n-4Kf_VKp#(9N*S@9T9I=b_=t3U0bFW=OYpt7*3uLg1_y8#agd zwrzL(8r1SEaWtqfVFXvQq^r*aqfyiRHa13#XRL$OHuO~gyWmGdB}27igRIl1I@Cp7 zEE~*?)n$MX62Z(h$eHen-d-mNRImA1rjO*AQ_Z5|U0kc~7Q92r%-qV58o?lS&FYt% zxGTFgo9@q%_X$GckUCp*8Lhs~Lt5;r>CY-3V%)SI)z*St>qD{B+;`Xu3|jGCC!zcy zqBc~WhzZ$jNtmIo{q7zKMVLneXF$Aks{Hse?mA;M3}DRh<4iNm*lu4ZT)Olwe@5oo z_;&K8I?+V)Dd3V`jVAj~&!z#@ptBS)rBQG*qj80xQjL|zCH+5kE;00fL$i~_+fE@B zCh^8IIN|qsRV8yaV=&K~;a=5Xy`SGpd}D*MZx&=Lg&4yRZhX3BseYg8?Cc{4E%&b0 zwcO3pY6Ki4@YZLrh?5#Kd z$*}rKa!wtOUDDX|o@dj$;E+nuV6{Wa@Yg15bsz<$w$E_4yvA#Q(I69Z?Ffoxy<^B_ zC7&QCI@?3BTe2NX59=0E4tlCPxI=wAeidNzoEZclD&`cK{vSJ8oR-L}29okQRh0Ci zMSqbd4-bB`0R_NLfpIFDM;dj>lnb8)>J>Go$@CuwWz7&ZYuPHe6G2N0y{G!7QE z>leDJl>`EPt04J5_tozwsgSBJx_EY3B@7xq_ zotMbssI!kWWE_%0ueJXl7EL5GE|$8g{_+TH2`l)K4pZ&@ez2mSyk$c@Rb}zF;(3Z9 zc5&;7p1hU*3Q|@U47> z5<5)4-Wro#g9CeuWXg@K@Py*RZSvaXrJ8Zc46;0t)o$Q$Rz`h@Phe&8Y{tk>e8dd9 zY72rcni=O!fMT~SFo67+FADDwFVxGqR?DlSCA_t&Wr|eh5(y-a18y7ThPm1?8(zlwOp-j2mdk<+Kq6k{Ivm{B zRUS3FE=Y^5A$-Tb2Sfh@d6BoQ;!c_?B@ziokawlw!xhgU>74$>S5A2_v-@2EsT`l>>E-Jsk+0qOfBZtdaO@b4Cx`hgy7r%ByALxAYijS7t_4$N2KN|2n+Ogz3s4$zT%00j zVB-~e{SgBGsio%xqoU}88EWr)g1kRpyaf4J&F3FGdW0!qV;ZV|?ti~}r|8#bMH4{$ z(4+5{k9P7`FStxru~8k{AJ|m9dGsfb5py&MtLZ- zf({FT&1|laS-}QB6*~BklkeLqu%p_~72#Bi1>^WA#8jZMc8-v3=H~YLBbEgLYPL1+ zLtcaNN=ZTzW&2#Nw*lM6hpN?nh~DmGVpFB6FS=wD_F);4rRN4O;9sD2eQ^=x0U6fY z3U0y-c2}(R2RT~N4(Ku=7g3k|zxRW(WC6R;ROr|HP*Ps%eV-NwnI1sTO?hwfy7~{a zN}g^}Q|W5SrXA`s-Wcv*C0UbVw@1G?No{B;BUNKGp?;@Rs~3}(sJ*>{`oZznkK0ET z&*7)*caBj2B$@!;YP01`7s1E6APF2(#uQp+>5ig!5pH71eBr)?g2@&Zj@F&Tio2hE0P5vD&p``m*ir#nokQ>Z-RRBW%{W zW_B<>e|XiHFEewA0SX9~wyWy40GTPH6F%Z>zT3>lq_u@^yQ!Em ziBX}OPTnmaKa+u&Z+S5*MU#3N{{Pz$HyoZ$%%=cSFUT_u&hnWXv9GP4G^nrwq+EfG{jUavQv{`L}pbTNjl6(3cJo9vd;GbU(xH5H`!9l3r3e(|&B+up_53 z3*-gYDWiyW1ND1H^Q*#C=6&D5o&eg7LCz}XdRG8T`RB4L|qIwBi zpoi^`GbL25)+O=D73uWUr=@v^UzgDO!}0pmY2+n{i zUkOZ4X{-MkS8VJmf2@8MQ*ghUpK(6Le$7&OL4vM$_NT;=C`PMLDEkkYYGzz?cY3F+H3Ce75XM+f8G^O$I%miF<@j!Kys6lG$I}^^(|TrEVKPD#N697K7=k*U^OXG zM*9l?yBz#Z4~{|Lm~hpj5RmA4B$6V&nmZ~KLmbd#o4_sXQkEoyADrhl8KOdr0hEJ~uF=w%21^=C zi>gQ5W;-^0<*f!XHErIJATI%r=F)(7t6!l6%1^S}HD?KMo=m|0S(8(q&gP{;Pi^)| z6Et4eKf~1(z07Hfu$|qM06(8Ln8FKzve$P1}65Ur`hD zHbiE64MZ3@3&6O^vX*<~soW7xsJiVpPHJf*LA(^Q^lQ2CuYLOt1Lc)?dkR@vuTT2q zxH36UQcqPW!1~1?NS1V9dO4l_A9wZXRB&JjFuwceidpn%W#RlIzAJ-2WG=#msu+zL zB-CI7U7q_miE6KZ!%j*}qd70U_=oGeO1bZBSAD#@m_J9+anttti;Rm^^M%}fg{9zq z3v-N4FeJb^hBRLB3*BGa3ag;;C#MKhbu$Hpv<+^F)czHdMK)h+>k63Yn1zt39x63>dZ&`cP5>?$)#Ban#p zSHK?=D`6laIxoQ07@45n;t&${PNaD~ic4tsexsS?ar=EI?p8ps6ZQe8ba&M7N(%6< zyqqfEAPKJ%W1}3_GI7@Q+AoIElC8F<7|j>C3!t;Dj(p;AZvQzB1FZ3%?-RB1cGvh73eb4~gEx59f^ZbpI8@Kw|(@ z1?iPuH(^jL5A>~Rc;2|mZMbtdNs}}tHQ{?42rl16{n0m`F(ErYIU$;T*(Kgcj!nso zULr5D*!Va*oK{FzlbpeXs6UJca~Mv5NCa^qAz`6wca#hO8~D&_RhLEDSnc0&Su)>b z>PyV~f$hp(^{{b}CZxOVq~9mqwWFLS3s&kn>P6Jhoe~iE^$f)riCE<{;$=&`Mf#Ol zpj_{5UvA0ktYy8D1=NF}{t|D<+1dH5bvvoC99)%#xG76f6J@bsc#cCw8oBG0x=4UA z#|;Dg%pBA-YL_2^(z9fOU?<=6tJX>--hxJ(e>gs69iv zIT&HjsO+s)>4(wulEpGfId9t>6uh6Tyg&P22>Up*r-A0LHbG6_LM%h&sykFcX$;1AwXB& z$R-7q4)7=-W6W4KxRvSkCmhTZN%sglH8ljL>oY-oi43_NAt5`9E$^lqzze!({1Ff0 z439IGN-4auu!5?S*$rYeTWpyj7rW@Hn7UQqN^38p{%V zO)-GQL8hd$D|-@Ch=DWCjnID8lkn6Qd!1MKc~eP{&22ZZ-O1>lj%t?v=@=As9D=~8 zYW6aru+$g(UJN9`S)W~RKZQH=UIEYl{LG0Sj^u9uHluDo$8KW(bv`|!hs?fCGv>;~ z>&k@=Y!*YVU4cpVYU=>+v>z}{mX`yA>P{fW&%!q9fJPz-UCr+QK*_h69MeRP2sc~z zqrk8U%e>+A8CRgx;7cZTrA{=Yj)oV&Rdz?pdR9WUP?Zv20|9VYEyXo&rui}5)T`Cy z0O>Sx?3{|tO!=t`gH=_X`;75hjOYp=4KjN8sL*oyaofm{9O_JElBUPCZO5=4w3(?E z2)$Xj-i%G@dz?z%n{?IqAtafMae*Ib&>zJJ?e^SB!g{i&-wjcsE0XSltZ|}4p{$8utEZvUJtAe9?q}NrtL9NZeRp{voqOli~>| zhz*!UP#ygbP3)2pz5AbM0x4k~5>Hd(Fw^Zl9BZG=hrgTs5Cq+9#SyM&$W}dmU$jWd zcMP1eAHM>ja*cW6(tWb1NQ_kM9_V!ULgMN?ELpu0#`BT&yA@W3JeYQEl)4!aG)b9x zd!W>>pgaOCAp_3r08wWakBFhy+l39a0-SzwdP<&YpkF)pXM=x>SL`z-JXn>B`nJW( zbxWXUs$y0%rEq6!KK z)yzKyd!&$wJTAfN=Ri_K<&}LOT03C!Dw^P*-JkpAG?CCl+;?d}5 zk-`;p%>X?W0R(%~$Q6g!H`h8W3uS}t_WJH9o^ckjs%C29bM3+;k(jrU=RuOkK_DV82;?Z^MJA~mWi2~^nO{*HY>-MvKvfWhZV{_}T9vs9?rP@Mbb#I-8+Of^%MI-W zz?l{A)b$u;GS&r(aN)97t_|Sw^^Fl?Ky)cQ;$HWbb?d!6ihwY~eH~Z`7Z`FIx#;KP zjqp@%{%eJb@mmnxcuq!L_SrDU_{XWvad-KRcnz%f2r7Qg%Unk@OuNkg|Y4{jjCxivu=keq20UrV7Vth9PeMbc}w|-Z-}QKk$DBW z_ohotWTj$vR06Y(#6H|$(t{% zT0c4O_;_cAohJYGJ>XFtOODRS@k!m<{?B>`MO3$pwh}fkC0fd3&*4$Q5gs4Dj;cp9UCX}aD{bu3!xLfepF6zz&)F}=DH#H)1Dn+~&<2|aP_N&cT%D^a zbm=1v@M(c$Hdn;f?{C7sMqDW6n{#@pYM(yg;w9a8)>3ISSe2T{iT{(%krJlCDP^)> zy2Nm`33`3WU9<$qE*6mU1YSjE5C^U;vlRh)%3OhG=epb)D(Qy$t$EUyza=Z+sB#tyre4m^88`yYYgG`$iJ$L@US}ZUe7S@lBFBW*z&Yb^t=ZtsF{X>f&|@VaBb0g$i& ztQ7jVZZz67R%~FN@sP~yE%mCST)F$tGEGACF1;(6MMo^oJ28`|bg9t}_+4<3#}9@+ zCm2sK*p>aoe%V!g`suB~RRuCA36^xQSzR?T9uV(}relP*g%pe0tbwmxp(ZeL6ZM`Cf#v5uSIUL?F94+YdjS_^I*8W*tz(-wRg#magfJW_gi z6m*!W6xT)ijQjO%7tDAy3kc=P`mqtOW)bV3s;a#73^x|e6y+3-e^nw=yS`RI%82DU zMY&6WnWnG=E}2)U$}%1TFzvJeGeFG03@_qg_*vG+ zTLd|<7V@LiHsg+dCFVpPEwvQN5sc0aeG36O5RU;$P1vJ`RaT?W9ZMI|p7r^uVf62+ z8%FOPq#4pz79q0T$WG{nvk3zan)F_5m{zqO_(P)@vaA+Nu0^lI{#%QEbnfWO_rj5S zgxP1oWW_ztbnS7kT{ND9443H?9&y%@r+D8bZf!AR4~|s<5}>JIjw^fyvN$|J4~G{9 z1%0Y7BU=s^5^_P^Rz*|vepMR&?{tb1%k;`GE5YY5X9hr1OssquQro_dU))Fqk>^Dxv``K zYn3>UB}o!I3;Eh_D--eLF73t&{5|ERI8%slLs>rX3F436K!d*sD{KX+SlIM8)5+W~ z9hjY=ushSOnp6p(2-2hzO5xb6pq_hI*p??g$%q1WInX#M`L>ywR%E=$DZSc^!q0N} zPy{IZI;JzL&6^Xbt$@!C&Nn2TM9}nrA)~1mW?}0kS)vj^2N;f~qyj3K1Lc~!)8a3^ z$?uIbi-uFJ)dSFQ@efq)=I~w83o@xON&rOdxZVA>5Ni5aJ*`Sr^-_MHheXji_LA!UXSkKOEPL$VC!Olc{#_2Jj+Mn3AlXlS4?q0QnVT zL-^XU56>Dv7jNdMpzdARjbYj)xhv1eN5c$(yxGz)s zS$sd#wflYF_Qv=nKegY9xR`#xtVpN?!JYb%Z_&1X;_8Xl|MpJqH<8SUN(8}L4guj4 z7Z|rgZ92xVDf%~K+=5|^J29!?-KjwB5AKrJw(QJVcQSw(c^+2akd`av9+J|4<-PSj zvo}f}naBeQxOda5Wx6vKC1`9=r1^4QA?WWsYlYzXeqsqP>n_;q!){Ec@iM6h<^G@j z*h7qnn6WmbRWl~!n-R!)IVj|XMsMMS%r?ZCS$_TfS#8x0J)E~tlo~L^y+Y#mm}SVt zqTeb;M0(W$OZ=l`d1?SGm@NhS!@W!oTAvSE)dH9Imyz5vQKYmPXz=KbR>k#{;aH_2 zfr$EmfW{j-M1d>ukv)ca(w?sj>H0}Mi|>O4ge!P9qmX0K6zG zAk#u)h`(1alDL$#-l8R*F#%p&(j1Bsor`fJ{4&WmktruKZTm5H<=q~UGBL3N1{_TB zQ*r)?xUn|>(OmSsB$$+fqk~jMxN;)AXW6S^{fxe}oU=Bg27MsR`djc-cR-kHe(6e~ z4lC&@LR!`b)*$6MX1n3m`%UL8G7at#L$9y7HrG`d)wG%?(0@9TcOItM03b&S+J929B>kV=v#Tjsw3?LA|9-Ec=RG?0~-!mZD zeb>O+eHL77yP>=miKUYf8BFj_3o;D4u+w-s;sEv{F$=%-q&9`6{hN}H%hweo3to3vZ5=|i>BjZAGik6;YrZbwC^Za+nb^ewh+P_JPW z_*u2-rDAOF+^*z-nbm!Va5*X7o~$<_I-KG{k?^89Q2#d|KoBXtv`pEi3v*pyZr2U? z(t34gv(bx0NMPo{G^~2&xE~-S0%cDiP%T*UUGe%$=ELx&susNOlgd4h62*AaDKtxE zs1{8+g2(wOFb7FcH5mVvHbH0eoT=Qf6|#P)E7*~lh7ha5YftGl5Zip&_wufB{K0L> zaF^`erZaZWO(uB<9~+^>aG4YmrZKsW`tJrt?|Eb$_Ln#<$lw4yg?b($ta{iAXcfhf zdK!%9E2HG)=$|}4Lm~C64Lo0zv17Df1ioh4q-Hb8j2{HMluUMu^B z*SA^Hmx-2TpxR_k62Jy6AGM z7@@>6E+9aCV>y<3Y}iwZyeCrt$`|J2q1@O1ao3C5nNVO`Iv@Nf);`MNwu$`r^D!BAvqAt0pkp0Jfy8r zYP)F*SFZ6%056vF=wm<@~F z^X*~sxQQF`)tJ~}bl~q1KWZeCY2IsoluA^#FUcUU*9e&$9zb0wxj;gsEIU+hU zPfj@HY$jyt`e$~La%D0&Dzn!l%1c&7$VMt;%PQZnJT!kn7^5w_;Ib8`GU z?PfhUjQ7?2OTXL)$$^FHz5xxtOg|j&mjp@HvrG`A$%c8;0@9-6=|oAand^Q^kAd7G zKVaH1R&_KaQx`_r-24e+NB>_@_NAg45%O1hy*27B^qF>u?$4G5=z!;(THospQrn?f z*;E}-rXV31P-y*`&s+$5$1%dmx}?uDu(BoR)`o>KX2HJXqluc>_}c@S%_N-Aba2=* zK@}=PnVgWe<4yj%v>79CwvT+|RFaFrPlMsaE z-NIO~^Z_K{l-C`I00093`U%;u(NrLnVS_y7RJxR5;edXsv*^5D!JjVz# z(sZ#uJQpw!y@`nKONM;QW^#QL}ZNIOf7D-~bG?0O9th ze6$sa*SpO5*TS!FIn|_LZM=?=k#Ay$B3QzMyPYi0B{k zp6Zk8Gi%rV&BWZ6`MBT?BS|+CpTlA4BuT{`#-J@h^_*XQ;L8EBTm(Ke2pm-CoXB_D z_oU4~saTusP6F0{e>QMdc*%2?7%@IUQ^zgTxrF!^%WgnGo{l$g@mU{IO9}n{s_~Fx zZPXHk=NP`EHTar)_WwVBNgmtNqu+d}3Yku?Ctn8SOK41|ouZ8m5^vf^AAp<3rS^;r z>jna8)Q&00@Ne-!zLb24+m5buJ+V%!z2j;7z$p?MlBY2l0||LVEu3IqgYu10`kx z(0R`g@mZJpl;PAUpl(}OIsM=r=LVoz?MIZ_xS3L5Uf=CpCmW%zQGSDj94Nuu6&-BB zp}qr(^d0@9vR=$toR98KWPNE!i$t~>#>}9J*xCw_r-hS@!VQ8}v!MK2B6@mcVJ?tWos8!5}@Avj(K=}t3H1-D&l|HtE z^uGFQP%F6jEyQDK_6w^h4Y9{dw~vm>tMfOugoY4r{1rW0}FgY1M>x{Q)K9@KPDf4D5@U4=07*H{gzA^u#&R=fJhCk@%=2(|VPZG0>m zvv+|GO}<#{q*b3nwf6FBx9doaS$t-#cV0|H;=3uksO0%VuWa!ehghG>B>|>sK51}d z_mpT;Zu2B2Vv(yj0!Ye(D^?z{->KRGF*;|;#89|W33Jqy#iIsC(#s(%8~s3>HX2ZB z?YN%BmO9#>+$8|rFMR$y_a|D^wzNyjZ)vi{69)Yt&gv4OmeKZFQQ|KCyN${rT$1izi^529T zfvcN-FnqmN#fd>Wrp$n!-sLRZ(Rsz`wFcX3gv~5)eb?S82D%2OH|SQ<{F2#y-GpGB zjSh|DpLeJT=<=JsYR&RRPf%0`kA!FEEP{CF%-`qMr2Yt7wXHapitYBIaB7~U4 zz(O01{k@+-dqf-Cg+4KL@IUnTC*aUA=pTB>Ki_9r=})J9ihWG16zi>}DVD@nObT7T z;Hu|}yeBv`;nGtA8~>ta>IOwZCV%ODHN=tl-wrhd^U(rz8z7L8L|-wMQQ)Ugz-KDe3WgCSUZF}T zTWuc$lr%UAJl8{aGbzK|!KsG)P%_ zr{#71sp`ECU$qoW&B~U~g0m~&%el|v=2T!;6zeQBxv;uuC*#gOO04q9Nx|qu?sLi` zy+_@c>Wb+T$#5P%#^!)+mIOwN5_UPYHssHe09E}PRPRlD)Fqjiz+Z4x_k*Iz40v0O zbau;HXo>xiC&;%k|IXs?b-ljz8rF*R#_ivw4)8=V*e@;lL1k9gaz`7L?{L%aO$8db zYOGaDAN_O>6xQk-av*LQjanh=d=`#n%-OZd!uLKa2_3PCm+8mAF_E{?7>KQwL}>{l z1LZ&Qj?pbLiP9_Xb=9J6wX?o{%rIC=Qm=tK*h<)n_^4{XohOhr=KgMXIN&9^tN3M! z6YFAe_d|$yXAbSFBv(`O)d`Vu7j_%2up~)%Q~E=zDdnW&^aW)4M!_~5Mh_tKvpp$Z zfaY?>@Zc;2c1#*j*r}>_)zaZfZPItA9<$;EhFIgdu+VuRl=pK_oDt$q^+dw@s)Hym zMyH`;2lD2*Y*{x)A1L7_tNENg!&ec1+L(^s)N2fbE5$r2^Da-?)%;Jk=7~E8?3vR9 z2-{I2HEDan`Pj-Gz307PO!tAyVr!$_KO#&h_K62@L|@MzjeG)x>$QmscoxDmDjO>K zfWy;zqDVsB7**o!!%|Sx5f~5u1KWtI+i0EX@m>U~>$2_v&F`n7FO&m>wMapuJr!ck$Lzkep_q%B!P6_u|xUSdqX*;^!@p`Kn&{?AR;(pG0crkG;HQ zyHbqqQZv;2{F4Z6E(%=T_!$9-pY5r>OMQm?Oy4_O8y=I1z0@ii;tcv}d(k35XT#M9 zgyW|i7U}tEdR99#eNUJVXnigophuV?H^pgrE~CjlU~QbQKF8oY|L33#kSX3}QZ)xQ z`8FDK@Is&-kvYzF`yRVd5uz?^YUb_WGooW$X>jOqM`JBQ+2m@R&`7F{Y?#Xc#_^Q# zRLfBL_k5|F3KT>&{G%I3;Qrqy%9_NMRFjx(s1eIXD@?%2y+&@~-Vnbc@`1(HbPg`Q zN9%}!@mR#}kax9?)ZUU&bpp}Q9EVmu4Lo!;l6~d&iapp?hZLIT#_Cc^GSpVH^_}tP zzYC5SD$53!%+atjWBI0wu9fq9ni>m?ikUy#!KxTAI@S0ZaxAbM(6^g%qS8X4Y%7x@ zaw$Z?oey$S%NF>&RQWLC*s8}(MKigRoA-^&Wig*zKlpRerKlO}#qz(-;DV(4mS;Zu z3DTJ?K$~z0y}$H@YFnDncvo7dE7VK^*n>C_56`kytY1oscgcH z^V;~xC@BuRNDV2f6l8cV`PKOy9cGjylN14^`i1O}&$30GE_P8V$&Q!VzC|DpbNWI*uX1z^Oe!P1m3t)kFcJwu{pine1S~kpZa6>9y%mrDCXUe7L zh$y3GHaiQdi=3s^rS_^1IRiRRY7hwpl7|DZ1oIuF9R;Bfk#a-CCMltcERg>5o&Fal zk(Kvb{I6_iq0dzy;IMfY+}= zuC%3|m0AHjYez02U4THMfr0e>S|vcw4d`2O#$g1R09>v?l61Nl_~?EL}mB2a_?wPB!a~ zWlKum1B)v{{?!yCPqTbZA;s&vy$;?_#`=cTzR)R7;F10DREb!%MkQ(3SBdYo+mMt_z>I)QBXP6PO{vumo9V=c@GUjs z?mhu~usawkvqqQ{*2NP|35(NoeL2M@38-SimhrZM-JU2Z5#f^4kWk*c8$A~+eok`5 z)FzyyHn(RwZd4KI2t7rc$NehKB1@SWc1@!OmWjWn&k_k|#AqFnUNgmgzCK4N?6@`h zHiGyxpP7)#v{;|B5JLVt{XSeC_aLB?*6n_^XlWaYpQ)n;%J5NNIN;Y?VVltTsuT4~w5hc3C0vjl<3p zuNthtR}V*d#WxWf`ux?S`!&6#rzdi?j>V;V{D1jUnu_*cFaZp-k45!^!K^K$dNCEN z2D87Vot_>~KxGW$ll}V;%}CHIuqD(N&$6t#7D?g8>9Q_}{Rw0ks_X{n&$o(~?8m4R zG)CpN5&wvcN1-i1>*A%^Xuk{!yXb!HtpnTyK)ov47{147n%t^rQie3=NcG(P;^a^ zj)ugi-&cR04{t&MA}jC%)&YSQU%)|frf91f0Y^tgY~0yDNxr0%dv9qgG2W?9cw|$r zDSn1g_zT;`)-1F^<#9hbS)qVzyHE=oS1{*VYstQAe{E}c&q|X5LADv7mmdPrI%A65 zJ`$ATjqcZ5U%V&-xj7o6^Bw&Ps+D4eAS7Y{-iC;%tPbKt4laPx9MIy2qZaIo&IEjZ zlCDl#@&*-SI^+>)uXg2!rLSK7LmkY_(0tHVFI^eK9mWq~*CgI&KW3#&eSOOQX#Xa0 z{mGSkg-ITB;0040wX+`T<6k8*J@n-lo|9!l!yrBH?YMrdImS#2sK0zTDWcuN3PphL zt^ywwXnu!x!Prw@`4r2%R-fJ_c3HZA_k&9+4XhG*A9I{h#ht!9J)yx)(g`n0Ae`YD z-Xko{tkcE*>)9=E2xAI70yc~HvcJ1rZK{PWZ1GMc_9~7gbFAyVMLNzkxY0kV`2VrDOcmVHajFoMen)78GIM1{T2fm0B@SEZS#0nSPI#TW-=)RYeHL;T1X>Dc$R7ij96mC$?d-LNRNFPDC<)^7KBV{)Z4)J z>kh{nrM9P=8njVl_qZvk70&yTqB8wudN|b<3PKUHU0_Y#r>T7J zF-M-C_QNuM$aA@*Z7I=w=0zWf)e<@kqYoyDW_?PhOL{l!9oIT1=mNiKO)nk;Ypm}V z0(B{^IxIxyhD$belZO$y1aY?S^58X68O+)h5E6~}{mkiyU+O+SQw=MLObK@tX7k)e zXfM`fGJV%#R166?&`E1>xAzd6b+=rtt3@K&trfLnNXG=>_g-}pJG8nX9}vI7zct>~ z!h2KAS!E#zZ=`?}lmELzcSQ{=8R5D*=-Olwn~cZSBz!)u>W-sj+yHS?N1+D1;L&>5 z-2GPG{P)naFiKh(n+fM|pe?0*%kP=PqMM|Ab}!qlgJt^!G?0&WDp>x&gN!I0IBYYGvXU)*gLZ+a+L&l{RErfD)kTE}5v-v(I>IZ^R(+#V&A>&Nd zH~}R&PPs`((I7%1Q@Z6dKT0rBy-8{!(3J`g6){vbLy!YtH+rG~GOoAu{FTv$5CX*hg0l=D%$hqQO{7T)e%q+a* zefZX(%D~w9hx*4KCY_pt)dD^GUw2w7ua8Y+cr$Cw??0M*&W+(8uDvHhZu7VsD_3Vb zD*LEKU?g_apl@CYmdMZ{00Ehx-IXxI-usSGyX4XTYdRwHgBOYgwu3SY!~Z{YiAqmU zw=4K^RNrBfYDZ<8SjD2kXMu=f>`$X=ZIQF5IdYfZv(Vn*%l36UY%yPXR-Ew3cDyuQ z8$l-*&a{-SGn*p5le14jkU|0HF->_ zuYdQg@J|171N%Cuq_-{wkDOy(_3)tHJI~hFb~M5g5+KecLSZf!nsB?&KTJ7kWg~b3^E^7){k%*D3o- z;Ld`)`*2n$)&C7uJvo1T2tR$Yf7p$4drfeiB5-nFR^&JPvT5ama}-o>GbY4!a6J z9kfLxyf}?WH*Cl#U5OtJX-qcr&;-iWn{lx9*!Mn30N+Z87LvK*3O*Z98Bvr!{cWJ< zy*EQs5UwiFgzClVy9~K55>HZIK*@dE)AmX~TCmIn;VkgQO=>W+Zq)$`+RH5uYiC_4 zyWc0l?D%EWxQlBRs^p1(UH?fA;i?*jwvnB&^B~2ru=j`CDP8?R%66m0l=|JjAr=b+ zHQK*ic)NdUhGBVgaKWJO*%7z3LI%FB-60P9_Uhp5C@>L7U?%vpaCjpOnf3YR<7kCy zgXxkUCkGptB>}jJ^bef!Od3CvBs(}A0&05eAb!$m!#|XQuNo;wYBLwh!&bzbNCrb_ znu=vre1Rrk0hKEkm8nP@sx9}X2h2t*3xDd@X-J0weZ55*&s2e#qNVKK_8P5FaxE>7 z@Q`x$@iaYv2&4-CnAAEthTMrV*yMS%dbUFop7C_IONsCXnf3Y%2BR#l`efs;!&ppSX= zXeC?C7wI*p0^~=NI;>nuf&TCBHn~Mh!nmB=N1P==*1NJD7OZ`RGPg~{op|xDOL4!y z--441L``9WcowiH~&j>8VF)bezEyJ(z?3!+Aq~HYF0mMK3DmY6^TFl z@(#jks?icb!uGCFIw`@Mw~j5$7gw|Tu#U&HjvJ&u8f_-(piYoD_)xJl{BR8|XFg}5 zM}ZIP)jjBJASO<|I;{mWPjr+mCLV{g2tylR6VQE>W~Y=ThP&+-tyI6FO6oEyIN5En zhrpLW;H=- z9hH49*xue3JKO!9Rg|q1#;iNA|0A2IV_OgS7V-aB87w+>1c%szRjkAl9zCVRLu5Eh z7yTtV(>O9?d{$Ke2vyu(Lt8AHc<^u2%iH~UU-PN5Mq4T1GSL?|u&u2qDgPUm%hRph z-w`sVkwYUGl9671@ImI;z5t#FWvd&WYj()DrwL{`kU`y?#DA&olgCy4(g$P(a7f?_cs4_ zAPB`wVTWPSpl=CSs8|X=cbCL>no)F$<)f8?M4zg*&1NlxbMJ@XT{#1u5)bkBhLLbe z1}yB`PXzqhzuu`$rR}pFJB_a*0ff>}v#E`<&6pr0nC|P4tNFVOwCq5+jf;vtg}n+V zGe?i!R)o1+tgbhSj+;;;liae8GuOx~$ zt|Y0Sy!~|bfZE?=PS{bK>8n$pFb6bQ>a}=HIz{h zX=8n>iX{Kf;I)ypAj$V*X@V3!=gk%|V|yHO>W-ZA-?%tVVt1tz+^xUVblxkQ@>AZD zopxyTMGK3gMGh*IGlTssUK$h06I7}y`}tN)ACR^VVe$~BqHAx?I-u~s!vQ@8GQsI}b$S5>Th(S0S2G8xts}MmRtFhDH{zx@bA`fr(IPF3ss|ly)srY+5f` zOec+KW-*neQ^$K` zz{t?>s3?i&^L9E8yW9E@^w}efLE`2)f1$H!uCe$#+|vAfD8~{3I@VrGgN{VDPC~gJ z944^=j^)iOHn^SRqUHbp&OO8XcF$NF4fI0S+@BeotDlIrE^!aIa%n4|!JE)nMNht> zNIgG=_dh{}gByI@e&S#&RDHeuB#kv8uKlbYew%YZrbvl|=G8*iPyi4r$x`q{48k%j z`>Ke<3>I>t$iSwA-P6yeRid6eKX+)1q%jeX8v!#km_;6pfy#@iGRJveS*88ltf+L` zOwvQ^;Q#<9gjO%M!q4ceiGctB7hnONVQCPb0041VDg(KlNRLD<^s0m| z)^OwiQV<2fh@y*+%Lk7D4#=idgs@oM0H8qMaQm3L15Ppl)u?BUnZ0-l|4|GA<+tB$hKNKN-Z4KU8EiF5wyQye2F%;KuyXr{wPuCcV>WYeOLWz+==vbi<%SBgU=jn^D z8iZrR-vZFGLp*9CDxj+F?r1;ihane%1g>ZB%Q^W+b^1zDPyv4sYDh5 z#@v+n7o)Anp5hxD4d?uTv7EwcDwxqKv!?jR73WW7Y(tMe*~Vwee5PDw5?MQz{2c~s zQEkPSV_IUg834$#wBZ`aAQ$U!K(Lj#LI5D9`3r-6&1le0%?tMZx1EEnz?+@T z-O-Y5X|->*SfL4i)-2A0_KbDPg2&38A!R@!KL8*|=(NxiEW{ZBss2Kd93>yr7C+g! z#gp7nm#<{$LO^S8-RAz7&z@6iC6;xOVuKuoSnsg=7+AQ_RZ>uLQ@hQq@!-vZx7b1) z3JA~t1KIBu3hR&4gy}guDF!k~I=9$BdVv@h+U6aKp;$;K-%IlGWdDdJGmgf{aRu@r z2KUgCyEc8y1V`ER(ce<|#gfQX`3*Jp=H49>t)WYFa6#qyVM|n&M+icd8y_ddf1Vje z4VK9-gSnaj_kBWI-j99kDXJB7`wl+kU`R59$JBw+!;OiI*3t$AIuLov7=2Muzdil{ zI|}Ko(tgS^L#9)_M?ZD&Op+hSz#LxNYTXMZ=X1cHqY_ZNt;_*(GAc35lm2qsVQo3i zl#(?+uU4z*XN>%f$9pt+{;Nsv(nz2TB3*~GQdwo+lD(J_?KUqTkH;ZU4UOjYZ0mOm z+f}f|vkj#~?en9a4mCPL>s(MxDXvyGnUwwkifuHiF2&~dx!S-N(|K=Sf(9%hmS_5< za&v{ts(LG%Y=`&9`JP)H0q10%>20YQ=%hsc=P)YkZz<6HQYdSYYdJ~heJbB7G?(O0 z^)GdqHd~d&PUm;yByZeFLJETZkVn09P>8e1n|YV9UJhE0%4O+p4`Azc1ty*%x#PHw z578|vcwDGNbQIks3Ey!GhB6?mIeitmfsIQ`;*h?aBx(cA33v${^?cUfkvhRuNp9+u zy`KF_1TWFiJla{WAq`*y7c6K$kJAsx?zUssE*eqN?(n##rQx)UG`_E&hha(7pLZ!_ z9o6Ol+b}med#^g>X7Ef$(c=O`=vS;q)75QkMwIJ~JyNr5=?NG2J&g7bFK>wz-sv3h z|1=ky(-=DsiQTY)d=qnKbe|*FN2G26ekA)e1Ts?6>nq)gCd?Bt)iR8#=59A{O*1Gm znY8wmR=c$oM??0z*KtWx?vCRMJEnw}(c-a+sTuF7fG^>cRcDV2a-7einz)dN`Yi46 zH7|xXwY?~h?k^Sp(T_gNR!Cb_O?zRKqN%&prAW_2HZ1FISvJvq{N5~;th0xB*K-TF zWw99+L|IN)rjv((FX)G(*vLDPui1cJGmFDdpF+Rf3gu1zO(jR>dtOW%^j^m0*yJYd zbnQKJJO*Ep=bNtGqo-}SAt20;-RPD9FwNjEIQ6rZ;mX(l|E5!M4Z-2 z);mw}pRS{K+okwnNQa#f863=aMiVT<2k}zY+{wrGffQccn zR3#)wyuv4R5{Gz2+~=Zq<{|IX4soT4&TMx~(dptu{9P4`89cE!0cF!zk8;%P%xzetkbdhWJXQlgNCP>lru*=S!doVbFA#^j%_mAJ z-z;fK#*s_z`>sW1SdU-9=jLj0u6{xVn!OFdyCn()e9c0ijLLTkXm9B=C;xca@eAEH z#$>KwX_C9p?yir-%zR5af^nY>f~hWs{l zY?<{Py^n35iciyO2NifF7KS!}%S3oRlEy?&dTimbB9b9IU1%fhL`3NF76TCex0!(f zIkkPiK?J0hnRWc+bsYi?h^iXVv%C&y8Bs0Zz0T`OIfE?XoGepZ>J;Ot1lu%KgDoj` zxgz+aWkO0Q{mL<9%uEXnbZka8nV5R+qxGldtIoN#il4*~FWfT=K*TBi4LKe!!i5|4 zISPmyAdF|Gmg3-Y#Ai5lLr~xQnF1(MUT}0}?r!DZ(%4Sjk>09M8XSIoBC2xCbe$nI z=>+dQ+hhGt7@DnN8l!m}#?d^&m5n|lGu|bIi_+&3{Uiyhm~1Jy9*|VdCmYY@&s@n% zCrP_zFz*LSadx*Fv*eGKhR>_Ok=)^fQcG@Q@h0Mm$HHGL&=vO8r)p409dS^TqB)sy zdLX>El1k3)yp8QakL_0lAyxLXzzPM0Jt^>cn|nN!jo=_;qJ-+2hY{^MtumYl9$;73 z-qSmK&Mts1El_~I46C-wH9U#n`zcDeYK;~1*O8r9ntO^{%xs<+VE=9qk@x2XX|%8 zl)QDoAl0|Z!Xh<@Yf(W`&9su2Cv9OzN&0R`QB?7c%Ji<4A%9TvykH5r>po%V_Sc8< zW4^tHEf3+Uns*{Z8E6ql;05B)&|2g|HuE1Xhay~oWn-U#Pnh7zs!Kf$l|286W+Bbk zW?Iyf_E)2b8--*@+0GdnDnJB(=WE18rq|3nRz(oE<|IcU1kHS-2=H=egT6&-BjSux z+t*p6mL6}MjUeW66Ml~Hn6*Wmlh676mYU3hZMt*`iMu?H^ajRp?lko{(L1qV0eQ+@ z;FEPLiNeB)xVZgJV!R8AZjRS(&gW_}b;Zwk7YRCYH4H+aRx6*BaX(hp&Ec(UJ8W1i z>)^*pO1-XBZlvLQs>Vwy-B^*b=w1;P58gjeL9Wd4YUp3dATg3_ZG~U}$`-hON!QYV1uUzd+&t=;c$SK!>ymy z$GDo1?0kH6f&g(ZB&)kg@{c+2aq4%<7J6#040FfoBVdL3-oVUGW=?Y4lGuz*teO?cbL z2S4*@rO+cy`tX;VH#i!7!^KZUlGGdqmoDpzu>&KT+v(Fsf3N>~Yptm1$Q&zggfN^s z;Yo>nmYAbdg9dFL0$PfO>!i~YNind&;iVGPKZ$r}#wOJ#9QUJLxlD6B&{r!4Pw$Sl z6Fh%7O1zWeq|hNtO=_Fm`^m$YMd5L7w-D=cBb!*TAowP<8rSP78!H*uAGkYQ3*MJK ze`YOXVBu1F$n59e7YJCoPhAOoq&_Fi9%x9`iq3IN(#NGkQy~dU53N@B2@(8)(uW}Z zy_BG20%Rp8Y4#?~xR?1S2dycIfI+ax>q+y-jYr8llmhG;2L>IqWV?E*fXnMugsu%N z;Rng`iuhp_4I66Jv^>EWKN{~$X%ZxfKVmch*LmjNYe$D7T`J>0jF%ysKy$FD~HHEYEp0|+Y{BAhhR9Hz@1yL|pcal4?DCU<1 zz@bj#R&elaCbeP*gc~n`uz!>>Ep#@_s{3q$oGpVsljRPSt<$k@W zC&R_47dJkZccShg@t(+`(#Y*kh=7$0gl(xIP4o&BtRcs=%oZ60lcR{ecoI{ea8`u} zI-)uPt`d13T9rougRMc@YaEJAO$s63doz_3^7XrrfkA*!_J=U+zs=|M&E~C1tz94g zZ8uSOZblA{K5f2Glf8o03lCc*E=`1DgyaRzo?>=e^U+~)B9%LSOH`T|CceE$Wc=u2 zr^JERLY_E3we5~oXH0xZ0iXix(Cm_v2$yhs`^TN<_eC*jz)Uc|e6}mwpE*J|3&MsaeiTQmEy^(=U zG^Axt%Yhlb*3cHAEy*zx)v)|4ztJJR9K*eDu=PBe*6Ppy4?1$lOvBjg{Wv0mdd?!|ab3VyX0=Q1os z-tMwX3$Vm}8Q|B8s|8sFt+3cDWo_Sz!TuoJDSXRLX)K^YjVMqhYx~d+t0E2(>$!Fz z(P!>Q@W|nT0~Vz7Jdu(LaTwsbNFnI-+0J()n!mtL9nB;+l4i{R}~coa(5zspQB9OTdMW;QJWU=j$@ zG`OB>$#6w?-mX(vGrEA^z5F0=EWf~=hR$bj!>7T{r2qmt7n%TauY8ec&dbR>i-|vD z#C>IWfgp_3L;b4PIYJ~w)*7kEZN>WDJUAeW=~f;Z7$n_J?TUKgD0y=(RnPaBx@uL- zW7FdlxK)jf)8jx5OhV#IkfUlaZfUwQTT|vhn37;&mk4>ZzK3MQn!KFe)8~Po>Vg%+ zF#Km32>jLhlA%$^a~Sj)pr($cBu*3@jw~lyfK%cMjJ!Wj5S-&S(lZ-Qs}Gioa_m!o z*XbRip$U>g42FVNf~l^Ve|?fwZvA8h>LFgkY+dM4=NZf-!kFMW%cOpGABFOq zh|Euz&dlC zYY2#L&18-b{SS+lDG&Y@ur9{NCvh)@jP`6rVXND@SC>3$6hc{#gbha-f`KBJ51aA$ zDlyAbZW>LBBBp{Xf>O1k^^VFy(L03?$81^yLiZMKCldC z4SDO=V$IH_P)!k(+4}|s*2mOi=19VZ9es`JYa_DjJitE8a5ipFs~;|$jGOAdGM?;O zateO*8?@Wry&Ii{ia+15nhxf7L}u8UsRX=Xp#6 zy7VR1)*uM~lM`|d-M?KbcEGvSEaU4Y_`*&$id^pBFPdr{vUN@kZs}K_TY+I0r+C^6 zWXM9$5Xj!vOlI0+r6EtWcCnz|Y9~_!@s3aaSP7_vYJmU7fYJTRW_*P7_V|?;DB5t2 zemSzN$sk{}p9Lg!*g?x9)gITOmlR$};x;YPo*M5LqSlWf-YIIPY9`(@d+PArOa3YM zQa8S9J9fXR-6=SkVFBN!0!M%qfSh$D8g*+n#Z2kmdk4odxIB5;Z#1D)I*|W_(AW~0 zKH-1^cr9^JnGn|&qWg2S*8u}{URN@Y+W9xWOId%QqVj6Pm$E<7)+`>_gS}FGNi&XZj1n+ty|C9T5v;}jsSe&wNwoxUcSK{Du)GZ?#e6h8GBo*(6GlRNp z!S7$?UaztR7_)Yp6K$fNd&2losK%r!$%#=;jg#QPkFws@DeLZ3&Q_}1xna7z_vYQDh^i~KIz82i(=$-5=Ga{`H>n& zU@BoRkjR*Qt+msA#Lv#RB_vW9guSJ?rR*76#v%;5utNCZW1Z`IdaHh54Xz0Eh>E42 zXT?Pmk1DrY0(Ip~i7m&)dQ&;pg!@ma3K~*I+9+$r&;gJRm2HBN1xa6uR03-y5G1B} zuTVX)M#B!8PJkNQEstUhX&(O^`=TlB5+VR2UgPl7G0jfo?p-CDLxclxKQ;FNK|sF0 zy*3|l!1(d|v};=Nu)}Psa)JBzN?nd0c%1adY{0&b(rie*P9w2k%wmZnH}mn!nDT>b zRpI%Hf8gBJA*cr>`yDfQAf5eRnk3-@q7NZvA zwCCe6f2$}kmpti8CxjKU^vJ1ig%}SZB@_6eda;QY``o~?vN9kOkWsdv;oS%0zlcXC zm?(B@${GIVn{9MB+v566kP372EQ`bh;lg7sd>qImDCtTl-C&0sPjDb|?!u-hvVQh# zBuX`|=YX-C_!yxl&;z~waUAsa5gQ8mXt4Rr#L~}qha=_n)f4SoTc@<=?0DF}FCK$= zk})__Hit3`j1M(yUmfH4Nwef&H}LP+ho+fQ4As~?ozmR%!xaEgP`WE|xqXm6P!OXX z3g5x7KHdEGf>+icLrTXY2FD|3ii4oNoCRxK`pIh<^sC-fxXqqMC{cHBHeN@?NRdy+ z+mt+v7e+GZ;cx~N?Z5afHa@kG%WSM3F6m+L5Q+yZ%>M==u(W{9800e3dQ@nF*t%1x z(;leJ^jD+74ow4ASW zR8ycXykN?~k=(TPoRcUe@%QiSGR(SCppf?r)0yvIt_IeD%Gi8DwnKlIppcU4-Uj1B_G0dvE4-8tGar(=2A+fOQ*P?S5R^4$@e5rdU-m!0Cob;v){-K@UeTr${ zefxO?_^ROCBK3h0w1E4)5TAmoEc0mHVrKqFFw5*4-cD=|p2_~xDkZ)x1=crL9r*L4 zjPf?eumY8u;f4G=8SlY_vC7Owtgv{y1#JSbn0?@0cXSysHELbqm3lfSm8gpPRCVKx z5!{n#$VK#zwvVu4E-xQ00x{%lyPj~TTvW>>2G`P-w@-Lnh~0R0726NRhaktR@dR7> zCk#H`&7ie)fG=Y;JG-MH(~%BV#2I?C>c1O>7-q?rfw{h+#jsgVfzVe->BvywpYHKQ zSu_YASqs)RS9$;u4`?fn@Wdm2Z(pte2-;zsDM5pM<>tdB^d%57lo-m~Yg+UxXj7}7 z+k_F#C)=-L*T4hmvq{gLS03XlBsHuUTCEeS=(uyvxW@K{GPLNYz|vRAuGFm4IxbrO zGmC)T)oZ5Pi%Lz8q|I^xJ;>KJrj4FFzKs zehz^9@t?*!F02xDjSrFW0z*<82l@_c^UMBdQN^_w&|gdF;1DvGdHFCvjjp?6BV}hy zLP0Dn$N}!q@p{YAdimPqprYK4|HU3netiY1oQFrud6Q7VmNZh=7Fu1Tgiw~s$a?HX zFR`A&6cv^-`TQo;N7=N)f#WGr&o{sX7k*n2StYipL!i3-T*~B|SHag&chMJ+#5V;b9cB#$j|xmt*+;lnf*-xM5%XU+*0>b~UPPn=dKm zQy7Lr(va)mIUd3G1nzkvQRSYGN+Ec{v-Zt+qJk}`Y>71->K zn~xelscUe|A5XN&UfiU%sgW&ir1{*%jndA9mG~Mje9f*M@PT?0>%yH4J&DhqX-yvI!YPG6Yb`vS(Uy-KhnVL@_4{0 zqpKM4zU$IeH>0NG6~0if4rye@Ycl~rxUE7r--WIseh1v{^sGKsnuQx!2?D!{Rksey z{qg}Jh}~In$7`A%;@9imz4fO2E;b3b(9?9Ar!CM)l0mOOPB@@3jz0Y&S&4T+r8u^t zh)zXxdD|e?-P`O}Q65DjG57a_1z(<92UupkL=(e<25TB}#cj;;A4|WiC5OhgkR8)7 zJ9c)UKx5?uds2eSf+pNDAk#x?Qa%h=a?~&5!=w)VajY*wwnjZjkF^h`S3L0eeldyq z!jjbrG0C?04mM21XnvqFGAd!aY=w*OR2OZnfm+3#zxJz(*zjDE8qoKK=;0ga_b52p znzXW*&OWQEHPI~IZ}1b;$Z7s;xBD2*L_KOkyMoFQ5ELEE*`HO>K4an|3{d-EzhB?D ze^$B3)U%t~LGm;VQ9SosWAn}pIU@}9IjaQobm>%1A5|LVAuo3+#*UHw5x1#_=&$x? zWRt5x1-nwFU$*lFcfdrUuRmpDsqGbcl~=+x5du_I_z4aq-Y)ehO=im@3N2V2~{Yea4{wDhU>(isP=91gPF?~+@EgL?1lQ^Hor`MJywn=l^uA10j9(8Y?C zq_8L~7mkVERG^plx2QEup5Cu495ZsG+Fk~rnYeWsYlzA=A7O*7w88=j?w4fC%lBdG*~yzg@KgaQl2QeMafNu4P{;+()W_aubt*EH~-q_jB$fzE`M= zZ3b&)g3s7%{kjFQyGZ*i>u3V>L?;6di9CPR2h8tlXwY>lv4^d_cD|wFYV{IuF~+me zA3v;VQD-t#9TpwpY8M-)4yxH2E`?Aa!5`>vJWQMzi!pEB%ui19^XDVkV|O$=z@E zjSU|0yTRdMGL0aGzmgZsGXJ>&D_(5<;hcaN<3rm1@LhKvs*Op^0HuG(SLxL7iM*Wc zy?W2uW@>p?`nWE2OE9)5`iDtIojO5oM{juxVFU|7&<(;3JXi4YSmh8mYoGvAFIgsw zHO~;L6gUYSX-0IGq)M$8Lgij6x=Nf*S*ZOKh*a7@lT06(WA_ z$*q!IuDbNU@fvw$DE^04+T7cKklFf97-La{ISGygXfQJT$6PQi(WDI}PF2~E_tT54 zhB4Lps6DJE4q;O-WyoCnJ&Xhk7eo*`aM}#Mqq@V@0G`_ed;RCqd7m@U0=yd%M1y$@ zMtY3ZwVd?xA!g;X)G8M4j8u48mZNjVCy2L>*}<>6U#(GlgW3HUgr=^N`Q>*tU|alv z{$k9R$YA{jGFX;@24(#UMhguofISJD8>zP9SkRc=6*?kzGBWQR0@9K_LE9Jbzaaoz z4OPK*z)}VpQI5~``+Y|?o3p}c@Dn6pkpUV4wCBham)VHtQC)Ap<^bYF1K(T9#P@_xtaJ9aWatlzO_9G-WtOLHHpHw zEG-bTtiIR^ZuAl?irphFJGb)dI-}$8HF(%WC6qMTYWX!b;G|C?VP>Ig|Dfw_{J+F{ z1k^+Xb`75+8E{XoRA`oI4-|O-K%drQ)U{$tl#$@3mdl z#u~9JN_#A(fbO&s9mL2X7V&kX52-UqGY zluh^JV4}C~WT>!Qv-zcrlMv4io?^+xI5tQOK^{5wx*ilXR7uC~GEC#2upFZeL;>7M zBd9Jo@)yHfr~kv#>{pH+wAl!S0t0nnp)($2elq!7MV)1YJxwV^&@e>&^)qrIXRwFe z0`lsO4?Bc-W5dlM#2}E+G%ctD>P9&0?#OAQ0B!4_26?^PJn1V5~;a1FZa% z{?ZZxQ9fS?>2`oi>)}qm)`(=mI28-bqy25T%+rH3B|%o7 zWM$B&LQb)BM^ZhDBH!HJuZxC=Wx^c=fDo2RzlAR@dw`@y7OgIhn;j%D26##xL-5_U zk&b_&7h&*Hdwil*b?hMDYrr0OPAcv3QgfOpxtYy0xExde@{SsVIN}8r=ASnfRIKXQ z?kYE?KP7sZD1BZ5D2H&G+}dQXTfqB12pM0Zyy=?e+$E1E@I2o&qyI&3|{TjMe;jelqFcY)ycDTov}6XqoMUfaT^IV)*f3! z+fnE`TK_|1)m0V`B4K_za6+Yj+xqk01cH3xt<@|E=Vn)_j|OsT1(^KI?fV!Up}8hS ziNv;Fl#s(~Y&>1RHkNFaH~e%(>XLu>>NU4^j;I!MBL6y#TXAI#p5ys*;KiZct6{5h ztp-Vb15e{VQn&lB*-iFw3cQitNGmn5SoeY8^SOC#(m|(x;j4z&()ZoYLOQxp zYcZ2f-FBU@K`E(!>m}xnj*mYH#nj{=-odn`@%tnOd(6Nj@GpcM9oJV0qBl z|4qi6RX$JadYuYQxiCNi(-7RxCTslsQD)ipolkEZF z!}Y*XVR!hsEa43pGuygnJsvAZ!$HQ~(Nx)xGG#>J_9)IIT8}Z>8NpcrmCo$&FnR~D zFBteM*=wf}IS3v$$~3${OQ_VxVbBJg{6ZyV&e2PwI819jn>Dz+LHWMq#jN!tQpp+VD{!# z=-vAGnqG*u*Gm0k&VPyB+I%roj0|+xM+^so94+e+I>AG%(D~QeceY-$#}hV*7!4{y zXes@VW6vMIKLWQs!xVtHnFv$g`d{}F7DtD}lG&7UDn~wEJo)O7^&0Re%)P(hzfN#a zKAwTQ`GaaKlDC3+pQJ@*(9=ql%;O!yOQa^(p9e6@wK+1ZJTH&yg=0Md&>H9A zJ<^nK7$se}O80XeX+L^=vw_~Vh-yu6r^#?Ar`7Kxai(ZKgO@Df_L!nKlN0Z-v`R7z z)m99!CaNuj@ly}Qj_Y^$!z`j`&~-ln>U6YrGa(dx)ZidYH7pQ8{iTrWB@);rOEf!a z$_H?uf#}-B>{y^>a4On1n&e&g>=gFDn>F53R=w*-jRJc%fJ%=wAN{rpE%mMK#MK55 zbFHaZVa6+*?PT2V@8<1?Idih8ndb5;q76Ta`KLCNCqQ)`Ll5XjbD1 zqkL_Pu_U08*mB+%UQt67>_jaZ!$-5k zC#7p6E(AB_+99$2W7v`E%+032JShPKZ$Z9pFrwPHRz6*xx9)~!rl>9C1>SR=^@EL5 zdE$Rj(!cY`zg0~4;7`swZ-T5Qm|NfZ$X_9I5(IEF#bUo+oX@Ku2y?`;lAPPEtND!EPVUYa%;x?cmQz)2{ zm}sFSm!RKY2#gBQ3O$8f6Lkd(UK6&<(vB9kxa{#)f>D zf3gCqtF?q@Uvv$D%8El<6wR}}qVvp)BxSGn*8Gd2O`nU#bqbx%RTUuMn|~z38lGtu zMST#)Gl#>??l53JU^zMDH@dM&*RMHy7XARw6x?F&!$N4fv8+cMj{kvWBvgT2^|bNC zC>Rz!xrsO(pzC*Jsq#zdckxHlTT|1!nig`%;z_zAwJ@(P`Af5)Hpp?xG*}8<+oa8X zQ}~5hFlxrW&lH3i+5TxM7wR{l?av#RD5oMl$#|gm%o&O+dd|LDhgw`a62YtCkU{x# zVxtJ}iJRZz3vq(Go)9Xf!XVE0q!8&g(Xtj??T*<|crk&Df~i2j3%!1z>yjD*3HSG% zOIY$oJ+8UPmcDYO(F9)NUD`~X{0QL@b9Zxb4D`S=7@jjmC;)U2{P47Zv#r%H0PQMx zhLR4)oLvTmvlt7wdDC&=2H()4?lPDGh2!~KAQ#by$tyod!&1^jh_6>cIi(He!7B1^ zuiO)GAQ%{#0wMIW#tJ!;fGeNk6r8KJ|XD=N+T%Y{qW-Cu$WRCGsX zxlO#(eM+ndV20R0I7y19Cxix!3I4&5P=ffw=5@t_4p1u@r>#jxz4ndH9KOnO&_EH` z@9rzZAHNLO;=BPa_pks03B4xcs5vFR5MRwNN)l*f=d~0`aRSs+lFzV0$#%T^7VfdJ zqOYh#Zyx{xeCmTN!V1)`xRg}MH%;U_$%#k>3<_IT7dX)X06>gEnrJl$EvYh?1ULWw zs#O304mqH9u-SAULBy*2y)9er;FBsB;2B9@3keA+@MsAHb7^9jWT_>4m5yag-)(@# z4!lj^Mm6Nu4{4_qYo#D*_pQvgZzdJc>JsD%LZVYqzh>Nj_Cia%!PrYR+nb@Ydmz#a z{-;q7-4}HXvJrltd0moe@d{J{UBo+;2Ah9i z#viUIc1PvMd7aW&WUXzXNzZ6krtt25umJIoE1f=)Wph*k3&Uk-QPLSO>C)=aZG3@n z@ECBYDkF!`YtL^d43lSXR`x!KldnL93kt+U<5es*iQynw4Y|2e#ZAJhYt5c=O}_=b z*vrDI>WKMYF|%Vd=z1)$hO- zv~I60JOAD;V%SMEnFzLT3ouU}nW(2%0=5~C$ON76DRUMXqHS&Y{^Sury6&9;+ERr% z8Gp|!(E+^YBO!Wy=7I~Q%fmnB&~C(L1oNMQ5SRV)o07FD;9q+v3k;xV1ep*5{(oCO z(lb!LT}4IL1sy5-PTk7rpsgj!W!+^kt=tcU`+q=yfz~TVkUWo`lQ7)~VImZzUE4cLNovvVAZKHhVyCYH6JTJ{ zfzEpR1bT&lNS~z(dhuky1N)B;oI_x;4e2|M(VT?=lkATb%NKD+aQ2?JoLK5)R*=9S z{<40-_}BvLhtbTXV_t>qaxSnkUo%r-0XpS19ULXu1_Xv)%g#Ydl7yPb9X(LT-iN5m zjL~So6)YbvIcR#g3+}@Z-;ppzeZ5~T3F9+c0Vn1^9G*aJdCQ*JdnpEMUYFlVAIlt}YpJ;9-iK!ah$bjV~hlE@t zpN0GEPYvA3DL&m1IQa-L?WaH{wa4myx+>O)a5>R}eRp2Ra67w6YjpC>SrWycwY=>J zR=H9q6Ywu%elU;%q6blbawr8p2|36B8wz<_kzIS{owI4iVAIKv8eh*VTX$`sjbd!U zt#~$j@2*tD30g)e44WdJ09OhuWZqZcvyeRBr2} zWrQy=OE#9=RK6-W(@}HUmN!w7x^-u~xlsyr5gbg%M>Y95mGgR;X9gQok|+AfX_Do8 z@M~$bBM(VEhNWbDW5va}y-ot3j=a4CA&$=-Coqo!vYfMF-P96pakvX_BawKeVsBaS zoG)h)zeLU`+-q^^i91lfSRuRUubG(s_A0mriSI%@ET8SR-Pf+0C)IL=H0=Y1U^S&n zVhV{yGUQ8)A$tZtiv`%4w1X;7How;2763oC{NYDLEh2Hr*rMN1TLEmQ$>OV6G5J(y zp>oNc9RnZ$(u|``vQ``#5SL&nm4gGytP&`aca+w{xQxr9D*_6@wuyvz9;l|_YF9K97`48K?lZ`^H>{638bX){ zOdV$IA69Zdez+WeBj@W4xyE%ro^@vQprVxHfz9?hD;wcivY9 z5!8*;k*tc+vdGEH82_csfJ^&+I0gF6tG+&%c}^o>sN8c!v=F0LWke*&9EtkeR@L*q z#Lte@!)2>bPtqyHKwc%WbPk57L7R&JHJ6o({-s9sv{SkfODR6rSzM7i@}5@Y&!@{Q zP60z)4|C8EFVbPr9(FRVZ7AmJWF``TfE`H2W~~~%qP#q_`Fgk zNnZ_ql)=?F9||5-6-A~p{&$;T*4RRWw|Ki0{&LKL?DM@I(PlR7jsc$P-@E$W#u&c3 z9|zM*OdZXJ)X&|(Ql_$YdYE|po=2@7dJ%oJxzbBwohlCPWjjd__tlu)h{If1lQhI8 zyj^NJCd1?8%sc7xJ4I?rYIm}$*oU*g=v!Cg0fNDZc!}_svJ6)V82Dd|Q~g6C_EuQ; zKSickT5|M9wev`^!f5SdoY^0xMEPz)ugnmbx~LJxI1>H|5*WqZP@IS=ReoO}KCl-x z#8+lM{JbKc`~{As z@uqoY$jDI7!73$7v<9rZVM4H}c>|mZi@MfqO8jt|znXegb+ILyo)kZ6R*wchT4?Lz z;Q)F*!UCQVsMh_s0@$N-7J1iCDUjglo#ZAcZEkeNsVM^UQV2V-xT7}crLh&1E;)%x znT(=+bj`MgUeLgSoT-0%u-HqiyNi*)hxcTwa!e>lGh^zAh_bU3gfYvdz@#Dq#AvV? za*|7;N%Hl4j$jIT^R`7R61}~;WIKl%MfN;852Zboc**}t@3Rgkq<7XOu6)O%xN|pC z?STMc%FaHt8$;)mB>^qKj&Hb9ZIV0fyUBvgpU5ZE!gAhpA0J;|`Bqzcc$*e|+95TY zif{k}zSI%tC_n(6=#l!SOPn0vN9!7*R1G15hgbu$y5j{-JpZzS>-KI@!dQG0Hz>o& z2M-!|Ui*6?U+ZVL?@pfA4E|K{Mw7U39h``F9=|og_az?mUJ44)f9`WJphLu5rr++B&-pv}P=`E#0*HPSal`vr zO=R7l3|t2?nw=e^kz*N~4iBrQ34x6FNhQ&-#jy7(rYs$N?#?JGCGmu zN6N`g+9A8}@&Yd$%x3!TKCc4!Ko))n^e;672PWt^J?K~GfJ$Dqkq^ozhuCBzFH zixr&7Jtiw^lig5JXm}z{R0j*)#%WIx|7{mZq+;9j!JQqy&NT!^yeWj~Tk_ z34UpMJ2AY+o!x;L#5a7$d)9hA;m?KD4_b**NW>13hA+ z>j{6+>M6+HYy#?L-{}?-=)z;@i+KdID4w@W(ge2_Rfs&O8al z>cF_+T^)RWekZ4Z>!w*SybNwpi+k`crAEGskR%bWz@u!TEa$TI6w27Z97%<)J8uTA zvXo0M{6kH;=d6T5c_;4S5#rFM>!Cbo-O}#Wo@%G%&$O4yt;9aAK;G9} zo|`3Pg;6oQ*4}9-9{42*w76KrI787b-a7GCE{e9pN1tKuNw&2gP-g^au=|IfQ;`qp zDm7Nn8%KAUC55pp78%)Rx|m(ain(O6LgAC~bVwmVdQ^(i>QRy=7}qIP!S0XWWWu}`Ot}m`?oM0JZ31AWflpBKXuoIYgLCC-)-!kv5Ofb z6pNigh@)UX!?ls}P~9p>hJv(?W2;KcfUACK;z6#Nf%MVN4z?!0T!#_x8hUvMbdY>a zs!yADg$ud|NFEAvN8vt+pg^d&8^5qEXK41sHHKhi9Ff5%@?;AftMcKCC8bBlWf9IV zGcG=mE3%sQ>$j<>qO7TMwS-?d5cJhI?aWt({c0MLYybU2y3M*9KVJsCMd&e<07?O_ zB5{m82cn`-SkzRZAvu~MIh4YAG~v^pPFitB4k>zIdb%t8f;+{aF^495>WXEj$ND#Y z6XhnW_{7hWWWvw14{`z^8nTBqiSC*n8;h%dW^M-VJ(ZW&4qTF*!~n`SdIy_vg6-0j ziOHY@T(48&%w;sFy8NNfL&FUhKPtdM0PoO_7N=8=KB-1W#zhwxV-}h{{T0apmJG?8 z0zQ@H3PFvA`D^mfe*n`%!&qG1${(y~aEWcNv+(>sqUF~CZK@j6pSPlmBQ|hG0_6d| z^H8|ZjyD+m4`PX6&FTenlK$-&$rm?>BCGuEE=^<}=zu#;rastI9}Xr|-C41UD2>wbV{w71u(B(sVg% zfpk8TBg9T+FE`o2Tv`CNlHMuZ*ne-79hj(W{OQ9wDN$OLdHEN7*{?_zlmG0SLIcIK zep|*h&3b2+M2pFxxqhZR>69E1vig{Sp-xGUf(@0z>TccjL;JCQ6TE(*Y zEhw2aelNq1hMP@r32K|+N+_sSWC-#6o#IXL_Lc=EHr|^yGQlFzp8RPlk`M#l5-2D& z4dV8t`eI%uaHHbM_fssU$ho)>7>vvAt>~DLAU;j6QJbeUle=OmF&P9E{M0FZR3s8q zUa+RG8D=*jZEujxM>jd$;ejiwN`G$|gogZxjdG#7(WAm_hV4vMyUYZ};d|JDsAhC5 ztap#obT3C8B~?M`^Di6EKsZ71SSiXs3;u=`}}NJ;lJ#YGLQ)|2kV92s=+CmMa4 zZ^+<;{M%ZL5!AIxS^w;8apsg+qP##W>R)L(F^~VyRAojNP%#RmHB6KmtBYG1w~9uE zq$ujmuc<0SYTX1ghdbz>IBzpq9_+;WOULjjqMQTNZ%>x(wsNKD(wd>Cs^LWG0barD z%WSxA{JxwVH>H3F5kNoL*2}r4H;Mvuj~;?x{Fj5_3=d&=p?i}72l%SDB)&6+m=ae0 zK~3932?h_`x=>6*?I)fWt1J@tI+v~aoD*BhGH*6#J+d_Mj)nB-SgQmR2Dx_-E5_%x zAowQ6vZ`u=iEckxR~z>8Meh~_%qdNeerhw{93MuBn6FyHel+~Owf2Gg=LcQ}=GM|? zm0O(t=fpGXgt`a17YG!XucPEwu4(med=O}a@x*g~SRQpMS-k`&HCr42{$_6=2b2Bi zI?mywcab?8w2K_d1u#sU{3K|9@x;OA6Cl2+79G0_zS6^e{oto#JEgt@TTr+uDDwWz z8N{?+DPwXXt=SZyq7!Q?y`n5dn5{`k6|!^{UJCmA4?i_Qehm)?7iLk)r-+jq7W~fr z!2>fpUNl_?x2^X}7q_wE%GJq$gogSKTmtbnE8`*z4b#rgn0TyZOb|4-owE1Z zOPPl+>qc29g zm#F8(L!NJBx7LhCMEtp!+TVM>Zyoz+GS)<%8wg_prI*)&NA;MlvyJD-%pTKVwjNB_ zGXW@Wsf1rBhc21CArcITvZL!lPT;We5yG&#+9V7x<)iad(CR9dKS*rKD7<=4Kj}q^ zkUSXdJ>fg#CugamKJq6K`Czn!;je2F@DLvUpg6VAWTs0dvT!4=J@@5be*OO>qMQ5wqfs@ z;I37N{JZ#VgmhJ8th4|=-25r$IpI%+Hzf|E+0Yz#MmhLe|TjU*~$(y`CbWmkQd|F|=L{=LYYNOHnxUOXB z0BDK_cB`j@EYe6J(Qz9*t$za@KrjLOYVWPC3E~Jl?)PP`93&)^;RGPgnOwYOKYb&) z@Szu})1T>8%BJT?|3{cQU%KLzcvcuZ?*N8>%uQu8OxO4Et ztc^g|6A@50E#RGF(t?Qpe$jK0U85@Z7VDUL`f?JCKOKcm?}TG1)!y4albXQg#_`67 z&KdJD&Kq2X~N$lH?2igI6+s;VICBq#{JW#nMtd@OQn|DP0tDz!Qi#)JV!7oW1?1L z9gXkkGEN(GAu2Eue?-1U+i@)%?jUA>xRJW=E;FW+_cUO7%X>|i3U9QY23Nss>0C|Q zg2;>;YTv>%>S7`zJmi2$)8J|MjR{O8ias<+NnP#)%Td<-*Nj(yV6nCEM4G-1cDADd z&zI_{1cKmPgG43JD9mR*&@w33URHA{1`w*x5O;S}mx9(sJW5PW#RsP?NLys9ID?^U z;@zk+ndDyK@J$-^2x4#o07`vf7JCtDh?wMaRCku#M}m|o(v7k}ubZ6J6<8VImI~<% z+5Guatr?a~p8LBA_Ps|on!sE_pCctlxUwrH@8F999Lwa$2WP_`!448bSCnPOVE8|C z@8N?EVnL^-5W}-8nNzb>P$jK02zrHo63D}~h~&SM*npm-$xmJU8T2dOjTaOoH^8n} zzIOKMSV)q71Sjo;L5GxT0z%qL&ae6=`BHu5xCHMl-SQ1Lzs^$ztng%oT^!vuC)FN* zUvF;tca{s4J~Qi1n=SwTKOTk`PogHKA=BYuQmJ6}_XI?al@*2%=)65sn^f{x4b6`f zyh$U+nB*OFHYgeJ=y>xE!WOK{H=S-u6FZ;;F|4@0?TXn|QRz0cdM0I6lf+&Y+m#mH zr4P}|t3*Vn##$ZH2?!F;(z|kD?p05Ap=@{C%Be01gktao5lHk6CVt>mVp70-!Fz1X z3M8dE8=IW!-J^Zz$qtGiW3%|Fatdc)EZQnVZSEy)8|$NN@@%Ln1?_ASHm1=&Vm?HY@*;Hp!w>sO;J56FC z2*V1YgFh7cgQwm^l3}R`tR@??=^$)_UcPvNXtu0P??H0KgQ7V_k=|Jz~%zBbOPk8xPK682cyN%IpAr zzAFH1h8o$0>je*xY|&7Pv#8!-z$GcDt%F2+lwmr#_kfUr~LSFAm>M)D+sc`lsZ^%xmphT+g`JL2I;1O6CU97i$I5sB* zv=nYKS;cVnR~uuU$}bXP`gkRH65AKBO@8h+G^pEb}LTrr8&=lT%bWZT*r34Mcg6>B89yA za-8<0$-KLh#<&ZNhAP!y?`Iku;ZB9v=i1?m!o;l7gN&J)olG1@=HAFPrt$uEKruJ9 zm_t0wPKY58mM(9AVelX<2x z?>C#h$$%9{SteLk(nD#~YEBGEFmodx0XjkEg=GcuWFBEk`$jIne7Y)w%16EKZ$cAIE#rt~#bOVCT*h~nbh2{^Yx1o_*mda@F^P1}`em&t?#OBRp z75Cqod}!A8N?NSeu(H<+7GSLcgf;(D5jVD!326 zbs%?rgK3aO?hy3Bck&_ro<)MZwZPcd#VF<& zUz~lj5joeo{p=c^2Q}9f_eoCH?T-Bc&RQMQ8-yA7ZN+cPM1qS%U9Cf4Ae;c#@4yLk zpj%2lkKcVV%HYy^li2^L6kCLKMtC_y9`_r-^e_(u`w)hpiHhJ*ulT-!>6+!!ECtM6S`hRKY$`s&z2s_9Mj#4jM2$`|* zreE4Nb`Cl_Y7e!61+eQI2Y9WyN(Ol>mZF*v$8fis=R`CMqe?9_>Ce3gl0R>oM&I!6E&zq+&!M&_y;nU5 zMSnaX7x&HHV*gCd6%~vqAX1+KxdvP}9yJI|L zAY$xl>K@6ElD1LSxHLT0wnBh`+-j|ai-pbVM{dtZ+R47u|2Ws~+cw_&58o<@KJN6g zA)7}9rJLq#?k&anUZMRS-LcfVx#ty6S4%9YqX;Uh|IshUbdkAWxk*4U>-_@C$}q&9 zHX`~;S52(yYPdowBU-N3>5|8fhMK>lQqQbLR<@>w6Y?CnOjsGochgpQ@JEcFAnngJMvf(y-}U*r6w=*O4UkO_WhM z^>4M#Vvs#Tu3xGcF(oEUK*HBm{g$4_s&d$_U zLtAFNtMff+`p zBKsoz3&b^BHc)kXn|w8>U2cwlQY_fSi}i|YYZdV>$B8pDy9_&u0>r%%t% z{PDqgo^)W0huB7IM~G{_5Z65;v$a0g90Ig+&ai8BGh_X_^oqe?UVHKB*fg7qR;T@F z5Y;v0APc8)N@LguA9ON|W|iIl1Os*9I+2_2{NTda7mU@5+w)24vp?94u;#LxRD1=( zfZ@AH1>eY3?gw`8u2$E0?oT}*a$2?4yrd5p(#*NM_M?-iCZUvQVdEkv zn+{dl>(GX0%!N+oxBD9FS*Dg5Xmiq|5m@FXd#b0Tdw}liglmJ{siFkW5z&H^?#9t3 zlj~~7MtU@Tg4vd0QE z>D(m^Uk3{Ove&nb&fAWfU@z|`G*Cg1=#I7Gt|aVPFbh+0-s5TjgtBjn;5z6t6YhKp z)zN@3-i+lte4)YeE=22qMwEUC5OP>OnL|bgUwP z7b-7aTsc@>EH&<47Wqxf&f3}YiQQZ#94+BBPZBCyi8H7l_#oKUxYmmO$RsnKKvX<=oOlrmCx*SW#EB*vKJ z51N9C2z~&&Jc5;V&G2yHWb%9iH}$pRh#eC32WAi94rk>5{Ltf0?0VB(5}L<;khvEy z95daj-u+3|Y}J_O3v~Kq@RGf z;+dafy-nBz=FfOup%^o~A1ou`f5r}pgy1CxoP%Ht&1?ZxzT>cwVB^QkAVMgaKVLgr zM{ID)H`Z#61prgnvk*_hZ*nmNfE$g^vRA%I1?1S}Q`%=RbmP?(W?25F`UtgX^*ijK z(?g+;RN9{<6Dz-YklSx3VV?qstRQQr8Di_O@@Gf(ih4i+`p7mhXXNR6mkAbqbOXQH z3Q%L;+VpcOnkNhchcElpddNO*l@c&cBR(~6LlM>oBX7MKZv=d>%$_^pM)Y%ne}QSr z$ZoT{ekeT5#o<@vx2RcVn9$`F(8id00YS7l&4>cZA%AZX3dW-Ciu|6>1gMtc)Ht1G z>S@jqd|#RODCWBQc8$zDDBpoXOSt(33IM$&j3gX1xUeK=#kh&^;1a=Gn%6tAXcZXI zcCpOV+q^8VF4F(|cPtFyjxqH;uS{%xSs*JqY|ib90TfJ(Mqz*v4ibiU*F7(r+uKJc zPt{ESuKo?(A}!bBpB$@Dpfe700Z~ggCOCw{?T)vjETP;ND2WcS^#77KeM%O6GNA?Gh_2-VK-6HHS z<2noWy+@xp9{j@4_a4JfG+LY79%w_Obbn6epYA-m=UezJy>EZD9k*Vj+F3-dm2C%n z9L_7~0BEx{ts{F=HU|AEA@N~EI7UXTh8VIerJKAF8FO7v=$5oS#OR%~keO(X{#ZyD zzl;`TinElw1z|V3owq9*rA)+G2|cC8AM70{TIavS`_T|pW4v&uZ2Fu^*&ZSuh;>u9 zIuK>TFyf|{g(aujxR^w{Q|=afbx6sYky4vJ9`FYo?23h$`2%LEPzK(`&tvpR$mL#n zjWz8BaQw42h(m<eV`@PYcThtO@)3{+0A;oA7Tw_WonTlbmvgZu88b` zVaSW(@o%V$EttGIy;^&D%>Y3_zQ0w~r%^{yXBFjaMCMJND{-Pth(-YHdyF$B(vj76 z_{C+(xPC@qOR1>GR+@c_L(h`gqY6l*1N2FKI&wTt8;~?!4f*zoTB@KmLmp`k&8!-A z)m;^74SEGGtN2MCSR<}ovxEE(60ou2UYDdfsif-Ebo)t@Vs#NE*c$6gN2DLxHFC#d zwRXP4^0++xjOqXV#{BW$frTi~8J11GI;XLP(3EZweO&wrM7G`Yjnm!p1vV&rb580` zAX=wX#%S&mtdyM7o1^Eq%vn7ANT(lz3EUwnXFZNn(6Hn~H(Y+`?$GLmJaW!F-W5%7 zxas7;=@W}Pg5$;Nw5@6N?vc55mF6`9%MtN43vWXH?_8HJMY2vjNTPI_4hxPerp9q( zJqg@nKahl1E>l9~c(;Ql+`?+msrp$G6*^_EfqZ^^;`de$u)jCbn%z)E*NJHs=OyNm@0`9-(HKBVR8lG zRKkP921nuswFJB!c}$>a-a+~wdk`_|>(>__H{ns;_XUf8mKzDT2FIHxDP}PVr@0OC zQ$=_{hQK2@1b&Qt4G1M*r!Aj@tBwa4!@SD;xi+w@dN*2l`1@SN;3zg%|8@v@FMVwe zgc)};A~FiOIv)tK;2Sb$JUJj{7DZrX3ieZ+4A{kvR3LNVb!0>{-;b4Jjg#Dz(1aP+ zB5x|pgHF>IC!WdGoRKNX4%5-+AE`v}IExIm)WDm%7f3}REG zh$b1j3Miac5VYUp<3G8ZnkD1==r^k&^k) z+nx<=Ve7;tgLj@Fe`gQWplHs7E3sx9#wwltOs>Rx{LnE-|1oj};BtsYes zBf@ippZ+pi5RZR2@A9Iih3v-3P|*y7$uo0zZ|KI=+;8KgH{(;kHJ{MkO#&&?bvC(} z+5gXx`8y5`mI7jvUIDKCoHZN9gQ#Ywg?0^1!1!wzt(+q9L9QXHrN#WYv*ShWB$_ff z0)zfj$+(BA1#uEp=Dc7w8;RR7&p^u{c0uUIu-NTdJP`Wqb^8Yw%O>BnyitgkeLQcI zN6kP7);?!%UoZE-{dhH9+KRh%1LL*xNk~>(Aa|~5<;<9;`6;IMWF~7Bc4YFIyU3unUI-rUwMU?+ zFHR*rFA_h+3d+x*4h6S%zcy1B5Q~94%liLg_oMzBaTfNkB{>qx30l^RE?#rOYvRLr z)WclD6Kc16hP@sIwe8_kR-VW({F7Jo831r^y8BNZ{iD=EK|K%CdD5Kkj|8}IuP?q% zPmRVHVWS`NsK6)SB$N&nkW^G>`%FxZnl!7B!}N^9lzOW#v77Lt6`S*2`#kceuTC-h zTH>zdm%!{lD|tz@G=0dNYy7H?Q->kIvdFKq*pt7nODvR>)=Xlc?%oC2)FAhGztahI|`;7A?S|^SFt1u8879wZZt^b`i`e=_iLfH%784= zW{b<@wf?Bx)9Jv>b{Zf9p&0mpFVTA@PLW_s6DeiyI&Kz|5hZPS**nuWDBMC_-ND8i z&m+2N4=)JJGu)*p*GHH?N(UCA1!c%u+Dx%{{f`v*b%7B1dsQYHrml6}XU;jr6$Hr$ zZLTc9#y&JV?AElroZ)8d<0a*T-w*lQP{(U^?|qcVlh@0*iEb=A9~v)6%UT9DS)Uk@ zd{1qrrelMHy8o`{z)2Dr*#k$;PjdtsuA4s;K>!ccznU6OJ`bgkj-y`Eq>ZQP@}L*c zoHO5r(Z%}vcS1yj+N{|@CR=?5)RkeW3dddBhsK zmNbh*T6BLK_G@%8PeU%-t#MwucoKqz9|neOsd!k7AKNQ;Ic>*r19W_^M4O;>@A8>S zbQlqzio5380q^Y5^8oc24;AxmGxx1NXxXb1(KJ>DpNJAOnOI^_!lQ%F-SA zjHx|{xk z)VuT@BfD*Vunj)>~Hkt12W#Z^Lsa)hsqt`Gt&j z50R0H-%J3fGMo`8m?;q%nHWuxbi2L|6Lp|i%AzbA7>dZj^vsr#CWFJrqVtsQ3M6U0 z;()i(l(+?UvXrvO0QFJnWrKt`@yzYivGU~cT|iJFLJ5R%)Hk7yTO>ygc@FM>H+L1s zZ?uY6GBy(+l`S;7n}l=SIl@DYSSBrsB|9iEp~?I-kqKP zs{RcyF=aGfQ8`2XkUJ6+v-p|sc`J49c^GpYRLVug;RSv?yc10s1-s&yMwN>9 z2c1UK&GJ(clD|X(_=9-c#2#B$uj(|=@*0PG+4y|LGFjH)Ld_Wi=B3z4a%i}(-GcNJ zjj>!jo<&bXpVe@yRztai=pv6Qrmk~dyV(X(Z{}%=w0BA!xTzS*PVdeRA#p?kfNIf} z^`vLc9r;{N_o-4`eH$ZQ-;9yl zxQ+~;1;eb0p{f9|DuGhk`nX-w z#VNzd9sv*O=heO$-utcG`9_qF<3XRFn)UO(5EJ0<72LJ?}5k~5hj%S5l=v$DV zO-OH!q2|-{1%7=SC5(Z~SCRj`+1X|GvISwFc`G-&x{8A65%fC-owx^pxuZj5ul@5g zoK{L1QUA1{U&BNr;-l)R>r1T+&mOa4!iOj_F1p^?FJbeK1bLIpvj?$^yd`VgejX$T zPciI%!pLjy?5`V+1vHRAX8E@Wz&i2&eHP|8_Fu0>`Su(%0vQ1YI&0a4#cwXh80;rg z<(#-fuQyS-^DAwIMj@zBx=^golXmxn#vnh6IWzM{hu6`H7cOllZ#?pTz8sjTR(b<8 z;+i@|km2O6QCVr9v4Cyqb@(d2%fE>{Gw$9Ed%Qc1M~@+958v{=p;u$3#y6)c&oRX@ zh~QG+but5|Ne;03ZP?VMlXg!vM@OT zD^3Z*B`Ee?j{sKrp)vQIguGXXBU*Cu$cEIrh>DC0iWE(Uw>gy^;5+!(B+PfA?BGTM zjb{-bWm)*Wfc-H^WsgS&nd8!d-pP5xPzymP+>NBUpDihfPWETlc$JXx_4-C%+^#}z zF)Lr_$g>2SP%|P56D#A3J0T7`a10`Pf^SS>b|o^&TAcmL^e0T)-VUKYrqzeweHttO z6XFFlCdLXi3UC6U$-(MOlZa@o?{6`sNJ^wUfLow&@(XPBr{@ZobxGIGjqnRCK-sd+ zSM$ib2sJ^Yfv>3;AK>E*y<9@*vqjXwmkh{szS(t=`)NTb$jj=*QHH9m2t8WaeyE_K zfqQSoBsx>@{3!{wIYvc!DBUc-nfZQ*{{MyhiX{4P*ZA01dd@bXXP_#LkhJP`nhx#Is588#FPe-yu~0`8Zv4@{MtO0epJ=I2!?Vv?j^*n zWDK{N0uW*J37^vW`CPR7-a6VWNaSET&dP>YrmEifETAS_zvP6^4-$#3ux`vo2(k05nkyTaPS{T&|QLnFw;jXuNTv^YFH>! z25R;IZZ{T!=Ze(|E($z2&EVDb|F8492MO)cBYB3#;QSzL) zbRNChIf}PU7CjvuM(^zFaN8X0rpEs?yCfDTvYINRp5|W8#^p)nSL+Yv=Xma!z6EWl`li763~!V5K2Lw`%3#+4t`)$C1KgX|vHh z+c`9rX@wG+UZV=1V2<8y2a1_O);mQU&sA~5kiNT3!17Sh1kR~k-v$$(<7K7hGLg># z0KOYhUOb->^jS%PuMr{v9N7Ryj1?9RK}o08e-B;P=sPmw&)a)bP4q4}K~T!v7NT)$El#woG)FV<3L`$y!0K8+#fU|p&IGOJ5oP~0?RiX9jyMG3-H%u2EZO#l61N1gA7@H@I$`&b9co}5%#-bEW-z^3n)AL_+@ud(UUs%DB^cFZYP z14{z%y_e0gwV#aBwZgv2qL%J3(R;W34enfkST6ZdEcaTNM1O?9Zr~P`!|&5a|3Mn3 z>-y|o!ot)o$Z%72GtMHWo36zHSjz|n=5POsA$I+9qbzrI7BB0LAd_W~&}94`Qws@d z4lhz4;5-TI46Be(!Tu1==%7Abm$G~k#5}~sU|<;J;1c+A?B6VAIuLK17;sHA!LtzfD#>rc&>IAMQi~PSXc0p4 zq43eYUPBE5S)<*r3ZT3I{r%`g-wz$P@Dgc%3ztT&ek(IP03E(0NT&$vPLg5i$mR-M z0iu|HSwJVMvi@t`!ugh(o6;s#dV;*a!HOiEt+b)V%y*HAKRE72#>aP8PN=prNqM2g z4RtZ{qrUjd`RlZ|>@qxw8{K~A>Ac80_=RuAGeu zsUXbloE_R?U_&NdY2Ef^a}o3YY=eWya4VB5v-sHxv+?!exD6~TpzZ8Mv+Qe8A51Yt z$NAj5Ew{g{BC3p6k+#3fBF$uy4l$B{?dIqFzgRI4l)MgNk^$FzBTzU*m5O}7 z*Qowuvdt;mFF7VgcgvL5plykg>AU6fza50yO6R7O|J`LkU%=Uqgs6mUdMCt$?ogd0 zb^YnAa`Nm#)uHh#pZ2miEdQd~iodNIpkgVy7S%-!s)%4fZ`omH8T-Z@HG z$fJ~LIEvZr`0G_TCSPP{EkQSuTh$<{f!R^>ssc9Ai&~>mu7X3BifvdmL2zq0?Yjfm z6Prh-Fv2*C_rab-L964b>d?eDYX6N6k#+u7#u9$+gMTo(v%3w zvef7n48!FrEW*qS4FpeJs<(OggBJ;(jj&UsgnmOSMy2_%5G|X@rpbJ}80YGw7iN-J zH|mB+J1U07*KPsMIB=|}BO=3osM=yHe<0NX#qiYc;GMywY)9&2gXeqPeU3YFj+~$$ z&xp=PZRe5PNv7O>V@DsoyGAaos_$syh~DF=)25=l)k0jF0=Gfw;R9foeM^@MN;;N( znVX$!Qc-^{X%T6>g$aCsG0XT?&^kpFtnZ&cC#4!WYNS`!W*lTK+xtvDbtu%VQ#gG) z!4*iWi|1+d$*gIpw0{XZDuzb|@Go_2Ba|_q{DLvAz6u$pA z1}MR5ajrTA`eX&HAhv8G#pFOO1G$2U}COx#lF zv9As1p3c;f4eH_O^FODWBAJt2=b#3_ppG&jKv?e)ahk!S*9HN)vh{V6hLgf`^n995 zQ~|xf02XV$;E+i3&wam}2B`Q13+-J|C|LCl{0j|<000hNL7s+Wltf%B{{R48BW!gf z&I!0tF-}pghr)tTkdf>e2bKd3l$0(0^ZxjgJjSDc{zCu`Y|30j>Y%+m!$yz*A3hBE zPMCfYfS!ZTfElJbQ2A7mW5(An{UHbQ|-G|NiOO?qGwNp-JK005sx%q!kL0D8d= zo;IsX!~B>c&%jDYL15CCYsZA z|1apHWI;-Mtd49OtS&}DA##dAk|hWw<$B1zxtl>HGTja?4ny0$g0eKLnQP!&S9gA_ zoN`NXO8SrYl(?>0(kdYgxlPX}|JdB*HParZz-)(`am?TUIkyC^JkAVgxs?DBK?!TB zyNMk+$GUB;(^`p>h*8pK6A5LefB7ljV0~*#+Ctmj&cCBo`#>qr{u_&y$kRjN+Y%*(fgN+!JkP*dyBr8Dzs)<@MLXiLatjZ_om`s= z!tp;1bG^Qgw07ZLdwJyoD;cVG06T&lk%bHrhQ~WS!9)1&0I8;a&YY%UP%r@* zzrF#~0a1|Kw^-Be?zyWL+ZI$L4v*Mt(wKk*QpjgeG%AWQxA)qXLa@zIGA!qV)J!>~ z&TbrhV<1w#9=8Ca%&ioTifE$ogYTqoj7{q6QA4qqe2U8Vv#tzgRjI0b!od{gmWP08 z*B15eI?44AU7`WE4#Ayy+IKY7gM)K9uy$)afK--TO*l@PR)Yn^4%+EDSh-e^Q_L_K zkNA$AG@dPSYh}rOCd5{U*ysk&dnh!)Z1{S z?Y4r6)=CzTBK3^Zn~|+1VMv-J$cf7hoRfs>kJf)ixt}nm8U!~7zJCL7411d0{rJ3D zm=VpHDdYCwgpb#>^&L8axq?8(lsfuiP6Y(?-=*EEXZ-gqfo38X>0$Tn`pVM!eoS0f zu~M>LLAuAn-iU9|hUfMh5;=LOFOU6elxZJRKUk8TJ7Al$)TzL}8P_v;EXCiDP<~*r zyr)e-g0*UATZ6H9AU*&)TD+BZt&yBdWZi%9X4GK6{uo#8XcxQQJ>xmLk`lWd&rpsL z>yO4;wyf`UzR*OYU;hyHubid5OHP?u+R%z3haD>c#~WH*Qm>ev`wk>V6VZ_-kS$=X zzN5D9I?n_JbR?V<|3@jwb>0Jv9V{M5@K&TKvZy*#>}Yn^%sa8VhVuRR)_q z|J{Dr)vTH~J@Fjl;wqqzf%wu_Q@n$l03G=81I8;*Jw0hVQdAai=O$SiK{9{Jb2ykJ z%KJ3pU4F~@S`>&n0>PmI9gI?n=7~53&hwpBd|c!m7~4g_%io`RHlzn)GisS6>8Fga zS%gg9*$Q`(pKPiz#?`shCi6Jj6!S-j^wwgO<721#-n`VrM)W*?%I&%V)KHRmGZ|~U z&VF9}13&FSGqsYNgLjAO384YX+=Gu0juC`GG49t zPre(S7JtVpV?zLO@iC9A;rp;z+R{+bOd!>Lt#z)Okwu#qzL?j6)&J%I+}uD#pe$=R z&cVaR+3l_XF;ZJYgm$*{Pj7=$V+~n=*BiygVhd`Hk#zIaB0bW-g{ZD?0P>gDkegWaO?;L@Xk~=q|%$)=-uB3_kg;!zJIY!r%1rv5(p*#m3`lzlZ~VOL_LPuJ4XEQcktZXUGJ_(l|_lTiHc3tmhU?m{|2dNH&_EFC7nKU|IE?|T_@|D_M=$X z*h9prAr{SlH`dDjQ5p;Qu6hNe+~h+FoT{^|84K$QQkYBDyz|{=Ff-M7zE8UQ+>_*J zslUY@eHiT~A2mA9PO1e;`$Cmz6fsx-rJImTO2Veba4|CibpM=_J!f*T}#FT;tn zJ%19~l6F3%DN)|{z2eFqVb6;0VB=so>XE*%rp_fQTJrJZ5$E=^jY| z388_YpB&Ku9>`STD5h2M4}*0$d77HJRxK;qaA|3wL_C?n(mfT&_UFnyGMzYo0rJ|~ z3RQy!uH2oJ|ClAL@Nozw164kK=|-u$&V6KjEkPOGv0saIF3rz#du_|0#H%&~(g(CU z!2V)dv(Wx{(~r#YsILRzCdaQyX&xbm1z7N`>2EUbKa?GpBK7!ytw0c8PH-!&B7G!< z%7~h>EXT6v655l3U3m&o)T!;u+*hcGB1rREFwdc(o$0JWy5su6&=?UFFjfPQk42scjx`h0nO+&%E)H`I+PYtQTjcywN*RH!^r{2ADR4g$$l|QYml=9 zNo#WLZHMO2FTa3ed1BIodsx?Qw-6CzK5^HcA#^YG$IQQaER*i|iOdBg|Cb?CF6RZa zzBlRJcu7SQ%cCfF?&tixhDj$hnVB9W+t|yv&{59ezX=X(9aeF|R*w&1AWfw@%yapC zRM^U?ayOTjgdtkA&rW(_A&v2s-pQ8OY`3r&&Xu%d~h5vnUMoYI%2^^`^jH zndKaDVrBdI+IF^a5)(n}%AxCsw|}5gJ0XcGUa&Q0dS4h`mFO3cvia%+b^;McZknG% zlb9Z$7~p4hr&CHJdl?>N=!}ElO<-o@4(~V;pn&i^dV(7u+$N0}U3N<_U$)T>dUtrjHorkf^i18un84Jo8_x^lfwt10ANc`+PF!y#X zn-?{mgk@X_n-SqZWjPFdd2{H+$zj1ya&;5N1V zi0KS@bk_mDzIk`t6Cq@vN5C^75x&-avGy66m`3=KlRs?pJn*8t@nD#(^v8aDVhJ4_YjGWF&{;nK4b;@q4Uk0SZk&*tKK8e|HU+|{ z6X`y#D0-$hy|38s&z-ViE7~AX#x~K|ocq{ho9n;6j}!Ki_r1HmLlkbHgdD30uz#Dw zI|e>tFA*r`wWx$YvzR9w;0*ssF*;J_tp4}I=@&)J9Lq+BiL_OZkaGW08vps&pkMnY z=XJZ>z$xbd0g(NOv_gJGud_5)CseX7k6`G#pGcrM$(0AzUmk+AS|T_rtZgp4f43ni zf-$Rt{$^P#(%2jWCUA7226+G2vmXEe6Z-+4rD+hK002*q9Iy8RO&tV`j;;xmFG1h5 zRZmyd{B9z<$N+UCDq%sv5rd_5g6g!DqHFY3!MU*uZQeXoqu=}7*CQl~2e)?e!1@FL z1a^|&2iz}Z&?D$}Hz;ImLKj!S9phaqiJQ84jv_JWnfQ-QM2OLg*q8ibW{7EQZCu^| z>^#k!gBWm95Ld?!&j?biUXZ9u#=n^?dyVb@zMDM<&$t&*_Zj!voKr#p zdh!u&`;JL>Q#LomRGRucHfF~=9_ZnUn_B55@?X(1l>cP`Fh|R2#P8O02^9~z z?i}*rt8;ONs99TkrL5s>X!WrB(kEh%17X+qf9^&OMh0zo3vw%U{_dbR)7gu{fD7T7 zWz#&$v#uROHW6CGOCV_ap(S)KqQC_&SDkb27`soO|vD!`Ok(C||<)8*bH!%uwItH=$3w;Rn{Yuz^=!EtM&+beD=&0t<-cx6gO zvO0Vs`xG<{ZRmq`)Od<421#|u_jKZO{^^AHie`ctu(QUFCe1G)^+*gNh+ymFJhS<3 zBxA|DF88OmJF>xJdnLw&t=Mc{^&lu+Gxiw(d;_nlNp;d&Y>ZJnHG9vx5Vo zE^APR$)tA=e#8HQGG?@Qe8^xlZ^EN5rg2ga&ou~6=#(-=VSTJo>QtX1(=WFI&>J488Td)w}qxxbgGNN(mPwoYqT_uvV5nx0TS>i=rTPL=Yxg8DRSd-utQ`$8vV z>HBw(q4%}sqU}PIEkvs4Myxgv=YOa?^-com#tpX6Qx92i zaL_q-Y#%r>!S1=|-c;(_SJ6^Y_AR;W=;iMoWz2Oub{?0$*Ixo)np6fHYwF*{y`1K( zrb`1c4{ZG=?vj^DA6u!Uf@$m3MHC?*8O0SDYrdqr@9UB86r_vObSp<-E5hH5}h@!CwAD?<7 zYp*;Q^u<%CL^2I$CGlLAgE~*4m_#*Y)JV?a&(x$8ea%LopL3+$S9QYSL)c@CYJN3j zxZmx%%|8f?{XrV8Cuu=Y=wLtcdMdhcaS2j@O=}`rM^xgo(Zs-?uGcISmO1rItOWcG zcVSZ%`TUnD(~IWbhG(v}gw2*E9rUa8+(*hVf~aRJpeD$n=#h=T1;`6sCf9g$f`8E* zz!xY*BBR%Z1;te<-I@#I9}e;jKGK}vnz9ozX2!OP8(naeVbon#%$ZZX(yY}Nq6g;D z4XN1ARj>D5yx~-HR(pJ3=!hsiERwm(7U?*sXF*o2&t(pTHnt$mTC{f$D8FI_y2li~ zF?A1*r%(pPeFS~?WE^!9C}3<|4P9lJ>Nphz(Ymh6J3IzY*QBEf<<<> z&=z&jG_2mZI{%vnq)VINQ^ zrd7azyjo8f-YrefNhsa)LflNNfHrRPdIxTiHc8F|4QkOW%VFQjcc)k56A4FC9sFWv z?s?snXF$^xVBUlQ=@zY8}1G1>8Qt#kGueulF2_jZ@OJz{6y1gb}KV$=2IBE zs(n9e9Ed9%4^cn#`)Mx>!;$@SgYY{eT3wPHsjGhm=xq#ZbvReI29;?qu7Qe1#eW%R5 zDFo*gLclwRw#-I+FEo??N#|&a8u7_-^o9hEF+v?pPJ1}^VJh>!EJFdG68|Fr*%d z#N&w+iI_v)Mz6gTbEK)2(C;JL7Yk-mP3*O zD}V)RK)n%bR_f+&_1`wn8o>Wu4>#n4VA8P8U&bV-^41!Z9R#T6+tuD|jyDbgM-NQ9 zYo0_{j+=MgZfV2}Bse!;F~K<-jz?$)liT7R);5mE8cre^$nx>gxPR00P?G%f;VoJg z70e`Im0Y#oBhF=17miO}m+C759^a73$WGZtoY>*hqa~*o%F>A~$z15Rtt3aY9Is&Z z=-Yp#8nV$oXz~q&KtsdTB3KELrC-fji7IAEmdxk=86rdF-`h zX4AC_4}S6{=+0fy^FIs+IO=KQPLz`=9{YD})T)0WR~qT@RWIXMTfQ2sY7z_ntw72E>6c+$-?)!4h+=bk?Bp=)y=vF1tHXT_ zjuxK36xa=jbTPie_d8WZ9Su(D3B0E+(ul^Ywfn*pF{!TbbA+GM42_OPC^t@GA}y#w zDe^3Op(nCHef?2Y`>K*FbMxVP4TG0+^dIG;Sc)kvWt)veB&Kn3;tbw~(>c_g@1~ow zjg1o}l&Q-_9fDc`*$!TM2y4G#wfz9sl1i(Wbgjx_HF{l4#Q20BQP*uVJxQor_Y16H zN6`BJj&k;gs-H-p!cR*ljErdKlTcNSw(hpU0f~}Fu-Wv{)WV7{$#DSMyqssk zVY`3XbJ3WoX4*<*&m&nrqdS3f%BYC}Tm|#DVrI6hiZkoGU_JikQZQ5YfGP1pYFeg2 z!U19-GBXGAV;0)Ff(E!z&Fx{*MFo^H`&`3CcFSJ;p+WEd91@GPnch!sCHFnAN@qjg zSTJx7l1T8|t;S|=QvCs!f1i}NOmME+i*grP9XWt9eV~7XlS)CGJ6a2=yr|M?V#!wc zt#3K2WxZ76;$`#2iN9%uU{9Jk7$rJe{cAG`6|aTBM6iZ z`Fahtvdm_ZKMo*PRfBhmS#(a@ko^A|B4Ii$s)2>l5&}R3Mb&ge8qRJqP1OqTzS2-e zl6JTE@gjFKd9ps#lo)G^7DQ&9USBaJQ~OI^Mx>~5d3oSa>X?TO-d7tb3H>v~vJKMs z81jNo=DA+U71dV6@q8AdIH+b(R0m%Mfv!`TmlP(xxs8{ilT#*zpX`HZ&lWo96WR`gB`oXdqicoG(vZ;!jw!1q+7t zjri%#pPtt#@(~`#AfhN=09S>w$gJ&hA_+xE8 z1Z&y8&iruld-^FiE5^Lg?KkGSy#>io^c zg)l~{hRTQwW4Xc76?b57=+&;X@ZR{6VJD(W#2r&Rp?m$`DE3xZwEu*7ckNy^giBw< z(vZ~to&}jp@m+)60%{rLP|W6cEv1REn~WykCV1~wlOs~6oXYT}Y7@@&!MIewL|)z_ zyj(?k{grEQYyh*E9e5sp-k#)hfF(_!!#01XpI8OrochFIBpSc%e6x&H`rRp!k*vXA zg{!jQu{&oL&~Ot5*sSoNXpdvrUWK5bTz2SQqb zL8|~32h?gt=>QD3B1m>_tj(xiK`T&kk1%ML6$QDTJ=UQYZQJl3Wvwnlc~fkXPIGaN zZvy&J-rw(w9x(W5bv|hOHjvZ5W1}fqQk#@Gd!+nF>U`9-L1p1h4|(Xktgh#bFfiu2 zTO8c<(miwVG#4Mo;X*j06G-idocIsMh%2y8Cjj3!IqK~z1-dMN*;op7;|v|!w7ja* zJ*DaVqnOZ-Ln#>eYBHH7HRYMo6OQ6KJ38i~mh@jI`SHLCakEERP6-HGljH@pUqC59 z$a_W=S>CB~+lxU9WGv%rqma@D=<>(#G<_ zNY=goYOj7Js+#HH3i@2gUOTgqscy~Cv$E;S_h5Zs&MQf+_Z&0R=tLc*8x-hiwUT=w z`j~hu6Yf^{(O%~5jVwvh*8H|#@@k&}7wuSm2>Uv3T|G`pL6&;oX9Y|I_7x?lngj->C&_d75#PNiuT?W?itEVEgv#0d zDs77Do}AV+Qzp$VI|S*R_&Nr~Q|kt-zs?O}$Q)^mvtQOe9W!+~v_Ic*n*bwiViCcl zIs*+r{zo+QAOTH-@~Q4nNBa6g-aw-<0Gja}M>DriGsXQ0!^wr%#BBsqWVn+5lc>ZK z$|f@!_rSs+s?#0YGjFw5n64}+e^n;J!f1D_qlsx>>c864o8+h5V|f4r^T7F}%@J}c%LLy{3RenXM*m9B&iBF7i9ETTH9N*#LN7IFBTD&NC)CrEqh zzPRK~aKTG514AS)1Fg#3-mECuL%1^Zgi80lUEAui!wPbz^;^9c*}+tveIVtdas~y2 zsU(i*@VURIpFzuF7va2LGeF<4T@)Dv&oR-*O_ZRK!B}h0=xT1km{VXi=wj`PNs#RY zWq%lkZ_*+NeR1g{8&O!p{<_^M-V&a4;xJ8G39u~nmmm-8jV*J)aEk}UqY@Tup-{Bo00093HFJ;+ ztk?!!kbB>=kfP(WBucO><%wx=L|9FB*zZr8#<3ULsc51Ym;xyCX&@9MX8-^YssWy- zZbE+m08gMf-oxe`78}c^P)IO{5k;>myjUF)@jCq8x5fAXI#eByTv}Zt$Uy*b9rt2y z_SLcXHAONFr|y?SQ*#Kpdz)wlQ9G^N8PmLAPvl8JKnQ>X-S#QSI1~P@U)(AC)Wr01 z*>AA>OzLWYQ5{xRm(e#>z$QsD-u^0UtVFX$zFluHPM>dZ;qzK?Q3Z`)N}V)#0*#+J z3q>YMW4!)c0C4@b4ZQvGJ-J^YRAwUvt~wZcA{9*OA=l0GcX2N zUl|tgSdqsD{{EC}oS?DJG{NTNl;2!vd0B9be>FXJzW4c|-yCp2v(|U3Qv}b8%!{jD zFtmDh-aF4}vw1?L*fnK+DHLCp3wHQ8V^NYe}-1T9!>qn zbH3Z#k}|O+`~4iKnJpkm8a7TXW8FD{!LU1PO7(2c7o4eCy%sI@8Oh+tTACFGxK3*L zorakWAP7(Gz+n-+X^_}$BsuNh<8)jI+P>_EMMTaAM&BKT` zR#Ra5H#)@4NKXHNo3b#roCde9pcNZK78+^-aFJ+AtWdEQ6Sn}pJI8tnWPzqm_>=kCTz}rmUhr@o!)Qgw%>;tit8AO^M|C7&8vG)8xK^rtFsi zogz!NJEvu&O}omWL@-%0)cm`9qx}hx0HXYkwM_UGwR$ zwq83vuiyh?To`yC#tuf5j5z*4;fEt!*dRd73xMewKwS>AkE|J_?W;$(v+Uq7-%hre z4wPRST;yZ_ZwHgKSGHfLw+e{9KcwrsypnfnB%edHRr52u+3&%E$KLa)G^Rv;V2)zP z8~1M?Njf#WTM=x@}*8`$CB(Y|kY*s`F|c0#hVD*uf5*?J8<~ z5|=&d`n1dJJ*2~$T8!g!oo_%-!uGHwv|e|{Q!HNW4S*jSUSh-<>*k4nY{EXbfAWv?PPo+x(?Rw%wuiR`1j#T4{_(5V&;T&RgY z=%R4n?uAZBz{XNY@T;dXu>KzY(2FCHTQ=PKzQ{cMR{HUh(Fy4Ri?lr0CGgF(;W6}j zpoamHefm79rDe5of)IYr)XnkTyD{K~E5>cm*?5F-YmTfq|;sdD4beYL^rNr9OxYKv3J+})Mh|gdpXi9z$Lu&x*XzNf!?wAAY zW#>Y_d!&idotT^Ih)A$k$D5H}q@CSg)oSK`Zqgv6I7 z+5Mu?$>nMdlXS`*q3@(Z@Oa}F)Ha=3lt~zaEYNswc?dvIqki2dOLuW0udsACAX>Q& zU?x`N8&h;(z$>IkXJSs&t(>S)N_PK@%442L`3K$SHKqr0*h-H7?^k1xk6OL3GsiTM zK1wb>EF`MIfVC{Kdd)tk(WWUF zSFIX23WxhIU^({tl`8L@gnIIhFWo_py#MUy0=?6bxK*QrkJ&5TPw{YnUT3nmdg(T> zt3|TYV|Hf~>YvE&t#YXI1^dnCtL-}l8fHNb<-l<}?zEo?_(KHaS=P218FXYVAO`^L zh{U_}OtWDl?D%}cIWRKU-4XEPG}e8r8OGvn?Q;ggCxqSY3+a(pcEwLSHYD?5&|oOCEj8BwYCx600#C`H1;xwb z5rkx`Qre?XHL8~8ivWb(`1OE08W%Y8E1K5FokvatQ^?Cs?FO57uRK&R!46&yb){fb zA$Oft;b)43%+jOM#8mbnzoZl`8S`Xjm221A&S+L*^LU*$2)J}k6VqH(^hVA`v{J*b z0zYdKymVH={#SUYr+vD!jxSNmngJ%xKn8qD@8CPP`VRB^9GQcpz6%;24jNe8b#L2( z%7iue$Js@)zh=U$-cVK14T4m56fcB*#?)zQampAm@fyasv%01`Rot`Sf5<>*K!#xnPdU>IVJ6}W%(;NXp!Tb{kn{_PUV+X$&SSgf7QG}QS! zO+20-pT-_2c+xw@;+Q3rB2DXJyRV z&ZuK*>QUoB;He|2mhsZtV-W3;sUgBdtt`hsGuZY9gt# z!;Idb3aeWMGHEf->2xH*XrWSOLZYeoUBhQk4Xd`w>0IWuq|(wkNl<16SNjZeb!o5KXTm3QorigP5~!6Vo|iGk~Y%#%*jR3#061DM5Fg zG77}4O5?;x6CspHUoy-$IJvZMu)9ONp>NE6wsz&kEO?vP=jnQAdC%49u?kaj@uN`~ z?yEVkP_^7Jp8JMs`R-P0_Ky`KI@MT;Gq>*xZr{7AG&7f)_AxSx?ana9VUC5h0`bV> zepmux4}PNQWYm0}S7@>yOXrYE13S3Ujv`uwxkdEsj#O^zUj{=+-D<|b7})5`oY08D;4g@M?u2lCH2*$Z$nvnSgYUqx9s$)S5ig5y3$ zoeto^f--SjrfC$`RZ-c9dT)URwav!e_063;13t0&*ypoAOsBc%)S(BI>9=&0Mv;ME z0-F{fIHF!bu+iu9tyFpxY+C5MyTKu@R&%=1muc*YSKq%OfbO!vWc<6H8lg@3{j}lA z_IMgD`19Qg_}KfX4YZ}$^oI*UD7_)qo0S0CRlrC%Ke$p0NWFbWSZ z;0r^Y$)HsrMxj}aT;kjQTCl}Mt!_bvV+|gL*EB5qy6M2Bp}r7Yvn5&WAcYCDgS zMwV~x-Q|ovKNQpDlH2-M!60Enk4o9xa`#BuaCB@Cbfx*)gy~cps0sQ3?gz2#oqh06 zg~N!V(DxFl(RV%+i^~Yk^kQ&9OQ!;_cEqxcz$y!$z$H05Z}th--5K}Ft98q;T%3qB z5{yN^&>!DSj%sJ~Cf>wR7KT&0`bA#xITu2SB0*D4@d_RAq?V2BovtiFHoE^l00_9d zJMC`1#T@k@6+LKM>Vlj*V%Vo3ZPfx$EZG^qa|t0~c(sy#D>oVSPm5 z4BBRA;41Dbvh=*Lkcw8ph#=YY0I;cK+A=|6gMJ2=?(RJ?-Io=xr`6?SbntECvSTIU zZQ7iCeg7>-{P%IJ?V#U!E8|JcmT%!|Bmtf0nh~-$As6HgOGv&ezpU=#{M;#61h$XW zgrg@T!_t)kX_$kimbDH-7|Q9iG57{%+awP(M$F-F${f2lubOl-#=W`Hg(kOEnI6C4 zD2PgMp~sKyrY0%VLZ*qQ6!S*cmN5_JEX^#Fy+lp)Uo7IJkbU6smLC4n2u|1HHCckt z*<@~U6JJ{w*HE;`AZ{U#b*%`toS5uu{=@Q!QE`uUixr2&+!-0~oLyXkvCD0wtNT}k zP+SQkh1-s3jhuVTsb^R$bqAUvF;!xOhtIFlMZy1Gj%J(p$+TIm&(NuH5&Cu==%%-I z19B$^nIOGkK+mG3L^mH5+N}L_e4qaAH_9GTon(5DxNfC+ZPmKrWnlf?2L@0oKzU`W z$h9ovEUs{1CE*BOqm?J+7KlHB}9n2>@983mOUX+zJ>`1-uI zcL$&ACfa8-9cR-pX&ArhYK6j2=x)WpDv7{)@dV9vHccndS8vVzt*Jz41>NFcKsJ%U zB>`9&000932C~Nu$c#ZV@bNPPlRG3%e<9}vk`^7Ud*suE#R|PsMa+xM^Ito5M$`-% zEJ2ra2Hm;^Wf{;E{~01i*RGL?O@Pv8NgeB@tUNK;orK!jMAWQ8SA zj;U?LA0#C7-@`YYS}!2xbzVtj?;$wEKC^dZZ(o3)>Zo>(Yr=3p<^G@d(N;Nhj`N{T zA%vPZq%+!G2zrd~QGTitfFz2@UM0q?Abe#)=Q!p!*UniCEQxE8+B}X-SziHqfacUO z4dV;M2y%yV@%0D9Em3b{LPUqMC-IyT>fO#A7Aj&8t*!4fkNkY@lL%(s7e4R6A};JO z4lWrMBxFPB4z{C(fupveM$lJFH_}1vU$_u~TNE<2sdEqgs+)}UEI0FnPo3FzAaqUx zkWsg^;z0;dgl5|s(uyu{XnNmGm4^e~Z|aThR9t&gdij9(>N$DM%w*wIHt0#h2cc&K zIPwv^?<*K;-Nb>WJBO^%!H4s&5d}w(=j126gQ4E71b-Y<+MtK0uEIeP{t1G0pj!|; zdOv*Yfinl>!W!W=HMd&Fu4iPto$`zv@613*sw4H7vP3OB&tOyA5zw;I1vv}3Fw4z= zJ{D&WcG}ef>`|j=E~x!L*UR~Rhil^9-%V}uHg@WBaMbpnQ)d2^KT3RA_s!J;8&;?5 z{#uA^2@|k3G#KJDLGBi@=!KcncS!aB{^2v10<%VEr;=3NKM%lFR)RIGmBQ;W_!KM{ z-NBBRov3#WT98W}CpYKm*dbNVx1q{WS6-|IcJE5_-X~e?xpL`X-QG1k3A8Ki${crk zPqLT^8tY=Ha>-$LRs9wSfZjP0}8Am|E^y0SCV2fN5ChwmiJSpTV z!d@GsC-qbx;mop(s{ks!PF+jZvatSvOf-Wt9^K(PV*Iffhip%u*&ntzP8=WXf)c3l zuz)y!PyQeX48B~T95fiJk_%Q8OujS4u_3JE+;I^v*y67-Dp&W2x84RBY?p#W8vI?3 zYa#poYmrtpy<16-y!+W*XR@C7Z=kmDdXh3ftQMI63Mwe7N$;I#*^#?_K#D*~^r>7T zGpb=E0V`BxXvcUrIgZ_-;fS)1LqXa=~*qwp96Y3c8cZzqym1z zUxaBt4!Zf0fBi~tTW4s0h#hn7`a^Tbv`XUGAEIXA1M9gN*;6-cu#K zlLky{*8!zF5~QS2iGGhd;6BHrK1w4=zhmqqS+j#kpZ{2)dNEzwP|y2pr|$=vO)5e+C+#xBxR%=Fh2D{XRU$R z%`;I;UG8KcsByx)Kbg7xNg{*O)zeVYlr)Rp2YPQ>Xq`p#JueThiAbBE6_}hj@>W-$ zr{&gl7fzl{KPgdFD{ZiGSTAUgf6wKg6Uu`)>{SZMHOcH5?HJ39{29Cn0A^iEYkc@V zSx`TEYE*nm=`k!O4@J;8;MgQL5;e>Cc91bzR+)pwof_;h`xgJf&5KG{hsD>X+G2=R z$H36OZ_~;JRTncJSdvB9z*0*VzE3_Um^UgweZD!4n!+C=o6c4kQ5x@FtTG-;iTmqP zvVPkW>4w)5!5i;(ur&ObqX?4Ar{Cq1KVEJ49ND8(JpB+OxFhU*qZ8`Is(m01Lv$V1E){&}~10u6J5>SLG@D<2$fOEH|r z4fP|0e+wv{jO?1lE-M|w>T4V^H3K2GVJ-FHMkqdZXtFAB1b3qMbtUDBIf|Vx7CASs z02pdr+B})TQyNXGxb7w(d2ElvsE9r)oopmsgTK=TelYtkZ!t3>Xnf>)CH>!Pv@i2H zvZl{sDNSRvRsj>lWn9(K^i(RB=pr5Oag_@yKh@+>+O&0Cu$v+L!To|QqX=&2Lye%K8!R&j0Vl(dgd9V*ZUntJR(Q?I^q^-DfSGKW1Pe!&R#f5^2nH zL!_A)Y+{%yHBz1M<>k03qFuzhkqiGbY;#0w}&$$h=3wMrGjoID5Iee8t5LI z2}4m|FC60(XlJ8(L?V%1WFd|kHI7%_ij#2jCB(I9NQil8D~ep==w!T=k|oz2yyvk9 z2%D@c#t(|c1PV99Gws1hlP?pU5XxE8pnbz4?bXdqbvbTk>XZPc*NX{;I5)v+EMn1;esj z?4`c!oEKfJog4m5zqdRJZZa6>o=Efw>!l3uBJ!3T7ykRmEsfP8}7vIw7QEyKQqxt@*<`QcUTbuVQP2F#VhQU zN@@PIEI8KtC^u7ksO0A09RF&AJ)2W?lEA36;UJ*K^i|*F6704(6ooD?Rhv5aq?I@Q znYpZnA@?GFaG%S5>MlgI`mvSm($d@+96Lff4te{3z#vT1{r1^=8Z>jLrzgpdr3_@(aJEQL{fV&wk4XXJ=`xxS}2ZQ4IO+ z2FgQA=+^o5VtQ{~073#d)FJWj5= z&@c6hvS#mMdm5YUOKXE96aV|^7%FLkI636FLsovy{Fx6pOmHaNR5fmk>T?2v6}!70 zu^=>rr3E;BuW}(vSagVr@1Na65V0eRSGcE_A={sjDGz8V^@!>*Lpc;xyy471T6& z<_LGDh4xAx5;zj)GLB%H&a8s>b;;J~RGB! zVynehO3?`t@Z?6~GmS5UeKWUlI&9Tq+Y=YTfQ58MXg?}G^F;+e-a_sst~d6ako=T1 zYG!o%!6M5k4c6C#6t$Jw*q(-=B9DD@j;Mq0UanoWugX<$jctHFp`WvE0B{2h8%*eHZ!Bf1PSxF>y5r+{E43%qGUCF~oUlvZz!&)oZUho9^Gj5A%*FgVq$Ro2u}Tyvt=cGn*S#W;QD7%N*Jlg|aCYEz;6s80p!{Z_ zT~PLs9be}IiyFz^K!R@cB;Y1FlO5P(^7SxeIGROnPSY%YBEg2u0ceejjP`Ly792G9Ez*u(3GhFpoN1IMK_Imd^aXIhA{J`8D0{sY06h{PBI2pQ?){I zeIv=7N+du+bJXv!QIhs_jzPD0>2LCjo4gCzB*V*yHE@5w3(tU>gxT;C(Efpx8BH5S zqij}9RsVQ=9kc0ZuOHUyFkqVzH5LP5F{-+q85b%E+%h>EDoeSh5v33aye)7Q>K7ZD z{x(z&?75RX2+g^lFX$n_!;_;=K8v~OYUByEgv zG&#EEQp@%-47Ewn=H+qm`6K+lC%+B_v|6=$UF9BPZv&UBF;2W5+~9Z}o)an}+DA<- z#_H-G8#!C-oh8CJ#W~Ll-uQbL2_DA`cRJY(wTNttE}zzOf%r(4&3Rnnr9rm_9pe&R zsUAmfG+2%-xSuiTL@|U6`VhW@Xp}ew&Ba2mZFd*kh2ej=Ta7j%pSnTxVUna=Z}j-@ zpKzS?-^QPV$Xa|bbL6f3hu5UdF@jIK5-@hAQ4J*vG@tjT@>?iyYy+gq;=`;U7_W<5 zicCWEs#Sa7-#h6Ez)aEXpYL5SCjQy6d8(cQ1rkY|gET1QEqXU}8whSEH9~4*#f?dR z4yZ&}a>$Q-3praxH_fw5k$KJUq`7cldhAE*A5Pi?U7E~! zAAb%#l*7^K?0I$vJ9@g{&f?tv0hR~b7NKs5j}O2?awR8>7juNQS(bh~V;IzyN|$s! zO9AmjrY(rabP7==3?E>ngB#4l%xRn-Xoi99JR=XBdj{+=w_w||iSupbwvY%6pdtAN zBdas&*udv(;HAWNhS#9gZc@1#TmzKs0XZ&DQMj1`M>AUPP7ie3^1sSm+U@ zz~)9uirKMTl%gy2t2`ZWo90K>H0dy3g5HShpO8gb+x1L$DsG0A7>xW@VhEJ z!)ySXHEhh;|7Ea9IP+)EjlWVM_3#E&7_N5S^9zSGZuHaOza1K^oq=9 z)H$ECpv)WM_^`Z%v>@I?oD%}DYA zo37Th979qBm~QiA`81iDN9iKU;QHOt;hG!py*8oev<*9gQqCuFqmHbNA{t(fRY!Cs zypwnO<~}cK|NO3*5j57|sNfx`KcngiCHof-hzPLdt9mTa$M71HW8#$OHm(K_llbSS zUyV=j2$3ve@zahUR8D^BVbyOK?}oyTgsR#`7xZNo$ooX>hkhV2ry$$2(d)HGp10u?#{VvjW->Ib)WUf@)uGW?%+;D0d}ENdl<3+mt+jX`s^qEC$(wC5tOil*L zSvzXQCJWNHqW#DwNpS}SfS!11q<$SfFnkXzveJo0t(Iew>tWr6Qy@$OizFG8`A#{P z_JD-e%x+o-aZQF`2K(oEhd$;Rw>ihmrv8oQVDqcd@gLT7&hUZ8-oOIYYp8smSm7Qs zwTgwr@V!`|vfrn(^(!Hh9wxTefF?6qm%31SIIJ$HtBPs-!jPyReIdhUMQfwXrmcc! zVo%lnEbXqx1k>jnKFAmDP5f zvIeX(=3cShksX>6Z#s|v;xM>Y*>aZK;ka+HIb|*rw$hSr61y4M+#QJQQ!?erYboWf z1Kekf7#(-^a;kur$Orp^p?=KAt!~@mvF`R91Juypu&zZ|?R=tr8Z0uQDv;F1>#&_S z5&$rFDanN8ao9~1WcOe#M6cP`0DNIqlHMU>H0U4T=GA-6asj zWqinTSsbmUqfkTXP`y`qyYM~spB_q|w?oNApF!l%Z}b`+HFvbv;9a6q?MLSZxJKmp zLT{95<;G_6TB7=-8WkBy6_mxxUM5!fUXp(?&qhFKNVr)|chb@et5baWaXFznN32DX zfZa))3NjK2KR0))XwXN7bX7bg@fc8R^<>bv>>4I&kz%({do{%8t&lx~0=rms22a5M za92?d4$6WGIrS)03L16D`^~?8Xrw#cI-S`;dz}wVe}R4GW5}(fvO5;Zj{Od+4cZlD z+zEfk$q}GW67g)d;{bZ+$PELs6FL{Kh7~Ng=I>upijErwGjw3LJ{1Wtj(1(~%%}6+ zG0IEIfaJ%EC|JQKyqTbi{-{7evwml=Ye2OQ9Bo$CH)y*q+;w`Bl552LHPVYt94>w~ z+QO87^%liLVFKqK;coYAL4@|`NDQG+2zv-;%f3OG6`<+U7y=XMM7TN~U~MbVKzO!u zv!o468st||8M^A3!Vy9hJnGyj=sTmxG`;RyF|oK$P`f$R)U4+!F_Hn!Te5G%w#TzY z5G6tydy7dFhF0Z8z{49qN*$LfDsJz-ruHNGm!R+HzCC32NIl0IsrR>_R2-sk`Q4uOUst??6vv#(&?P^to#1 zRvl-vd-S_Tp_j#KqE_-i_`&T8^N`;_xYoWy2M zfb8KC57+Utm(@)eg;(0K2FEn!(I-lU<#94j`v%v*Vtd`PK*$V$zPf&kXpN>nm;P4L zUK>&o(Ln%JQkK=LPZ7meJ`Vjl|JCdEsKDa7Mfx5H^X4yBrE!j_v>f(LUgLBr^FBqi;>>aGzaC3H zwxE8)Ido2NB*S$Ju+2Jn99DlFmW1W62cXxwu^eAdWmY4Ic*yh)0kL-LsDyLEa4oDQ z#%(I4H&;wb-gbJ83D`{|fKT_8O+3ig*YCB-F1(zEOVzKa;uB~&oe3tNdsv>a-q!pt8qC8k;Q^tm z%UVf|W+2l!xyc)^8d$j2OZmN~jt2}Hfld?Gqj5P$uIYuTs@yA*+;NrtnD>WeSW6-r zgw}7P2@JiDf-H?0u!9l4qJyxP%*D2zD@jZUc)W`fGf%hps~pW)FvP>o+S^-zZ^1p&QH>L)7|@m%{T}yNac}-t@bsr* z1e>DYfss^HGRRD$`*+}qn&}IBKb+e==yGH%Fa7MbX)hF<=Jgn|)JM^#;oxE*_n+VP zL^~8`vmGr^0(^VjC{&Ym0fp8}E}D8QuRE_UgyQwQ_ z7X3!jp#a1F2Y6e__A*y@?!P$sY-Z6=&`ldTI*z@FNdW^W5%%Q)N4RGQ#|{Zdz8*ze z>GQAdv*R=H*5Ern$qIN9j<7lSEc6Gt`wiii4zj>5DQyu^%M*mmB<=fs8;~B+`t);iZ>nao9kOJ(4q<98 z#|}$-?B;aqT|a>|(@+9>nFDfPxnUxrvIhf8e?dV69D`)v0@wmeZpK+N z22ZtbgmakJ0L%r4H%?|$Ag&W_el|sD>L(X{@AF2Hj|8gMss&V3a{Ao-MZn>(k27FF7nWg^uv7N4v4fCx7Qk&JiUO>=M%Xr*E=44a@jo zsj=v$iceQ{G%#M!Rj`WQa#V3?g?;=Ck#qaH4m*mh=aSJ+(Cw7pM7}kc-Hrm2QdmF} z(`;!lk19W*u>`4Vii8T-BlZ@Z|6^Y%nmW~i8Di6=r0XF&Ci=Trc)Uz&B0itM;CwCX zQqZ`}e!PZgl39AUw3H0`z!1PCFB`DQ2TS>VC$Y#BuFL(at z)$e^xRi)fjeMX2&E@Hzc{Sc`>IM(5<@8AB>u65E_Ongt~CF=U1Z<<+>M*^lV>cPP9 ze>?hYT6@kVjq$OA@61Pqg3>YuC2?nRFbo{!{-d~{LBn5F*0o7ysM?+Z$>1*(3#+$@ zY;Z9DwLeCRDY4N_g2q_&O5y17rD9uSPv!NHd+}p}?8Ea>woT)3d|rEp_PNp{Assct zut8_{plDr(+4E*zxN(?0>lA3t6ylHyP!0x~(`^1}?w4`FL@C0zCt0ecN{8&Pvj*uQVM7T#5XBh5QB zQKim91*}gZA`?2zy&ZV_JL53*En^>Ce!Z7RN_p$c#29P#^#f^5G<2i)rnMGYVwm7A zVOwQYv%Y}%-dBhgvcAGv>dyA|Kbsyi5zytYdz91f)k?_8R}(D%i#ghF{h>Q?$Eyao zQ9RT9o`vnlEs{}jBRNj{-f;@viGdF4;1(uUWFrlJ-I4CYvg0;t8RxJHF5@Y#B2 zpY((61eCeT+$yB&B4-tP9w^SQeB@Jj>{WKSRmVkf*YLumA0HKr3Z9r%@^gc3j{mMg z9csobhtYj~v;_%UFZ0F~1D1$`tmTkomCOvk^r_VwH^2IDC4yb)Su+o4o8xX3jlliP zR96TnVv(w3g2@q!ldLAIz!$a5Uu`L@xI&$LeKd5_9GFUDE#Ag z^KkX5Vi>nVsaT=SqQ5(_;Yd>WAC5!BPMm;_Jh&~&li!uE6G|Eho1heqo%l*fn2ICu zJkYnQq0fik(f`DPf6P))nGO}L{S->G5dcaH!2@{>+c)B{H_Yg0B4rU{X6(3PgudaI zF6meuYD_rd4NdIPDq~n^#-J<6iC#TfM%B zGqCj>S~wXB+@c~ArAPLfx97?Bw#}h4?p!a}3`epJEWicg0#7%V^jX$MF}(_fwBnhs zQbLyZvj=R2W{x41)U8)ps=}pc(e(&NwsSuLboWh0VO3Fud_Sc$;TPyGU?fR_^Q(A* z80Wz7fVSDbsdT29Cgtfih%f%hMRc{tzc@qDVIo!}fi5Gvi9pO#Hqe0ANdy(jul1*@ zjL+qqlMX92^!m$)tTDbUMo|gO;5>GbJ!;yhGh?^m? z;4yH$@78TPp>xuctc@Ox%hUYQ?lu%&aB;-TX@`$H34W{%NC**fQxYYb zkZad8X38MMb2@UQ35nSpq&kd=c8r6yQl&QKr@c7E&}&XI4j_9s!H}~(2<$`#{xtC8 zia`V^1}~+nxd6I%Hl8)Ku0?3wC!CdG;?}9YXT$`L>tPpERadDaSCd?3Felj=Efo@2 zLtUV;=}f7amj2%B&FGG}54#NqmO=x4(Qa5~b8J6yo5a7^)j;d@Y2{NH$jX1H12>t2 z5L&l5abr8xu)}_6at;$_?dPZpTBkbL>HS3%)VOUnqj(9pMH3#C>xGXX1PJm~Tfraw z)`yzbXQTRvf(teY3UDd^mz!`-8BV(mgXK-X+?9%VyS!wgj(S><;f4!0kZE0vv{lrR z0Vm??*vAX4PTISQM^}Qae{ZxmVv;>)K7lQ_G*mY=OjCi@t|qQ;Cyq{OF}7y_!Nl(v z3az~Z0=!;-DKfkOp}l+hiRjT83;!qepANbE{3vz{U#JZJb9FyNrNR+nG#bJSDFCKY zFlx!{lt=?#>C0c>15p!TPipoN;(!&evDjO z=p322hVq7TV;kyFw!VtqgDwZNw0|EPjlP{LXUlMn+ik42hB2ngYX?|Z8_4e^$hh1r7x4^vI<$_Y=b zAg$_Zr%~ks4h$WwSbIp%BF0$fL^6DagX8##9|7q!mN`6CPCG;;MpkwiHPt^qGu7u{#)6}01GVhT&}s^a zfUbg+r8=pqc&FdQOvn2^xlA4UubiK4zqSxaVVnf2lt?ZrYHPe}4>x;j)u|Vrb1D#v zu}}g-4^|v3RETbsUjhN&W1?26UR!LA*IhP}Fjbhj)57Y1VP0U;&Z{m3YFRqyz)R}L6e5eJ>D(gZ6%ejk6 zk}ZdW(RCqJReihzTOqA01;p0?6(g;1Jk5x%(Rd%cWYmL!`sK|aPjoW(Bq`-vkTbL} z@O)?IJnF=ewA-WAjk?tr+t_elxVn+zR6Pl_F@Y*Bwe)mBTON5Wifq zq?c4~nyY`SbD;5h3!q83vy|$#pbr`l$JP>lNl}eb1Ql=2? zi|l~Y6J*8AHy4B&KeH^Q;Cl{}o1cpQm4jf4cug}D)FcW8t*wk~>)GD}bk7i2k2ebv zA2xhn=PL>sF82I@#kYLr0<{oTwQccPaM0&|Rob5t&DXg{LCzFUNn7R=Pldz#3c zxQ<>4Vsu%RAy~bH+n@!k@JMX3z@$0*Y+0>m~GGLj&&+ec9rcd~104$_<|?i+H5v zG}ns(DNPML?;R}6K??wWL+#J-e4`+3_(YaxM#Sv|wdvS2TotV?+s#@hj-Ap4v!9>{4ca>0^5@_ZA|eHxXRO?Q( zlI5XKv-JD=&-alG+qB@G_I|$T%h{({UyOLG=xs9TprO4f6oZoQ$ywG}v?S4Y ze!RY;E5Z^!4m+39HnXwFIdwYF=L_5b^z6m4#{41C$o|_zbTR?RM8Ak6Qbx>7nU1#- zFIVn{J3(MsQ79@0c=`JvLQejI1m&q5%BrjxW36xXt{M3YB1UK!+4dYVcQt0cG$2eB0KPwRc)^{YCCI7I9 zp`Rtdb?{c(IO%J!=smZ9!$&5er7IiY$B*R|dOn6;>K=LZ4B;G(4ibt)EY}2Cu%uL|9bB zMjTyRuzpJ$I=6uwHI4nOt`rjdl=w<7>TB{caP+LN(OI%pik0l8zk06aWIhXA=9&n9 z!eAxq4ex?|z3HHf7~Woya=1#6Lc!C=+IA7xGiQ3>&n8Mp>94D zEF$j%?TWt-bFsD1O3%lmNfow{_we$-K>V>LwLoqp7R7ajV+ z87X-aPIc+6sbj9t6q`^kdap?A7Y&3>b7F_-olXRv<+8l9@Lj)l4nliyZ($ri(ng)u zz|e$`ncg;;bjh&@&KW3`CIzmq>)*ElG3M6v^6JTvt1{D1%faSAmBY+1<}{1-t%geX z+JV8SAD5>47jAT#7U`CSXQVJ*Y*qVgrac}nB`)?eaV6s;R-$1$bRsw@uq1fdq8Ugq zl#S+yrTLjyo+r8W{GWQ`PFdE?>!)qWZjebBo@y8AQCHR+G32b)B$J{1R#zgB*>uqxkx zNb6MA?sm(eUuX-kFWOKkR=>l`NR%NrypC;Op3~4|SUQIb&(|gWSRr@RWOjk8&bUkW z9SiT0I_hh)FTaoN*1p77FtVTW%XREpswAtBXxaxfBz3~$>y!}YIzGk6F=kf+5o~Mc z{Y?syTm4nikbz&-^vjGOc;p?;+13$O*X^2NEY4RVrHCW7IMpU|KW3Xg_4CBpx^;c5`_edXKvuqO?{_rP7E76x7NNYYn7k}_)kuS?=OyYk^ zFPT?~p-s4#P4*cz6fq1cJ2e%qtQ|i1#*1q~ z(LEq^+8i7M6K3Rs`CWT*8!8Z{%e^+>kJfvRAVly^ddf{a(mXEeitpA@#Z9;tc$Fn_ zxV!E-l#-d9!FZ8W-GJItLmxx6UqXXfc9?}4dW3e>1?(Srsbl@xOE3S1j$(fD>@!N= zG3CvxAdDK_gUHs9OlBml&|AQ&X}UWCVDEg;jUA*67i*?SpuXk9)cde71KuN#j8ofb zH2r+o$+U~x&LtFjvUBS&W)YFdDCZKf!B8NrNrq#}rqZ_zf8K*PKcg@@>*?*{N+0r# z0#mpl@#r=!hxWfE83hmSi$P~o1i(RpgC|R`6{&vYnUE6Zhtu60(7!Gu635nd{}%vi zK$X8J#e3kd>os0u`LeeJCGYmtwyhoJ9SJBILYyhgu5D378vpB$^3`AI87ze)e85p> zIX^8@REo>814;i+u_+a>Xsf%@Bs%z8gUZ*+FeC+pUM}Yw*Wqb2HUoucRo6hi4uC-P ze++A)Zj`}wZhxyBiwsX9+4(9j$4rY~y2|)+j&!w#op_hE_s=K-_+-9-E98-D~vBOe>`B+MKveCkLWPi1lP&QsolW< zud5}N`{M4-;`;l)D+BXW&wIfWs8%TT58(s+_&FS}*eIJcmYcKX8f)uxs}fP?xCC3V zXx>8MX~O?1HQ09LDPw3;74#}8vcEZ1UMg<20IOd^ee|VuHvPu)*QfrS#LMWl3D^)8 zy_^UZYgf5JHo&YV{p*2txyUwucfb((&%q@tk8M4dpO1%aJ$Yx*)s-x) zNX8#*#tsRK7ZP|Us=owRZ35<(P}oT6yaI{F_j&o#iwDCv5<&Q0)0K*XTVeiZF)#=K!X0|dPD-fzSL%|d*m$)YZ#u`F zQO<9@J6=>2S`X`9Z^=muUA^F*8NX^fse_nZ_{yW~vZY^Afn4@%k>;JQ01!Zxjx6wQ zJ8{s1& z-w^^%O}o3l*t=I&>T<%Ba61#tM0XFvwcD(!^W%#4`q_eblky{8>&5DAET8@gJ;9YB z{fbEgU-Hxfvcc~1uYVy5}JEMTCj({|N1bzF3P_qBlK{fA zyG8s?BVG8sYJswt6mv3BkT)Zub_U~o;GF_kVD&(_Oj+JVnZ?~;O**7b(Yd_GZuc2% z+-ot9hypD9AAixiVtk(>ZBTYA?W}+E$%^PPA#k2SQIJ7?P5pBRr*a@y2m5$LaulT* z2U>kbd=&Qr7nz{%M663o_cb3(VhJS1oP%jDr8i2ufCj>K;1jyM?y-a_8>55_3Pz1bfVP5~`~(@fH| zke6iVI!yK>xRRjGiTK7S1@lxcIYI)(-A93*g6-WgKBK#vs89FQ`}3dn>kB4W6|rNS zCZjaF7AEXN?+(@*+|Kli=&ZpIFO=xJ=5C>0Pt_I{TE@fy`Dj-{0bjQ-5pS8wCZZ-| zh#K3m@2zrLf<~#u#%+|{@cn)65orCXPJq<$zak0(q!nFYAi(@`tSb}qWwS~Z{m$iG zI@*zyzSDvUmiRym7%!cf3*(BgzZkTOE<+&fr6@iB8QQ_ha;MQq>inj1;+tX|n0M!a zllAu;pQsZT(2%;yZbnc3@T8)CO$Ka;9H*e4iasTO)g}`ZBD7wGQem$!S1b{_g0*KY!5l#2s<0 zypIjRmw>|x%)oz5n2O%@_Mr%59}>a1Bn(vqkhEyNNtSRg!v~4_hqR-gwhGpyMae&*bgX&3g_MPl zrs0mYFCuX!1lO{S2Rpg=z#|pRj6NEwniZ965ZOvFcdMeC1)zWT54!+Iv{}DQNE4PU z1uY21*5obv=R;YqR-<_KeC3fp!tBXeG+5^qv%jCl1NURm?<^}TL_o;xMb%QD{JU)h zblldXz*=x~7@Wwwdi#3Zn3-^E!V#7MHe!G!j+vR*?`ZenH3i0!sfct zv$rBzzW`{?b`%wD{V`clj$gXHN(S(!exAp!c1s|i)A9Z>GtJjIXPZF*Kh{ z@lkEDQhC4qUx9-DL->KO#OAb2p-oH4B-Jc&MM{do0wst^0Xv)g2ju!l-6Kx8}WK210WKk6LRwDlHr!^%Ja02IGL zp2}pDL|iNX003Pk3DlD~B}6SIf@ckh$gnfySPVkafCOAe3YOEK=YRV-*)c!?pzTiD z?v5FO8+uyIl+Xd*IohzgE5dA0!MdlxTZiX#EAEzz*(mO ze|K&Gzy_Gh*@7)+Ug5P!B=b?b9#1gR>p*o0C`F>R+Bz|`x{y+oo&Y4_9eM|J08Ijf z-2}^gxhn&jH0%`aC~;4n1_HH*zZa}4aRA5l=PND7mTdr!;IzLUJjF#)Oa=zNi4qkjw#}YZn9sp0W~Q z*$0UT>EAtWF}T;Qj6XiuJB2+&9@gdg!GLBr*>mGe$uRoXUZrDU$%k^1y8WHi+tS{( zpDq6KH`LJ10pXtsw6K&1N-#n@y`(%h|G#3c!x&sPV-|1W*Whs5u*=M)3>IAg)BR3I zW|(^Jhn~vC^i+KZtIH@6#**~b733I6*&o4NhMo9eiP%9bi`#A0CGCJzT$!syen&RF zm#$T!&w&+w`UtOR5L(Bt91ZoYq=Hb!D|X4?LWFtHzsDLba@*+e!>(ff(XFKtdR>NF zi;>DcBdP#2kju6}{TsWsAmF69u^Hvc&2^o=*Y!I$v1KK5bTjDFM=y~wX$|tIzni(+ zw^_z{;z|JR%1=TpDDMH)wr* z&wqzv|1zeVE_Bpx_qf>uH8Kkb@6vzrG6bqq%G{5FvbyCp}Koy z83KOFjbzzO)1s$$(AALg=Nzonk>)A3a^h{P=EDbk zfHnRNFm)Ojrzv(uk5RCA#-L>bWGlA3pEMo!3H@0+WM=y~-b<$|p3xPPk7xWrEvbA% zT24qbUY87YH_a;q_EdMXppWjh27r!sWtCKmbutU6AUsw2{*k(4!;pCwW$NTrzuGa@NJtO6VfCqXy#4a{iiJ|vlWNPI zSX8S}4i7<4amd?5mv!mQ2fJZ|g?pILL&J*q5s?Ga^trV?9 zb?s38Z(vNk=52*tQt&UGBBkElS@#x`hN#|?G3d^ZOgUy#B;1k@gepe`665C24-{>w zn$%0+e+TpzYg0L~*%33`j~e}xA#d214Pnp;WyuNQrc`W(XH_Ig*^Jqs&%YxZN$=@( zv=IKgeS@u-)1CVQ&&HcxYZe_0x@y`ti#JSq{Xm&?+qgZERizz9z4VwjthUDZ1*20~ zpytB=jq0bZglqGwg|KrKY)rX<6Qlt#W ztq_*Iz3DbCUOkeevZ|)Vnm+F(-i{lj%U?CQob!9}G%UBe-xrree~edVNT?ex?=P;L za{zRNS^$&e^xRjhu5KpDZ?9XrlR({S-xbV%6XE=3te>V=IWAnFhH)SGJ0!A{1$PGA zNc+sCDR+z-n8)Yo=06|N{W{m@+0knth*h#ATJ~7HTjj_eSduX z!h?%!R8Az7JmmU)=uE^jsN&Y(hvk@y7S~GJpT^pGp8FM3Z}AA1JKH~N+9?Z&zqkfW z3M0o9F=IcGVh9ZUq-@7CXSDB0=3!cYJO!e?v;osdHw)xM!y-w#E2E-M3h0ggQ&Q~u zF5+Trp7g24zis47gyJ{-zv_wVzp1UtslgPc(0cz9|F!j@)FT^B8p@#M6*w`TC_ZMe>#y4<*dJxd zvbE5qc;Vh(JB0Me*&zI4#jcSBMIF_=Q6SE{rh<0R1j8w^*UB={`o)q6dJ2tR&r|T? zkgnypj52?`Rv03x$iJQNx*MAB#+B^|(hj1Jer{ltPHl3^fBKRJh8aw9eIAu(75U2q zu2FEs7Fn4T6+XyxJfRpOK#h1B6)aTis8m-(Edo?iqj&5@3eTN5f$Q+IR%m4)Zni zdiXAQ)dUu7Z)^}>7@mU-ANvgOg$}GS4_>AJ(KL%^T~nXTQc$HP&@E`YrU~)(T%*U5 zMfWgc$KU5|{I04{?)aXHvJxnDs_UZYp|8#p2$ zH7Q?iC5&$-9v2PeyYmg$`OWayze=zgw|&N16X2=R&XiAEOY&7(tuiUH){hGsY()m})MtFy z`V2A=xg6S8%186hHQfXD8vZ=bpSXuY7{O1N&huFy9*6~2t46*Y?RGiZV5US8R&CFz zyO$6B8)5J#`PocrD`mbk3PALeHSF0iVP?3>91R zu*E?Lq71ZuY&Ghi!r?2%`JZ$C%H`$?}+RN?-!R zl+ z=4Bx=wuC73sL+|$k2AN2X~*&2y+w2qoquju?`yJ^U?i&6+jq8xS;xGsllNqXnGf&p zCp0sSNS)->{9C97|6afU;^wW_1c0%np7MoTKK{Mr{RdEO%3L0wVb}QlW*fYH66YU^ z4*M>+l$Nj}03av3QRk76(MH--k8(K-?bCW7-j}J)440m1;hje6)7fLCB;n^Px~jtM ze_y9;J{FOdoWRE8qg0P?)-~&O)xpfP=u*nq^Z;&u;`ajGeiiMV6p35;2Mnc~;oNxg zEm?%XmX2`tEX34Cnc#>GejuXlS8*%+3Qbi~(y+Su`wWZaiHE{fvqF%c-c|%u`sJty z{PzH&R_0`HW8t0va+Ak!rQ9E!Fh_p7?5E(tq4^j6>DEAA;IgXjmG1viW-`nh7mPrJ z*)Yc&d$llLO<~X%F91AY=W&yn*eu)~}GK1QUe@$UvZ!I<52tth; z@PY}Tbz@abUW``BE`)(Avicd1*r*2Xa#Lj6?1nf*kPM{8x|G#P>62tbhd~?L0;%>_OL9 zBLB*$7fo1V!X}}zgkS1mLU}VDcvoOhvQfB3zXtc9lGN#XMUwsE9_E7wXwwUZ{u<54 z&ngGh(T>SMhky{DzI=U%D*Xg2y=xu4VuG1Zjd24DK{kBDFikF&kQ+)a>6JAiHOx*h zLm;V<83E$-U?EXI78LZzvs4)h?}QdOXV)-b4-X5@VDgVwkh{vx*cCx>b8dubLUGvN zy;9sHjrBw(MiZ$%*-M}0RDg}W>-7WvW&5!B#MvaB`&a4%r>ViF4yC~Wab`o*Y^C5q z)Wn&KK?8Zbk5V~8+}-1Tv7pNN+p_P|2QjH^en;4+B&}qV)@S1&5S}I`l-kIigzYI9OmnJIi#P1SZ0X_Ch$B%*FbW2USsyOc@ z3hVWFwfCrwucj3^&HviFWx<&^sW`L`=;E5dTNb)nSKG`#hfc0p?&~>LQk{nHKxLCe zcVVpr;zduz?J)wVyB^$9Vu`pHtbx*Yv3V$C@9~2^jjykYA5WaEg|t+6?OqNR9Un~P zd1T|kP9ul&D20;H)M#`Y<1)x_%X|lqH;r;EC$Q)kMP}$>A%{*MM!M@^BqyOX_ARh#F3ZO zUcN|e^E8p!x?$>_OAy*tMP4Ph{LhaM#wzKsypY@HvF$B)1ZFSN^R1SJi`t3(wkhy? z*T;M%JgTp~r}eXa#D(lq33kME1zOU!`{`hQmRb3W@0#C)`wO<>VL>@!Ys=lZP$WAX zV*sP3)vKseu$K|<8x?B%qOvH+AHj51Vr*eA(@c1JfM?99V;{ODU6M=Nal81!-_J(v z3jQW!vZJ#`R)hpJ_WnY(vdz#)rq@xh90T!iI>F!-oG1Zm~sUo79r<(D4SG14L zbAHc4CB#dv>$ej(sS{Obv@i!xgz18w1EdEVE}4tQwj;eFs~Sg`D?XgwL2Aq!t0lqS)*TtxLM8O0+sLME1dn>sND?ywN@t^Gqs-qTlAXDh86|X$k>imfifApW@;3 zA1znylPhzW38TSkp3*DUPiwQ~8;T~GJ%aQ}I!5{j=Zm(MELjE3)D}Bt6R4{qc5?cJ`OHt*m%{I~YU&w;1$;v2GNlx`0{aK4>8ANawqxhLd?-SmJvl|S3 z%&x!w5?_CYFeljEJzgjU#|7$h*fkYfnW|^UNeL9)Ls-rV&){{LgzBDB?f6G`>G#$t zg1q5641V3*1pd_h==?QIU08qoyvP%5Nv_)C104uF`C%u22xYM0kl@E`|9q%HgQ!-% z6-Y-#JS{rjydL>%p|+-3gX1^;dx#5L zuhOHM&Q$GCbw_XV`SMyzYrJjt7lUEn)5Jz?SN;BzMnsyr+xK?A0jO2lf(D!AVZ3#v z9r?de?*GXdL7Y=@aKG^q|4t}Iea2doOqzBBP<=iN!5Pm1pZp+RJmyMT+lR=uAlebW&H=`yaBBX2%rWORT6z4Xy#n!@y-xlbk_c*2>TfauLAzU`0;|7^WM?M;e89evel z2)6`@O*`79_HhM7QHtGJoNVW$6gp1MUL)&kWYnne#8+A-nW`z4IR|Etr`;~;r2rwj zU85c8GEBopE%YhY~b z%i8EIaLNlJ^C$hd@O+nDqSg_J8t_S%(WFJ5GHIS~X&)~|d;q-d00@<|fq?*a!h4Y+ z(=9-0?J6Xd&v$1HKoJm}gEr1Tz~({lhcgnQw6TDA;+g{|kUyj94j?nPfaSi>G7 zCe@2gMV$Zu6ygD%>1hz3002*q9cEKmdpt%U_hkD6K#j*6O<0%+pjuVnc0n3URravf zAZcCV=STVqt?20Cv{u1*yn2{7i(p`w>&yTLylfOA01cYTmgZaiIsfCE2-T2uB6A*n zS8GY$lMZgpZS3}#1^k=^MFYl?n$XzP5f#*0#pPJ)yxeoL#Sk{NP(*9@;7&u9Nk=3TRS`J*$(s=-1; zH{3FvMr-FIcPWWY-)^zc3?1h!$AtPkoa$xGxl3us&?odY1x2Bh(DQ z6iSPurorqFMS2Wf0_Fuegz6xIjyW3aEvSD#2v+af3At<7?OIjOaC13|h(p5XKlhv^hXh+33I`e8_?fJMe)9PVmBD*Wz;##rJlpHA)46 zOb|`}4kQ39cyt%2$IIkt5_2~lrmR0ljvt=Rx!g<{mi&zG@DQau11%XddC^rpY`PY16nJarM8IpwuP+*Wo}`a;4o%CxfXI7lZfQeowBEra9Hdwc%h ze@60qea*YdZT^5np^tIhB+!qUg&pkJMNq%$+rL9YzL{T5DN}F%|p@| zZ~AQ%^;*LFg!bv}6)Z=`0r$8=EX6kCIXa#BdH&Kjl8IqsF^=q(gx*6tO~2T;P&x&b z6faS9yUfgpZPu3)wA$Hx3bbbm9bVp6Ih=qg2M8phf=sLLDP`8=` z?5$tHaQEH|iL7GJbBI#>U9X{<%WnGFVPp!PgA72xsNPtaz4g)e@E-`MEP|6ga1k=zq=x3=8U^ zN)1;ifyO3flA7&!HME~5oZ-k_47!I$HT_J2H;S|5mG*lq-2LQ(WSRa9B1+ z+5JMjt0?3^8ebJ~yF#&k0UUD9Ki3mz+=Iq9WLO<8z{)vRlA?^AK!|12m$F=4M5i$3 z1`EpxV0_)A^bf$8YpjuIGk+JAz(8tNNSPsu7hI^~)R*^*u4a+L#urPnnPs5^K=Ku^Bi*) zek??QQMkAM4_%TqBv8O?0+0B8`2S|-ZnQKcFA_gMvx=eD-Ef(4!5PRq<&ED=ml1)lvP1sz;dM|f=o5T&@^G3Z zIG6ZFIaAw+D+Qx;hb7|8*{%`^skJ;hSPO6cX0Zsg;i<~dds~0QO+res-9JV9R-WWL zb|omqTs!cYcWWIlfG)#eT$hYf)ef+e*XNx_67D1LY*a^&4 zV)&u~Mqo;Yc{x9=f@LOZ;vYTkba!hJ_Cs%#RlKFEyiEroxg&mafSk_eoP;ZtPzH#6 zS<4uQ`DxMBR2D#&%^)JbWPtuO$4B?;%KQolv{aw~8ihVDGW%-4!w3)~I=5*%ek0XQ3 zwy;l~F)lyg{J$c)qjx^jJRuA+TR~6e#uoAo+=Mty5lbE=0hp1|t}S!bUm8_GlN}(_ zllh4IVWt9W{e#b(0g<^jm7s-D#L~@n!DOCfl-2&;Q2c>18nSM1^QMCL&EkX(?8rw& zK`o2Xh7w@Lmut|2D7fw%4uBl5UhCuzlwTkmkS;&jJa-Z?WQd0=IrY)P;#8{E>mR~woiwB3LSJWwg(>J#1yji zEha2Bn>KEtQ=E5`We!_lIoPhaA2ChGEu^((Bi%eQg^E;e!x-vQXaetPOKrcwjp0e` z>ZHp1oQ!yaIj*q|QB==a-DRB(^#Tnsdxphvq)Ba@eJHOz-pV6$}c45XWd-ENMHq zEpethKQKTZ1SO|A6|gs0;*to^TFwxvMez%S>1nz#+JMu2z2L$GtDE7<#)+XJkuH>Q8lL zFP0w63Vp3n;H6FdO4}F0oBLj0W_CfRt9SPa~(c!~Bzx7qFv{8uA zeDy~c0N1c;{Yd&40Jx{FMnl7c_tHCC9VOPI186uE(Em-gMt?5zE`hEdq4QA@`;93P zO9UX4DkZ18mSKFBBq8)Z@0ckL$6p-MdOX?nBp`)jcMScs3_f5Tlw~WDD zA{{@^%Hr76I7S*Y1saK~2rivXEQM;kSCHr`ols3vCI@brgh z(>0n*c+n!P5u^qj&2zhjZtjPLAWv37*MqwaU| zkz1K^rv}rqt!80&^n#c%dq5g9)v5CUn2jXPcMV;#L>i62BEq6_h%fLG{53=f14#y{ zu=|JS1IH)T&}XKh@(X^gP}5rs7`Nrah8OINtVn9t9d*tdJDrX)SrhM6Q2#u5qF0t+ z0Wmm&xz8h7&4#_Gr;g3c_TJrm4dx#+{;?NvgfZciNYfU1rOnFt4ReZzEJBPAVmk6x zu*2n;VYsEU+L@0k{&{t@r|C=J12vrY8Hur}8?^Md6}XLFRj9Jnb|Zi5V~~*uGmdUs zn{Y5!wm$95Y2jTV>a{_Cj*+!8lo%<%Wo!Q=p=EO0afP&59C zc(7dWFJ`{Cv#P@^>|C(V@>ak#pw!R#wq2qJD)|wMrO-g8W5(^{TQDl}q#QfD3n?ef zgchRID3P0o377nL7{YMz;(*mm2 z<6MJKy34J&6xO78I|%$6WdHXSdfm=+x>TLZ!;lzNiSDoc$<`97_V=eCqc|@`(I+DYEDwiHuJK%3g=lp)->K zRe{E3)L*(dPMi(})Nk*c0%jRNAuj^gi{gH+bh(33k#cdvZ?DH@zzF#L*CNEDKN8`` zOMmy366v2>JrQN(kb!j&3vE@f2$gQKcKYs~YWmD}N#(@;;6BW`wFQN5ODBCA#q=)s z+3ZtPyaCokIWpys5`74raDyjugaOgoQ3D~?&MH<_v%CZtg5Aj}?{mp8g1a}Z(NBeT zI95-|=MW11nvaIDj@XrPC7A#CgAZ)S>n6jD1Wo_FcItTt*N!bCUF}gEy-d zZR;0`l1A10#VD3Ztn!e;c4pe1IjLCXycM?ErrzKz}47W1dR0r`j1KX`a>Y&poRayICxL%%^NeWD?^~Jc8QCg00h8)@ZRXhaNBMkfq@;Pe)yl((Z!d`ougv&MW zc8rkmlY8S+l}gUksbLKx-D&+MK$0iHI7J;Gz-70zDE)zennOUZ=l>?%ANud1U7wer zI9otziV=+~5NVsbWz(HCG`7w%`?=78vGg!O@iwSBz4U1-P=044g8a|dYV1kur{K;% zi__=#Uq@Tt61*a>PeSSn^eM=7}PK;W| zeZp!7l2l)9jTm=e{b4+O1X0QK zp~3v|0;Us6DJ>n`c@o0gEyPZ8#DG<_<;jSPBG&6qWk%}h@8`3K2px(;39Di$`0|k_ ztb#Eax`Wa67WK5f2V~}#Yz2}QVjnmnxH#FYVoXb%>Z;dq$AmO}A`cRqEjKQ=!=gKR zlTghGob*WNWTUBK`4I{o!KGv*G*EVZF&2B91Um~uF_qs!0iFsoNu+Y20EyXao#&AB zRcmsMlVrMGND{?j^%G0szlSKpxfx3&9u6R7-S0bXaYeX3zhy!_ntLdJ+Y5LAuw@m`H+Gt9zpQ=D?^~1icYOd-Qt$84P1A zzC{m$Osy;%*K~qZP9T7B;hzWE`qd_9-mn$XR#DZs<;I5XA-;pYpI4_m6iKv%1iZXY zaIaq8e+HgztZqnLs6wl$UvzUq=0c>DuH3TV1E%MBT4wE^jxY5jJ?B{LeCDs0reNmf z=r-k(M$&x#p@y*IhnAdF({d9l1s{aqJXD;E)_i6Wsp2+|^)zwWmTN zY&toy5F4@3f(qK$T~2424Nw&zrvdkSKF3n%urWFd%Od$~{~jYCP-w)gO(A)(}nbl;%4J!(^1k9(>eF56r z)GUVY=0Vqo9w}<)hQ;f(ujtDK{|nbw&OTK>T$|Nqh%~o|N?t_y-iI`ScxOzgGe6Q800095;}9-L%f{mKv}91cRslKm$_{{6Df%^vcL#jVAnZhJ4)ZnR4=Uy*`oFT! z1_`AaZ=)hPap2|w{)GHSQ~sDDz3PC>Ig$A686bOQDYWzZtek|h|4z~9siM7aOXF!f z^HmNq^st&lC5swlJTVAgDDuD7o!D-_@urTzs|Ok}(>w&4Kl>90tyC?s4K4gQ zYS)*u$ZP)e-R2Y90X10M)5wCzj0nB8CiM*aI1GD^1KXmVoAk13n6~3CF&32<^(UwO zRed1@|3}z)BqIR2bX?Zxr0Diy*BsK&NkmEf*}S>A%jDO!j4*T?8@#xSl>8Z0qOB3& z(~*_^qOEr^r7^y|F4>EDsMw3y;wBPhM}GUiT-ivdg$>CQG&u45XqsBc8V?B^GI%Fy zKDT6+NfHAYSO?p-UvAY7IyrJT*Xrr4GgVGONEUO6hkxX#>1-`T&Y^o@ws#%q*l~Nl zOh=}4v|H7YTX1lrBPhG8cV8!v3y_PGHonzq0~^>RS(>Ab*AgHAJ%ZJ#G7dzu*hT;& zNS2Fm&#)dq0H{BTzn1-4d|OybTk)+7xvlm<>pwwGb6 z?!gL9IYLY;T`xNPW7+7WA+RaY>>N~m@UTb2@eNJ$9GMAeBy3;3cH)I35?=l^m&Scz zWMHk^jMAc^-_w(yo+W+F4K{by$PmSF6dwHM164ZlYiXyo?@|b)=ZqeyCY8Y~X{fJcJ(7Bp$;gu0LgCHN&{NGqHl)KTF5pGFn zg;A6l4dj$6T@$Rf?-6xTHDJV}@Vts0$5+*f!@cTi#EM(lzRav<3N+Eg(L>%!M_vbv zh20sJ3HPp0Qin?Gz=}Ndctu4_j6NU8r5{Pk5J~6;{Y8X92`7yrcXq>-qY+^WW0W^6 zO^mXOH%v)qkPfV-(yAwFE5V@@nrC)Cjcb?#S<=vmTn)<#-);X`AMpPd&O;5cc`e$_ z#)Ye#au9+$z&7@+`Pw5@N_#wRoO3wi0E&ScjgF|iQ4r!$ii=NT)09jV*8W07$odW0 z@R-GD!_eRUV`*7HuWss4jr-dBXd8LiSjDC~$N)5(V@t>`V|l3d|6{LE5hUB&{{6EX zI#*Be&P=^D6MXQ$MU0O>$pO%+#v!Y;$vENGy1|lf!vW!h>md=+eELp}msYnr`56-> zsUdmyCtIKOIU~n%(Nm6s$M(ODa}HGXL@>*kxI+d5&nZdQQJ3T2Djoir3~Xg%wSVVP zpu5EIBJmf6c>sH+muiv2(Cc?)&QoL@J$5j<2s+FvyRsj<~PMzaFI`e54!8%2Y4_1e?l7n$|m4Ft5uegP%ZD}2xAWlVS zZ}7;;+Y4={BkdF7gW`{LjT++l0?WO9qJx2=(ldO(WKHx;X#48uBC3}8oGz@uVdV+p z=Sr=7a}o5wKT8(EWhzy4C4623%FbKOpk7A}PnHAw1inO*Qo?|X1qN^b{2c|fH)jiT zf8Ax$00&I@L+KK#Vwjhc*HC-`f%DX++2YW6+crHmoRYbq92_nu>n)`3_Z%jSjt_T? zdv0X`d80OqOLxWx6bS;29aAj+uszY>$?LM5qjpcK6JhVCZ(c078~c7Y)P(~I!UR4gfy|Igm?E7+1z%W z=!m(S18Xx~d8S#nw^`2BWt`-uBwr8>eVvAm6LZoX=V%bkE7#HH=IQF>LBwx1Rwu*Y z-i(un{-=-V6t&Q;rMO}2>%35usKB76;n8G}O4YOITT29!7IGGNhnZ#jMIwiolF{M} zJ?RP+fwKK~530Bo~YR)R(`!FIEj( z6q>sLnGp(ZZDJBytK7=ZL4LMj(w&W3GiOr5&J-opS2elIsq^^ZJML63fC(e~m(OKk zs8Frm*=9%&igNKyZ zIuW2DRH$Re&{c6$43fEMDhHb{_6Z2phwdSaYQH5kI>-!CaV`2AY>Df!B?L7sAQil$^#=sgP23)uf0_>MUgH>mV(rQ-Zb* zLb4fK;6;q&348EjqxUdt{w^tJ!IzJ_h0rSV1tb@Q@ci((?0v;bD@hlS;I1mqgcb+u$lNvK)bC3jkof_@Unj#yjx2WbV5-jupFdM|`550PE>l!*hh2 zPS?v9RoQ@BWxNfQiGfq@(5l%%2z<4VwMpFr-bY5+KVKgeYkM;RIeo_ zpoEZ06Dl^`^I3nFHehTKoe!@~!dSd{-asjLiN4M2A8$slbYTLn$5H&k7sZ*N)c6(| zcV3zxsq2};p@%}To-hI0OB9V;t?^>&;BD@I zpQ4h*x~a*rE*+PL#;IUE$k|@R8zvH*O_&j=Np2pq!e~dK>a;3tCx4k8m*h!*#lcLM zj{!rV!$m7LNXS454@bVm*dnXwQ*!*hyjQI}TYHKUgPuq%H6?6xg8$8nqR<7=JXZaI z%uv3_Zd*V9_x2|yU72hRpCYx?g%v77jW5nvMiN3HKcIL?Qmw+jG5o^@@6ud}`Gr&& zl0;iq`#SkGCfz;t@jlF``;LH%(~unguEXP^OsK@as8Rc|9fI5di9;)N6DA(xS02+aqL+l4K2PeA!_d8NIjhV76YH@01GKpMaScZl zy$Xe^8&^zaGU=hWa}`Ym*3!~e!Ppb5G^=N1JQC_#gnq^%X601%ooZvpTc6=w**&D(7r%rq!w=GYMKndi)03U zB=|V{tyaji)xo~P1>X*wXeTiYAj#ol z5uk4k2ev#EhY>53&dD}R6gV_KhBtt{1(hplrSR|#fSCDW*K1=`=*UYV)e4JQdy00d znJ4bnbsOB_Q~*Liy}zDBdbG5(WS>d^LO?b9#*x*EAk;9|#?1(V2{5ihR5Y~!c1E!+ z{kA8v_rN96aTh0<-_xF2p44rdn8?~9T^oX|^RCor|6FDKKS%J!A_cyrtVM(%Kui%7 zblmVrevkeB8Tq23+2_lqCP`*Pl5F977tD&z zvri46X3pm{wKOL(dJC(KO3z7hM%qwcBHFm(MU2tJDT)a5)|rbh^z&q$3&wHO!4tK@+1M zn9caj#w(o{%YkU4wm+tAb>Uu{sS<4gsCIyI?)SWcgM#Lf$2=g4ot$+*loCq{QSh+N z7v|_c8-Vh$;%J6SQ@IB|0NceUt<-7}62#?UcQX z(+J;7dY&+fZ8gHbMz-A~Hr-!BqA1mA*X|^-+2Q3UnW8xi3Be7T(-dd`_S+8V5Vx6f zx#tfp;zi}y!etoY(MRK7L6=p7gfW!;&T=#qi=WF)r?|${692Z;hX|aC8@ZUExN~AYZjkJ1pQhwa#yO`d z?v#`Obv;0^6B)$a>hx8lZt5cVfAb-4Z}8Rzkd|QFFeDtOPit}-b!o5q3lY1vGqvMp zshMZrtz3tFBGr03$6ni%c7NF{(Yv9Ip@?Zh7!ut{7UtEANZ|HcNMF5FvZw=u+ANC% z^P%BIJBwl2HSdu%EOV&k%;5nEd&qby!T367W;Xg3Nr>3Yxz1majECFo9#C$E7(mdp z5NT|AvXJll>sHsF0Y40U|VOWQG^C`3A0a&BXMut;eb;m0*W_Xhl7TT-fK!QyngzvdSDBjNac5jDDr1iVK3n)*; z&tk0sM&bY?Iq(a*7_GoF0j?&p4<*5rEL%l>rcJo@+b3B+LY~_Q(X%?2L3p7>cYoik zx6>IeZBL05ODcE?WDui(OrE~Zc&PsUs_aM?(Zsg@ReIhGe)84ZP9CDB$PvzO(kLK@ zx2gVXY0zQ^GIiic6>mL}D?@zJv>1W@=DMh;imYoRZwEG-^2Lt> z_b8s3k4cV2^7@`ew(y`hFhDWm4*qt5tss5_8GL2q@QIH-ryfea0dbf;I?xGyY@^a{ zUwHKOu-&>O97iu^D}~p)N9qv%Ta1}}kH3|Cg#IN||F5g5!Yf38x?A+9m5YdED$=c4 zn#H3#93aeaP)yJ`{)Wy7vlSfO{MO~1a|cRVaG0q(%YT z-Q~F~^LraEF+0q&gxds;cJ5-($2gPM*H=WExXyW|^H@~DIX4q$K+xRUZuAB7_Y&b7 z|LI(=qF?#saNE8BlIm;}@$d7VCC%azv~$MVmW-_{D${5q)bS`va+9t(4?tWSDdvIP z#|t0kD&;g={$4P7i@Vk~I8DYftn*%suR>DRY*>U7;f;)eg|)Kl2|4N=1#DDXHRQQ> z?az6L_)JhImgFb6GmuMS=>Nfb*+5J&QSFPP>U7Y)!}(nI|!gLxRE6#132NFIW~+ zWpF!?1{7HB9e5{Jkd+5{QMR;~Ky8FPhBZ-3M@GeBL!9xDg#}uttsH38AAxY;W|R;_ zk7IaxA%rHG!ho!gQ1mx3d`rRH=igyzZAa_iqLO9pAr`tSH{T4Xj*X7sNVw?T!z*g$ zEN@KSqPQ=2RcD#ISmQ_CVI9hIvc+dKK4o4WY$bh(ni_PrS|=Q?HC&pcVw)GP%}QL& zT#bM?ClzF%%X+o)Tv?a`5aVT?B>H!3ww85GpTQ^jBlnC2`u%c&AZ2A8i7TWCU+khK z!v-GU2XVS$yABTMAIU4`zeoLRSuZR6vS!j}U0>G-sQKvveR?e9^f zm>%tHn|E$SwUMtd;|aro#-K~V;U0SuN~mQj51{IpY=^2zjbMH)i@=m-u=F$AX@B!N z$|Om^&Z~HtATX$~-!)FQl$p(GoI5%ylb@V$N0SPmBR zIq;WJK-o1Qm~ga4jNrgbV&*283Z!6u71QC&GA&sB8wLJ@g~MB30)5jLQ&0c^0{}{1 zV@KhB9H@7ur2qW7F&btUYyWJLqGPSjPI4@4oeuzY0JEnS&;S5G=0Te9H3%)KGMEH6 z|Ng2~000g-rWG&%N65AVe1RPWf;$yXFk_e*T zO1mM8P0znnyBSrtomGpaU1-{c0tWk-nja=hOrPz{Os}HJ#atw2qyYpRCK9S8QC>Uj zk|B5xpoh}!b^rqklH-s8V<{3px$vvi+8%bZZMUV{ZvRL5BzNFYhh_E&d1^M7+*gkV zK}W<_Q@1;nhcZ|196eP>^S6Hj1oP2kkG9}9VgKDbY1CvwK1qlV*65VW836C*qSmaj zY`BrvP!`j*6f#JcXaCvT9?zOoMjE!Up^Uf?cEmgXwZm3O{3f*Ap^g~rRqDFtQ7GpJ zGs;RI#4WG1vW;(z%0#7WcqPK47wG3Uoi9%c^xlj8Av@?eii;V=w-5^h)CSzmc^*o4 zLY!!5D?C7th@P@cVEQ7t17kDPKp+II3UT^f-IHZcG~*)DsCWRtE(dg>F$#%`+^6IZ zxV^HIZhSm(ciJ?P8?=&%vzc;D7X;pscJA?MQ%@Qbt*#Rac0wuDMKEDW(}Msp^~NcV!hjrY_m8{N!SFpnDcKz z#a~XY`-$HhZ z2(W-708{lR)*g=aw$Mh#`=hE~Jra!}xvxs0AOG66&J0thYm3H{!&Jn32?yZ3ZLlg< z>};xzJ~{V{Y@Hz3;~uwmGYx?kn&F!Ib=M2*DwQOqGA)OL&r+BwQB(071@;D!OiNRb zs^5A8b`2uPM2=73Bk-U(_t^w=bu#tnj<*UDmXyM&&O?#fM|)O-pzYJ9mq(tavq8lU zZGQj%8)%&lF2Z}{hoVyy+qnmup}HheeUrg#p;qL|X^)9Ux0G@JbI`?|yJD4bcaDmp z6&1s=hpI*J=hkVvTBe(42w8{q18@=4kLZKu9!ruT{{^?%2xEhg;3cPW1D87%0a&6d zKKG!hY^r2Jwv$%@;K>ZG>;KkviI5Eqn<*F<7J;APJVkx=4$$73bfp!nDnV zw^hVZou8=fgBqb_i}0JVRL-h2Re#$>{2GO^YtR1a0E;WRQS5^7yV*L{#MHnC4z2{s z?!eWQuz`xiUmH19%wn6gANkznNdu@lqdvgeOFlL?puF)-#(L z0KGQUv?!({M#7t01*m?mFOo$|aE64+sANv_?LuFoDjO2rld8Jp7S@;H4ay8yJbji~ z(Fple0MeK~u~2=8-Q?-+PG<$jDKQMl=oSC$#YQtuKXxY4cwGY56Kc;ZG=KdCWkMAV z^Y1Twt0DGqTi9|q2m+&U`E=8)qaK_9Ws+Ok zw33)x8i(v-UYkh6I#xQ`0(|q#VTLgSzFAvFYoW0E*l97}hHaGrybgToIib`FbZ;qK zh2jD1=Bx9tm)t5JCMQEt>12=NK&n4H@JzGRuP^n+!vH$Zj+;06^Dv%d0&hI9X0}g0 zexe~o)0WwGMCr^&?gK|<2gT@Ld1j6Thq9TA;M`h{#W5Ar^dHktWEg98@_Fgew74nr zjfR?BS1>Oi$}D!4w(^=ERYYips&l|9OPL;%*6kr(HW$|_JYpvv=(3`aM~)r;7Zy~d zm6T9bri5eLzAoZA7#d!*Z5sArZR0_Z@2x4g4m}L{+(H+Ayw86BAG6~W^}me)^Z)Hi zU^MyqGxP~`+^o;QO=IC>=w@&A=gqn?a|k#MUVi-fW<;JjWV$J75dUCPDorE%v`QDi zDh}gvgvwL=&wkD{BRsV0!DazC6^e8mgT2I0cO}A$0fokGITqC@umkr!j<0waSBh+h z4BpRyh=!jFg#j2Z6LNx&(-_>T2yylXwmtH45@)!yI(XY_C7HBG)X~27`vz1Y_z4$6 zrq!x?2sOvwvXJhU7rT_VB1hV|zSv@=eEVsI$&tL|NZ(VndMY&r6rS0Fon>xx$pO`^ z_DBMOO-Awqi6D>)DteJHw@W(sz1B1uMg+TD^y~4fE0})S55N95`l&OyiaFdd$6`@Ie&Ws1n~5%+ zY)7|{CWvhY0_6g#^$&p8L__>MK;tQ6c(HjjkQ9s2ToW>vNa{GNxd z?#!y$Ms>d{G?UK6g5~l-U*&G&7fr2xeRSW3Z+4G5An;H@Fu9OEl4(~~*?O>wu$V9X zu|zBrcqVA|z#SF&$@9DHbkSYq%(hHBEew~pr9Jbz<$mS;Rc?7`Af088?20xVVB^=! z>mX^e=&jWw;w+)kY&bW! znnbv7>+Fg^rbWG9edY0uOK@k{#K;K9;lu`DgOYw_k&m=ZU9giixZA*X$xeQctXrh)@z!o`& z3js%54_G|$`;UI^?I*D%dOo@)4abF*G01+}BNv*l-(PQGJwllxC@>K3mX*(F`W|2E zR*W`)LqFCQUd+GcydVB?p)1ERO9Wk}Zfz4~{NhGm)en%rSNqkLH#qjK7`6p6YmEWR zyd>zA`2;fRfh*eLB}weDkgpF630N`V(x2W*|9GYJ0wzv-423^#y>4$6lEuJ(sIUFrsmwGPfy~PAh@=X>Zyw(GTxQu`mQQU zRVyA<&5Y#svaRRxZjrTZ85}CaeNaLt@t`HQ)Mxm6QOTktc4}d~Rto+_r1lBjH-lBm!TEB7M!deRRb=pp@BK+E z>?m@HQP&kU-r*A~#m!l9?B&}=B!~oYE-qj7llu5IiBCmuh{-a|KB6f1Y*7eF#!Dm;($tb(V%l$z*aJ@Mq#r7u_Gv5_ z_Xe9kslT&V}@R{gj}xd$EsFqI*kFCB;hF{FQE zVA0vMJ?&ubV>kE zH+w4ct4Z8h-%51`%uCQg)SDC>MmSt)lJx1?MINR4_FvS@ljCqYpaHh-f%;S(Rn3d| zg6)@<_PsvGqjx~4Ns3?o#s(kkVs%AI5Lk*Ged+QvO!|$-)CVYX+5IBWcj(A*j>~a@b|=y+1eu1F6dF_#k8$zp z_}kL;{H4auWnGDfKol-NUxa4Hvj>T);-4qGTk%ZK6cm%XvPvO7R!UL2g*+Zq@9!cU zSviMn)xc#V^k=HV#;CoA{h+ZLZ~QZU`kcQSYJyvNWI+hxF9K^2(~Lk1^(?fxT6$^! z5#|KR&&XJK1;EdLGk32^jHDy@)BleO>&?C15Lj|z~s61G0M)F>jh zt=l8fO;tJW=I)L7_l0RrpB9}nGfahlvRNxpo*B}Rmz=u-pUbOqtO8x^?51}t&~gsD z4XOgns`~1dSqlc%wEC!G?%NrlPxC=_jY<=vRXgdEAy*~L>U#;7o)$j#SM&n-AY zH0$fFsJd*$qss>obDcxWU9oZm`feo`Xn^FUl zaoMwv^T#kJo>MNMFqXxG?d6|o#auE5Lp*p0wwJi$jyolic)-8h$Oxoh8{3j`Ls^T) zi3>m_%H#3L`O1h9DdQo!EvH^?X@Wm4AexUpCLlrHPML1CL>R$?drrFJnjVI&H@?&u zWsW&70o!Z73T*=h%*{+NG{?bdz3(0I(rA_IF4P7rqPhOZai9`*E~`8aQ@6_3##(Jyq6Oo$2R*%S>0=H9%bUUWs!Lj z_a~eOnOaBQ?rg%Z(Ep8il$T$~^JqN_4!CNL{%eJmcCsi(=oQE+LP`VhJZiJ&t?d>B z-LBF*sA1eaMmZ1dzoQ|JD>BV^>*v&D*QY;|nMwYljXy5X5D!oY> zT?SDm0%xVgz4Tf9<(Q6I0zoT)JOnuXU-yg_%d_yud41oreNqm0DXSl~PSYovN?+ch ztarNaU7+}<|MpEwUg(xp_4w6N5aZ)pq47LO{faBNHRgshB=hLU1>}GpEs*iJ*5GjW z-srnisC=wv>GhmWm+;Jr!2`?zmDWX)q#}2)Xwa;NWaG7kojFfrLcrNzA6u7_3;Zie zPjz@MA&h6S$hLMn^qB<2M7mE=Ft?Uf?(4nP$*sl-$Qk8k0HPq_KI;s9JZ-r#apjMS z*%jAI>`;2bTg{g0r>aZL8ZSA|ytl@~uGHjFDa+4##F?i4$V<~;uyJI+5s8Igr!90@ z&ookYNZRyS4@eN7-ny^y*hUivCKfCOFjUn{6sGxs9;fASoWOE7Sg%sTJ7;Apw?KnM zz3Ldzv&x#7?5PEE8&%kE3n01Nk+r7kxDjFv6gBA3_1PMJK{rV1gFTH(9YaX(Z^Tk&Q_*>#dF|C?jTRFS0}?X z$j#);OO#O;Q7LaOq=FZ;+1-}^ReaTHk*WTSU!LN%Lk_K zrPhEY-tLdO39b)NxH8MgWJ2k)-SOnstOk8=ZV$ZI4(H5j*h>{&dl}KCHPrxq?H)w( zXe)nc^67ujE3baPG+GxtmuM*Ty_ZNTJt6%FS@6~#+G@658zk+~n32k0yrP%1j_J@d zepCN!L!pF@N#TsGv!4uxM3-X&CMg?kA|gMnxZdujNm+P@_vu%;exw|DH=P-*(aEy5N=;R3u&)2oi}e-@ zJMz&0>q8Gep$w<9+=3{6kP_jDI;940W~M2oq3m0nP%tO$xTMzim@<5-95;iw2IUg0 z6vlnE=5W%?+XVi~fpyVqt`O*efuE zJuY;+1jOF`u?njU4N(&}t;84v{|wcm$b&w)9KNjLp!|xp$Xy?nLKscv~S9mZv{azwc1IAG&_(P9UV9um7rvA$yYqY%kLy@fh zo`_`|$@dvgtEl6%agHxgCh8!OyT!TxY7zAYus?77HjJ50EFOI9Yv8PL$YMlcjAk}^ z^72VMlta^9J&>$-In_%alm^Jikr-CxFQh2wayX;(a~(MGDbW-fT!CX%&7~|!AmykuFy2#<*3(cIB5_1(+kH0J+u9+yY((@Z)$k**SjPJ!&U{WV%&CT9h6%#KNmbD30*%=d~9+iLy zJ;#oA#wK|gD(D#C5d#q{1W^~3hUy(dpESBYF6bJ%pc#sZRd6mj)kTGb=e}Zqodr_D zUdyV{zabE9n?2tbJbMa3dy)Eo$!%94);A6qnMp|6LTYF9(Q}Odt6s|^d%zXilbLlHvjrsvuhYC)XL5iC+LZP4H!o^yq9=HStJxI zHqNsp$*!B`Y_n!6MNrzibhAU=)S*amEO>~vve3e#6(zAtWvvj(`#CvFHhH~J3eL@4Kq{=~fC3>PF zPmG=g0Qf4WakLD#nYUM19LeE*6&L9cPd4yUXEmf?C%l#f%XD~gj4M0FP~cOADR=g7 zshNaCLUknQpx)ZEP6_P~Pahw3-)lyi8UdFyaO0Mimx7^3_t`SjHroh_C=+hiD(&`- z_C=@29}v_oqX2aNw}{N_$Rqp1*Qy8cUWnrpd{Dj6=m%qXTl*W;pFPTJOmuUUJ&GS> z4u!N#HPsOVR0{q!xT8ThVK&pVX6*ilR!umW8}S9!dt3|2t7`;%Q1tkU$0dZJ|qYNF*9NGaN@_oF#FFCqI^{Ub7CN6d(cpl^Jb z5F{}{CgV5msb8lpPayk?N+xS;xaBzI)>(s?1lmO5<5D#ZDUy&s^B-S z9^=7d=-iw+fX+g~(xfG!)AjlS==%2T2KKB=;^T9|CI*c(0MF)ZO-C0Jz}eyqy3OLH zzRJ5_90=yF%2=TA`q9(9sE?duci?$YU(rh1X5j!s$&zjnO>FI3dp33m{rM0OR~E-% zmVqz7iLI#Jjgy1hJ$@ZjdNBsf0xH7R#!`5p@N#Jvnp9?>8K_%-j3zrtyY#0rL^A4^ zz_BKlYXR9Qk}Bjgdw)HH0MnpxHx(QzcfraCIyeA`uRo;U|MpXyxB=|aOq(*Lz+g5( z{*JE~ogRKzVuI^Y*Ilb($FDY(tc)Z6s!U0r)#($L+N*P(CdsI-yywAU4mwVEy6~u~ zDxC=2DNk{`*9J}L{^uxJds2Sh$zbKeg$@l<8!A2o>_Tgruc`>4NYHLWaj2;NM zN(e?+y5X8%EP-k|%*1OwGW>l*LP1e=m(>)&5UzN0w!3_?(EodWG{gUef2zwkGVt!Q z6m#<4#DQm;J$GxQd9DD*06jY^yAgf(pkRspVk?=jzTI`YA&CQfA8il5hMQlzc+IUo zPZHaURW6=VX*E9bECo+j$BMDR zu~;U4)pYgz`)Jq^v#3vY-C!tEx4K5ayt86h&r2LF0><5@z1(lPSC%(>u2qe|Tx5b~Cy> z6Jml4v|WIG9BU>7L7_3j+x8ifUP#KIBXl=HG!V1Hd`^`9lx1_3u3I&VxAnvU)8l)ARcKf3ne z8`aayS*O*;gG4rsPdTGZUQ#ryJKXb2QP#Kp9){Hif59stMi$`l{`YHVCq4E6crz0e zVQf(~-vh$DzZ#7uN9!zGrlJRfjF*I}u~W5r4e3~-7lS@UwXzOBD}4?ZFW7(df2xX` z6L!*x5wP8%5<*a@r|BrvK}E2Nc{d)&&AQ8i#epEE)>}txBc*ua<6QNj@uvZLliYwx z4Fte^G1sft9FUvKv^w*j3k8d7`HpPNeEct~(r_H|-lnw|RxtZCwvE|Uz#>Je^Htzw zX%n28rf3K$$;(O_DXqg$tVgk>$vC2y4pG6kWXHJ@%w`(|{>_xY9EaNejVQj=1*s`d z7QtA)#5BN1$nmDpH-TxvJ8;l1fGc*O?Lmu7KPGR~drvyVg@saHGPUx`5r{y)jIv)2 zNLDlnMN+)8J2r`yUD!;sI`Cf5;Q)ltmr=}gmKwdlbFxgWveF`w|Yq|54 zPgVK9Rw2Tzql=hE8f$*zOwT+F`cLyl&bQ)Ec|q6VPXzG;8s?3KmR~E3wZb zpwI-0e|}BUO-ZQw;JeHNCegjv@ypsripQ@jFxHm`*9~A~IKaQh?p}8ItZT(on;5k5 zdG>CJw9l`}dh9@-(@sgP{2#=lQHtQQ?5^H_!Jv64_}$d*+V2W~6O=fZl?!wmHP7-3 z!wq#Tk#b=Iu@T3G&4+LsRI0}o)h6JJC`m{?5;q_bdHo1OCcF(pkb2dkWp;-QMdF-i zZxQHy)nYz0U$tatSNVFKCOn+CH@P@Rbsa9?m(~vW0z@5w%?c~_hiyKF@56!Su*gj7 zZB70EW_mFCf?PfA?E4ofMzR+mg|T#C3QLb^W?HzDbOo*vrMOy7I^odq%8w`!p{jw! ztXf;Er*--5Mus$1umWwf#CVe#`zHR@t6rYAQtL15X@$y?qiAVQvb$x2(Fp@TB|<@A z{;%xJSV6e$56zCgsF65y^~w!*a8nMBc=X)AO?WFb9Z`^PNE`Nn1c<_uAs8T7)c#?e zCA1Zb>=(}Gs8yQc9}muM2jBQTUJbsTplAne_AuR~{6tyIN=;7c^V~!$7ID3b$0*6H z7L{o$uq)Der< zyV}|Z+5-YLq^B2B>3)AnMwq7XkB9;S+vGvdU=LvW;dku4of6$}sX$_^<^A*Esb!U~?zC()_5+ z+~v{(Nl#MUW*gOC*#8&Whasc_iOEMxj54?C_thmd(I!n7*XRb$!96NgBTQ*V4q&B7 z&cp7h%C<>8^a+Y{S#41J={zk~+$O4jbe+eSD(0tK%v;Z9n6bD4QgFGH(W*FyI8zB< zC(!^}=fSJnchrtUX)APZ4aghsB_>!9hi)BT;_^)aaG&>F5Gj8c~Zm)A6`Sy@_T6V3Fh_aKT%$ax2T5c z>i{n$s63kF;{x_!r8Idbm8gC#e-ahV(^-J`%G;mE_WH7#Y#qY3vkq#&>6>-6 zfex3ve({r2()t7nm1_&rNR4xo&MdU_rC2~vg}&CUtqCIbZ09xsZxfaTVurg)I^0$$ zG??Xxh6G~gD@Xh7gKu(ZPbPT3uiajv4C`f08RYn$R*yb+MI)tve;l~k4y=6+jRAqY zsPViQpBDreg&s7^B<_2H0uP;r04jc-^7v_+@KdIb%aF2!lgBi9L>p~9E(!yK&;429 z#T1LSUC9RP021O+eO;JF(1ac%6LDBdDiYfsJQlP9nsl+pqY(^Px?7N+!vT{D zT?$+%Ly$GlHG3DS+d&QvHKVfYfH79MKJf5Gi(ahNxyRw`x zsJ(ly5u~p?Un}irB%8Edl_=8gryNb0+vZG`KB-=cQo3iRv3j(g>s&6BK1uEilk}Ho zE`iMG#u)#pYaS*f8?i^<^WWW`PU_r&I}jn4DbSA8E{aluz7ybR#kp1UEhJyf)E2?E zIU?Fuv#80g8CD_XLKgbv$JK~96Fm=!)D-E7C2KWuQK;lz#Y&ynxuU#?=j3jep z>`=o-(_Z!!0Ezn&SujDh8oXv$U-t~*PmAFKT`N8xhRbP(x}j=u>#d$b*RbHgwQqeB z?N?MN!<#6I*%&mcjR7QmD+HV(@&Q53xqDYMnxt(|3%?Y8>U!YcO*_j{;bMSDXDccM zYPmqZrj{{t?2x#uwOW{sTd)UJE!CIC3LR~b2wO5*V|J6{^BG%kDhMeckHFMQ4Ad>pj zwTXtK?+`-v-5BE!zVLA!X7?yy#x5QVg=Z|Dv_2OeI|wn));ccNxD z1I!R4asm#49cO?X0U&Fd9(???#h~Y~Jwk0HKOJ^8O3+h~Bp-$kx~t4ulq1&g+DPhW z6Qc8U&xK{tk@T(f;Su`4e)W*9dzVTJB8D!#r~wDpYDx7BmbZj~FLoC9(t6i!C<9bi zd;q!e<)nyn+A+b&YW;d(@tThW0Aqvq;tWUBtnCJ9?vG-k$gjA#OIjN?#icp9Xz zE9{#^CsbLPk{lva%XG$OCjXmTfD*dGN(=pu^j4FTF>|F?0dDPR0(%qEmTi}202&G> z$weNvXv>YM<4i5@-PR6O3fj0VT$HZloN2wQvhGY1X6*@*+v#SEp2C|4o5Q6*<%M;E z46@8_z&*{P{`9SJ z(r)g@+XrU-FD>sU4-Rxw+8hceH<~8PCv0v;TzbqKnQSDDrK3kAilBk&4#Kt4jkA2C z5FyEzBG`*AQZPF0`{GeHoQT_*{N_#{t~Wzi%u~fWj%<7oRrk4g&t_F-#(Mn**Vr{i z%UlDabrMdr6eWnmHp;w6!4x;g%TG2$xyf?P0)IQw{7EA{A1 zo`77Xrz1t25QEMvfKaN{_;9Sv=l)XzefrIrs1EK#?0m3ewMP~oHV2yCnxty_1i=$x z*@|b&Yb!>Zxa+B#P@$F_P}x3dygAtqbe(LLj`2!~znX9D*`#^#dmbz`!ms2ardG`I zCoSIOx`i+)NWzU?9IZ(4xH~u7WbXP`JIJ3U7e?n}kZk%#w-p%IsSWZ-3_+}7Ck}+# zE?tcH7ezZ=9qa1~87osUDNMGyo#JDEwZdt)-6xp4zwUYZD{RBj_nF6rpX)xsB+>y} zbp`A`gq0U{cY(j%XC(J&2+)hD>UB8$+_tWsW0c zQ0m}D>&~bsI&|oc(b#-b&fPIxJ=6Zi9N@%yC}LTP>5Mn!#2#3^;$~ETmHcl%T4xqL z$%r6k3{@xFN(_Q8%4>eKEBxi3)y@D-G?XKygc1`y2Ix4Q-kvn!Lmf8&x;9*`@+GZe z4aPH7kI=FIyTdc|M`~mBmj%3rk{RpyU8ZpQp6|;>eyl>Xo^@0zC>(^g%CF=K%1eWS zqoeTl#rw6(U03!T8vvVeyiTH3nR!iCoZ*1=8`+DP+DOnox*DAy-1vPUTZ=WW0o{$C z*NH&rp?sRM#N4-OqS+L?gT-Y40^`b!%)h7G8%}D0b&PP7(c5#j*kDVn5OxeYxD&s|~dy3J3he zuSR?ZU7xslE52+sg#d#SVBjA{j!U(|oX z+M2wgjfP%7xAHxCl^qI;jDWJ-!Hv%|v>^-GI*@Mm%HD8V|1IM0fYu=i?_m`w1v}{f zKi(Z+#pg1ioJTlzVsV2%;awAufA|qCt(9K?p&PB95K#{lC>F54=|9V0=BeHk`NpDq znw+V9eDs7_>ktpM-p#MYoQOhziTxGO6M$VM7w@~UxtjL_H8wvM_Ayj_-t8uNygUHS zZ;_0RnvyZhgJsw-IR;|d;JpTT<9tMhBv&;9+~z63(Cb-HqClUB#2o=j;Io+E+#bVj zcVIA;%0lV50&RvTqMlnY*voBb+(`U}3`BnGT8*AT+LW%W7(VMZbJEGb7kZQbJ2vq8 zrGW0ff%-*YFLu-mYuD--mDEo&wIcW6Es8%!pBhz?8{m|mEYOB`+yp7~5*fo3 zw|VK@LD;ErL<6iAseVRt_OQgUX~)2Lo_4O*(}$38dqG_D*IZbyb!6RofuxH{0@7VG z_f;>${a0j@y^482zA7lo%V6w$Tt#TlIAAg?Pbb3x*T*ygUN6)C7(myc05mee0GwIA zo>ig=?$Nwi_KS-zBe;>+uZy3qEm#pcu{w9Dm6jQMdko>N6s#E`30pn<&4_{=n2rH+ z0~@_p?+Zstm`@Yi(WA3S0^kE!1l``MsfdQ`sDu31YYsy|x69C0Pf}dBReaHod!M!G zZo0hPK%rN;;HiC+nu+v6B1GbhI095*G3jO#LUz{r+lST z>rI@aiC{IC7s;aFFC|rnZM7yqO~xg}A4R34ucM!5WnFk((_cs_OIPSyHP3x;9*3@q z(E~u70J&!hJFR^}3VYya2NPWfWAaaa~eb0mM(%dBZ+lliB+j zUGoDXdp}pyK+)|9-(adry4Q1JbzkSGmXCz^dujKn`L{!H7`Qo8v1f%rQ=~QJs#`sb zaxb$~*jpG;sTg*LbMU+R8MzGYK22tM{BuiVFsY#%ap6nk&I6y!nW(^l>URUMO-_5L z!|1*`9zSjqDY!vH!-%5AE`8Mff+1Iec#An{NRx;{e*@a#2S384L2p)0&yiPXhvkM2 zr>aW(#Xj0rdUEp1A>^N|SJ$LsXySbi^ba7Oyvv!0kBhu#Miz7O3{sPL6qezKX!U=OcXq#;iDkFFq^7 z+IX4p7I7m%xD?Ic$bQ%mKCeBZ{gi5*1!+QCfY&>~C8*3(I5PmM#)euHh0yM~3s!}; z&R#is!mujbfyX`>n=~{Witc_Oo?99QEEU|Uu8mBwspVE%>#UU<>vpZ|8Rq0URzUym zjB*6=6&6it2WHV#`qG^B`BD#LDu74F{(=dJ>N3fU4ortFSuDZ4@^sy5#Y|MDo^x;M zigFre-1x#5Z~#rq2XJHe2QTa*azmIZ!@nMz+g?U_6&nz1u?y z5QpNOgsN;SDTaUxMU<~y1#8FQob{<8%KrWneA==eP;{$H?TG@p4ELo8T20LB3rO=t zrrv?Q#u%jrMaW{KiZ>5)_W+2UNKC8ov<#w7!9tJ{us^Ftx`i6iR!Pibc3q>mGwMht z29l8$R~{d&hsNp!-p*evjXjd!QM~S#?HOGfG^KN2IX^5*BvJ zz0;VG&m6a>W{~=&tOVrD`u<#sp?c@orsa38U1h{sqj(;fVrEoII3nbPQ-YrwR_x(1 z0FvvMdwSCM;3R!M!|_tY9r~;xTu2Y=yMYaAdN`EG9g>y?I^r&+He5<8hw2N~7MNu##WI==W3}4jY3C^Fg z-CM(et!i93D|~K;v2|iFW|gmu=s8Qt&cf__Zp*-b%ivf)3vCRG$G%_-xzq^Mp9XNp zjnwJlZ#~N&9_h?g;iPE3ec?~UEH{7}ZNapLzj#5d0IGKnqwD423_HmRe0Z$oue%W2 zsO3ikOV%^e!^4eVg>aIHDyldEot8E@TuZ7``@KsN)WNXW14on{R{8EPK^kN(r4nUZ%5H~T6HIl+}h=_t%X94MVKYXMs4wQ8bAcunL+E>?()o~-Zq zXXpr$81F)@CQC5*(vg$(tN2lwjIOYhqvSzj$tlcFqRfAkEM(Ls`QmZ^R9`l_2f*y* zWPJ*S0=}|Z*@V)B0+iWu)^rVLEGn>Z8^-nGL#T0qXyUOv&J?1p%qH_Tmzg@|6W4NH z@s1`Sf)V<9Eb8D+NGBxvIE93GJe+~39b%-CqD_6C-@H9E2(#^<73E&i@z9fLv1Vk> z&w$sqUM zhvH1*9Bsr7NEJs2C1{oE1g`L9JZy8LGP51Bh~XErfln-=`m_>Ke)Ortsi}|H-rpN5 z>NoI?nfVSMXI*w=JHKV%L7$Bn@u&bhom8R5KXKcZlLbX)Ob5{Yrl5f?WUJW7sj5SS z_i?W`PE00%`SX|9n97ekS*C2|MV!&@ChOddV@Z$Vmo@{@YNl@WNTm0uC>N`4tT!y7 z(MD6PiHReS3oeOhD-*+^Tv#RiHDIvg@TQ`*zBR8yjEZ-Qj*2?wVy$2g3gS@@`e~L* zcQmrM&X~R2@eP~j7ADmId)nm_K~r!2W*}NA$tbVecQkWmOp9Obk7iK}pc%|f9@pWO zhMi`X9)N`g{oq22;;{=}IN(B)gKO5`>AkWLhErLw`}VP^1iTMX`AWuyCUP=4iztO0*`U^j81Gptz~qa?LO+9Tyv*+a+8ZPU8zgfo`~9d z$dhOF3UH$BznW##1=n3Z3M+qw@w<4|^K$aqtx69%DMn~pTXJuAU{pZ2F5+!t&Fx@< zNFFRm9aubekBjtck53Rj{YRcf8t<>$>9mFm93K4wVX0l`rsEvuLCwFOSgyCV_$Sq< zAWJ>KV-9%3zSOktU_puZzyT98ZU8pE_}ka3XINPHZL_Z)i+CM0l?ojUpumFMGZ4lzpbHg(&{%MNEkcT6~Kyz_tlaX9pE@bP{$mK(^ zHT*746-F*(uI$JQYe5dRzdg`BZ&z%F-|2T4{wi7glSMJ2afiE9y5#~xJJbpjcOWyHJf`-;o3kq&um&*s8y6mfZk-^1WHbw4UQ7xlp)LygRVXSC%6`C1RU za?w>s{6OYs`L|;!a(S;>cuPI<7FGVuRY*PsW_8qEe0Ef}%$Qyfb$pJhuD6j?^zD56 z+j*zpXsZH5r}&GPH|B>Qm4P{+mOY$#Sq0Ck4B=>?GVlyZ5dX5E10ZY*cG09Tg1>A4 z1n8`Gp8=a?AbHmOFSRsDEwbDEsqDoMby7ozh$lL$T08N%k%XlK}LY-WvBhZ(? zz+#z$mdpZQ4v^jBmG#Zamfl#8k`Tqg;4rkp?=>C)2de@x;BZ}a3d@k!aILRG&y$d264N>NqG=`@ytn}~Ea|yOf6W&qzdD(OP^~^TbQR3JY^k_} zp>Jfpk`bVRhE#I)Lj_{wRfX0C_-$zsOE$&hqYF`5aQ`Ah-Yt zywr=2br#U3A_ZZAi!j?q8>e%S6jKUP9!owv{XRL#bf*FgS}9;7hMk&n=RGx4i+JmI zgh9ObCL>V7ghFZ_CAeNKKA5zLZ&+2N%$@ZvxE%P%e&r&$b|k5D7<88ta`1}t^qo== zGJb0I1A&lL>jbK{9x!U#bSPVdPwY@~g`$%OiYs?gcKz;X%pkNGNPVCjQ+;p)$5vcJ z@ALG*MhVw--YjXJlUe#9d8{5fpHlZMd(iD-=we6KknZM?1r9DQ_MNk_MI;3`U+POI zNp-(3n|gDo6Z+I;(_iYl6=^i)YVF>Z(2*|J^Ub{kw_j|%>=WbpHU<}tTdm}`ppwKU zX@XRiMW8ep`qGsed;1j?3m3V$JC;IO+oU@#J_uzvbb<6!i4Ie?A6EEmO)Y zuVHsX+g**5_dv#=zs?-u=$Z`N{UXs8sSKEetB!uSCOY=O-Q_V7} z?n+{z?bnpa&(>6Hv=t0;uoHG(0;#wu;wV7M&a*cecB}pdj?iqdZedYyCKgd3;1L@g ztJn6cexQje>C*OQ3Z|7)d1|e2I~765L^t=gYz#o-Bn2^Y`T0+&CzYHpmVg}WQvg%p zQ@oxE(_Z&aroVR1KWkX)OoSO4z9Am5(I*Jjc(sSAc_LF%1+O05&HGn% z7_?*Kn~?XU@2CJ6M=9N5py%4M9=y9Pj_c9oGk7-+yj$hY|I#h-9ahPlGUokP~MaDwUaesE$(a${nwaFbIy(%pMU(UIo8V z@vs>GX0P0^*1@4PSguAyhAl+Bfvuk<9u-N+@&|y4T>7EF1~b3)X{2TDu zT_zX2ld&~#MG{Nia8$WK1Le(zWIC6g$x|XP{r!$b7((h34w7qz&EF0i*|9^*dsUfY z(Jq4HH*?8Cyp<^AsT}BL+WLk|l3D|w!_y-7lK=08-A zhCK$>#LTp^g8Ba@f`X|cHal&}&-HaU<|7AqhrD4Nr+(Heu!9ktFh)!t{92X!KPLrW zZa?yza+3l^7Pa`t&bu2_?D)<_eAoRFwcsp=WT>(+UF`F*b*?^9JuzF836JiD?iP_^qcas$qL;X#VHz;rl z!1^x-sHE3`B)i7NgYft;#V=n%R|9g%^@ExK23eyqyLrxub zk0!=9egOEF9%0zu8(m--5|}|D-0O%ZQQ~^Tbn; z5;X$}K4gIE1GD=piJ${b`oy{KUfnL!f|lStyI#Lpl)w<-Q@&*ag$T?8eQGCbb7J_H z3d20Hv`b!3QhGxYqdki7F>GGCxD#{n6Zr*7oB<1|^k*%!9 z1QGVHnF%UNf?Z%eEJK0*iJVXi)ccQ$JUys%SZ;ru*Zqj~2eq!l0l$LmnX2dpCR|f$N+#&`bORzOr*w84&Qz7p5>!yJJR~Ku2sth5!IcxobqpvEIEa7O^ zjII(((Q`&S@1Kx?@{23~ccJRMdqU)JgC^|;h(#*T(}ylOBuq|!ffh}sPR(L>_ZZUp zIJQurF}xf5#;s|U)dpTe6JHW&Ha-f0000!JL7xs}ltf%B{{R48CJEG&I3+`S%vnHO_kPIZHPRNjf8eS6uP2b^r;D`VeEx zpR}7f|3kl-zRv##>xLEosZ%Kg__fmGP0y6?LM_s3jkh0R4Ou`sdqJsaF9s07Q5w*g z^*rerJ8b{^P%J_`jVs#MIE@h!BhZhEmW=*e!cA#GG6RHbo$4CkuLPNih+qsOLI56| zB@L(4v4_1LMR1oj^dw!DN*Le{t&;;spkH4AB3FZ3YkIm{>D9i`n&Y4e??P$&thbTp z8cU1G;RROPrO%W&gJu$}i#W9ND2pX@s;L2y1OtOOHR*^S%s#hXFZ_iMXLz7b{kp?F zve#d90|ID!{_O*(sOD}vM}76z-LX0SX}sm4pIa4f()z?t-%RYUs@#%!C zd%Ow$pKM>s){N*Xak$}$Fd`YbEafmG3e7;c^VUY1-EpGHQ6KA$HsCcQBs?CbFA3(F zQZIbo3DjWmGqHWs;$jf$vDhG~k+J<6vo0r5yIGSVU>22&cF0?=rqK4_@@j}i`~qnej`g^mjC zMoX1Wdx^~HRcv3m79D^}V;BZaKi01KB$6MeB5}f++cE4J?X%}*YKHHrApZt`-@xtY zLl7c#_(Or_`;t=np=N+@Cl{G=cLG>1j%m1&Q>uv~WOswJlU}VoBh4>axs&I*R3LiB z`Q_2)s}jw|A(UC%mQ2^$u+9gd(a?V>I=sj_WeP8*Nz0SqRDOqn?;;Hi6AF1I1xYuu zh(V3HGjI1b&%is$bq}Bi;plu|GO#u~A+#oidX)VCk)u29lg0Q{@L0oWMW~Tdt)Q zKP59AjgPOC@1~5QzFYM4@9oPWLJ8V~6OFQ6m~UW1w2TaaF^(LPnbh~b?$6UF^Z3H* zCe*3U)I2N0JqRky#S)oKzpTx zij;FryrKXtPmnAmRuE}#_!&u4S9R`6!-u-JILPFenA(?W5I4AcB?ogTLOy{EJ9NlV z2ZPC`3z>(*jR74NAB{_a)h_AJCJShT3zDU_fC;~VrpIcQpjC6tO{MpSp4d9O^;-KT zlXq#GvQ!hGu#U4UbUFxCF5Hi%Q*CS1b3U-QI@$BU)7~tD<9WG1?!q7!ZC}ENauvk+ zna>579&o3;P_HJp_RVR#4td9AQT?>%hwmc(5o?l3ZaW1eTli>tp4;EISU|BW9AF_1VyhA(!Liyv-xQ zj%*wtVxH&D@LoXUfjbO3cJ0@zN$>SfI@uzGq%O%=d=-G5dyt90;pUi)bTdy9n zmOmN1(w+h0%eN^(_=9^M^bT_dpe9mYKrz}sA6{Vv#Rv7!tTTyzZ&*sl$iON0w z{sh=s8ZXUSTVKxfw1p#=Manwn=kN&nSOlHps)lVS|Ro zuJ|pqTP5V58X!G|*}~@yxP`vR4L)J?F(yehVFeGX3&n$I7) z*ARF=kpTdZJURxlaIP5F5sRr^!@;{w=Ncj_26z#0{A92!An#$LP?1a<^ob?7uN~<& z{%s51W)0???PTKFHhD^dNeC^B_5-tOro!F4zrDFMj|lj|o~(C1Q-TkQY=(YLE0XxY z&VdGT4y6{KNcFV)M#*PoThBT%Yom1^>MfWb{S#SU2ra-BMke$r9-1<;UIm}fNWa_UqBJ_H%K;kK7fWEpApVyuq18Vj4Jh)#76T3+5x^jK8X5kEaP4Q~| z_gD#!0bNp=$dwvRkhX8(JjiX^G$Zk$jf2)jDEO;HlgkpNqvi<=y9MWIi0LZNHX#4}mI0@59Tr51Z^Q%Fd9*`|<5jGc zH;NF#28XPM`6Pw&5c&f(+w=dub5|Ici96CLexb!8)XP|Mgq6pco+AoOrv}C}ooy(PMd*SjzvYqqUJ@*tv zZ31R3csu@3O^y%8?}c#Mf9eh!;PrBW)~n(Mv4OJNx&NGI(5HYLW-w*9oeywzgW#?# zlRvMW_0m3eMp$pn0h;0!%gvW?s7!k%cS+u4yfRd!WK;-3FPDzf$ier_5qKNIx8cd4ALQ6MSY1Dsg=$3EGxmS$767q=O;u z3&pK$_7dV3YtF4P+4F|&BeWdvrD@9GSt!KuB}y-No$1gJ&@fPfjm@1Mz7vC;$q(~> zcj4I`b+#U;4mUq6N?bxqL}I-|9h2ES!{gCzS(N|I@mvQG&fb!~ArJ`c=~h7qUoz6P z*x25`lXF8ThAM3Mx5;o;4xw`ly*6D1snO=f<#ZOb+>^&OWqU;)y5|_L$(i?Dr1Xth z&~EVrdo)+5346kp;tI6?1@-i;P41}HoPcSqUs4W4s`L509vrIj^%VV*P)*ryE31W{ zxx++dYX$#?LK@g*fE{4O z5#HQ@?oIXbD6SGHNAc~^h8UOdjeucml1xz6>0?EVCM{wX^j!+6~ltewAIu3c!;N~B*Qe0$d~JeWaMVdDNvFb8a< zme||hq`1d=Am>@*OnGhoE!Yg&Ku9&H&#hoUQ~}w?6^QZ>iw4!8*vNFhik1%t71uKs z0*4-3uG$~*ADd=9*`I(6CyW3>$U`Vb6ZY2GFTIl7XG`n6`trii+RFgp)5Xu0mA2v! zTJInneAK{1`f?F-U-yymCFmnD!tu7N@vm$Wfa(H!_h%lea(LP&P#05qJKa%!20CDP z8C*b$%-1Wo@<&Kb&|IjYbpZcd)2xw z;lckJnGSHIpCB;`XeiAAHW{IG*6`*4Q8{kPtPxPCOiy*FnDqeMe=O{;uE4^@{}jPM z+KzKniwb!QQ2n>U==!TPZ;CvLUEL6UfyTXS zvxD3gsnb~Hn`av#Ebzwo1;f9~ZUjrap%oa#3NP&;z77w%5Woy|NLrEn(QdAha=^;U zkp5TQ>t61GCy`H{WK=5C4x+8*6&1#x%Wy`m-7hCvfk-A4#s##n9OA*w+YrL>@h7~|POZSBzy;u1di=O%)S`dt5-+ezbo>KKO2(VsV zuwHwL{3=PK;eEK#YK~vJeD2S+%U&8|S67{eXKDcu8yyl5Ma&-;zs0ngnL`{6RO}g8 zQoxeJYI_Z9&i1qY3<&|qSQ^mNQ)u!I2Co-B(yz+>&yxF`tj@2wz~)mnhQ|kZAwQrp z#k$B2nlfCH17g(p*@DMO;E1vTQp5&{@t}YPN~)LiH+&v9s}J0B^@32NCME?_XBYudhkxaSym3q9y6N|brVX)j#< zsU|wFzqX2^qMBAAk3!13t=%#-+l{u=B#S`295}~bg*xt+0#o&{X%&i7OVI5*f{4hi zGd*~wMpNaA`SxBUX>new@w`{O|!j2{I?a6Y9IAx}ij_fKFL5usOLh16Ri$%Xz#s1@Z z46R@Ty9U(iNSwK+JaSQA=+ zl0yF55cXT-_LpiSE5O-Ou(z%s`sCd7_p*JZ0rVmd*Q|GWWsxyb-%O5FrcF`&}w!a>J|Q@ACRk6HC-cc4?ANBD&>zB0xELy zX=MLo^vY%Mx}m(xMpjSkJ$G|d3Ak+{9jse?jg3~9jhq1OK1wUM&_YPi&epYu>`u6= z^t%UIu879nqN0obx-gSCs;U{i^6r*XYjk->OExNgC6?<`y>Se9ex}him;pfq^CUnH zb1Mj@dtkrtsWc$p9Tb^9_{#x~UGR<^BTBs=js_qN>hlm!>UAe$igpodOvip8-5xT0 z4i;O_?IE$rgWaFqHM;bS%cmQg2}#S13t^y)%qM(uMZz-l!_~}UbQvw_tNirHga;%} zy*5$|SP#MYt@uH1`$5w6>Ane?Y5f-cD?VML;9P1B^t2@`2~Uxd=UGG@A(99hZR0Xt zg~|*L0Kf2tXKTVbY0Okvw3zm@0EkkpK^LsM07kL(d|$AhgHpm614-&{4v6w8L5QvK zR=iZw1$irDAs%{vYZ7J6xLK*9oeM$sa-Iw?+XHZMs{G5cFiqHbAsPYhI%*ddST2WKbYDf69miXT1&7nSQ%=#P8o(L2Z_Ze2Zu(Y3d*kkoetUf8IIkGhH#=z#|6k^yulBcTrxW%@&>G*h zT8l!`vzL=H6QZLhh1t`5`|-MTT5eIZd){^R5coHulkErIo6p^ce&tu0+A_t>Ml0sx zdetw9=v1Q{Eb%>U+|*hgEx=6w$#O~mc-D5~1&z7^j)#Jmgy#UlO=orQinJqF`nn$_ zpXNU^b+6(z_IlOG7QpCQUs{ZjvV)!7FV*BBV0jj)_t5F_} zyrZzJ5(_XY!e&2XjjlCvC8v~IbP}G-ruxb(HOF>_a+JWVLOpYF%piT>Wp;px$L|~N zGM`j#uG?kLXyh&gvS`YCiLVa*Q?DgDt0NPgUpI|jtLMYp{Tr5V{Wbd0D>$pkoAo;j z95`G^0Fw2t*{?Pk(XAoxDcIFwo@*$s*(EyF*-p7Y>f*KF*P#;#hqc}v^Tr4&q3{J& zbx)ffkH(T4Af`^vfV>makafs}Lohd3ap=g1)7Uk>4t{l`*0=-R;$|gbp<82wJjEfs zD3^>F6n(HF5SP=d;jSI}Xo6S+r*5yDo}ORFf&41>;1)EEvxZgnC(HV2 zllF)M)eg$&Zsj(7IY?XKnq{o=9DS94wcYZ6jhtwT9p7USWf)s>wq8eG zOKT8(G3*ur;Knhi`W0y5tYkEOHoWDVF49xrvB&Fgp*8)ca<`09;XxUG1Q$sh;T2xn z?rR%$Lp|%gA(_Q2kw*Y1kwHxF&J)miXYCcWFLTxYGM{Y_(*|t$i-ORQ2W(|N%g6JX zqMuYO%kfDWWC|3+EU;)7Z-nxC&=71o#dCVjaSH$Co?hT!8S#Et1MLamfG-C8(Za11 zbyZ5UJUVF|r4ABt+n!aeLgq|prc^eb)DAIch3{X)OwPm{96VYK8}!zLvezfs$)&ybi6>QsU@**K||+T z#5F4z0C!*?iI|`@t|&ZWQT5oy+yl}C!wJH2XH{BE-7IPb@2DtEJyiy_@laX&Bw}pr zcV>N_-+INydLI3O_jvXHR?YpN~=%{8y7@7R2|KdMwBFYTvbq zaS;ds;rN7}UoS!ER1496;>)48r$vA244bvR2o;UT;_d~1kjnk|?kk$ih5Pi44B^m) zjfCK+(Wz0d)nY>Pid(dpox+Bc_>-fm6qZ3QymNmJHTOJX?Q7+&{ntHdTWt}t5la)S zM)D;ZRLW3i6xAhQ!4*GR1H}m$(^6>EIQ16Fwe#5rkS#0dEB)Oc9ft6N6@IngAHU6+nTGr1zTe&}O5%lDI-AL7N@BU7in0 zck`|FgRRy@C2gpoRpHg=@H6CM|1VJ7>-oeFoxQdl#z(XMxkfb1*CvKe7%-5AalF3w z9<_3LM@Y7c?^>UL7^s-79i;Gtm@;;?Oeq_^)F=Cff?zhdJF&Zii-b`wBCX~Whnb5N z$5|Vs=Vl(<5J?Gpw}L{ew>1+#Jf%0Az;Q}kN78b4{*`(Lf577(8n&3p-(G>O#=OBp`KfNo38coL=+HLr_p z-ahJYS0$Ro=zA@!Oqi5dzx$3ZD}vH`01~DZF*4h@Kv0x>pDHx6L}j4#p_sQmg4Yp} zxAMLo5CbB4h)*s)WCa3tm%PG@wCVOG_b*rJN9-&>Q7R@(nSQ-v<~}{`gazi(ZyNhV z4d=!(689YlChMh{4EJYIl$}OOo~}3HUOz|L5-~CAE`RQ#p6)EKK_opAsudJ0O5RUS z5mN4#Z63c5)cC7Ymj52l?7xROU*)CWWp}QabKWpxc7~gVx^7J5hN?nWXR0pyJl@p` zL3DL^@YJ$s<$NszywqvfdGY*7WjrnBZ`RZ9%7K%!0Tiqe@XL@TOl!hW7uc9uK6P#- zOG+q5e6oidne0HpIw7aKlk%up-?O?=aDyr7%zy?>TZcm_0bD5{Y4soibK$^UDaO*iM`IDq{!E308o$%Cw4tS_wla1>0?_#?tBlRNl zD1WJPiFo0IoP5N3+HF@Vr3l^7@~1-0$M28Gr_h0j-=~`YqPXfsQUPHiHcOsjR7&*L*B&oP9B>GVzTy7Jye60oa zRBL~2_FXs*b#ia@(4W~pLn}ghGE@Fw80JU(*D;`k%oB(57bb8#CU5D#a|9R$c-^-^ z_8AsN%C@g6;@Bqk+6$ZI8HM8^w??wpLyTcu$zJ~?cU)0BFChq{GhFHGnTVlk}IePA9c3qq|$wpML+MnHdT|0?D zp7+4_QKhuqtVd-NQH&UKKBU}MmSS?}kb*i31HC;doGJ~&fW`&nGl~)8T?+W8bC&Mp z%}i9)s&E*uwqFa_lX1@IJ4D$+T0Dpm;geZ`@cu7EiBv>cl?UCXYTujS=7Gr=Co9}n z4&EzP@NQ|SfDq1Z_SHWwN=TCS7=(J7o%ezm6zxj<&B!v}LMrP5Vk5Xls76~qE|zym z3-5}a><#tl^&SSuI3dQ0s@@E(Gp`)mkexUkeCP4T+7zxf`*~l7QsVfwU;iMHc~8)#Cn56)~8&1cf!MBxF`n$orXd{@|xB*WN3@7`6L! z4{CL~w=8%lC^LMp2S;s39exFE2yi+nAiJ6S z```tQd6u+&75nAO{}D*1ZB(dPMR0A~w2Ibs;7*Hy@2WNUq2*udFldN(%cYOYuEeD^ z3PetUn|QS1(Bbc?%j7??-}AI7M(eo&TGR}ozeKufD5n){_} zY)z|DWCS0_eAEasK|;IXydBhi$)r`)VZVJ6MbST+o%VQ1uXnBD-~4s>@uciG%ftF` zj3tRtZ`L;@-*f?`;|cGVZqhglb7@tP(K(va)bnDzDJq=6LG0_Hn&&cTcLF=J_~gv{ zE}Z0o$9Vau{}Jf-aam%D1?ue!G!UiO>75IJ$KU;9YBK?9=FS%`eOP!TJ|*%oPpwNL z`M-xiJ$0?{;jK5U4~h6k88?%R^R|UGmP=EnrE;@NydhQpuhubmXn}wQ6}?93b4b|b z`NI*x5Kr=H!4R2~i97hSC=X9GZ*Y4fq!vX7P?sgdmf)vW%N4(Ex*BOaNtBoFmIZR& zs~8sT2_<;{YyysqkZQ@ZL9_F+C1;knJ8*di;8qg^c*t7j_d?!ovp^K&!Sl!074H`X zZD*C-*fyp+X`$_Nq{j${aQ>P}_^WnX?I<0D^8 zIJJeVy59Vh^XKxUE%q-}Z~gj0<`$K|LD)s5#{OK=39QFBscWB`h7DH1+qA^hd+3Oy zyf%y3V!97A70LeEJYH%;K;Yryp-@-g1`}Qa%q3U+^Qd-KqD_bnPP3-YV~zseJ#2A0 z#3&`>#M*PMQss~FTg30BuAI>{%#ZR$i5Q{QdGm|8Zu^o4!+W&*ungkv9ESa?4`pej zOrdVhuL`1G_`YQ>DUWff#atr|UZ+m~j#c0Zb?{5nG2em+XiAFLH>*2f7kV6BPc4S0 zT)WyoXiQ5|5YR!=saCCY=^&8-MFex%OEaYzkDnx(?O!q1kJ=^|ULPks zH8k-Bvm5Y_eo{x%aT0fBVdBEl+2FZqJuWlZ$joK5b_Gxliae`Mq$W7fOCL!u9BC(p zO_YivMI27|QI$^AFwgDkwFzTp1odFdM_Hn}bY^dD1H>Y$1<P0QIWKtVH4H9d_ihs?g2@ zT$qV3G`OmkMEN>ASO58qZe*%h17lO&Vy;-4Y376Tx{6zw+fc3ICCNK^H)vj-=-f|0dP3oa6y2_S;Z8 zGY!mV`QD(_a~MsIUxudDxShRzv2L6?k)Otyi%=})>5ERGUrl3J{`Hnh++FAR+Ztgj z-bh^hU#19d=cMJkC=`ksqLU$Lf<6p`p>X%GyTk0~c2{;3J6Lwb;oa5@0q;>%q`xS% zj{L?fYhC=(mdEYu4qsI6uee#A8(O;l=}zf-+hDzTBpbS@v0!ygy?<=}321nvP%8Wk z!p>^~GsFdLa|T~*+)-FdRr`EKsu$OTV| z*2W#{yOJo&O6m61mp82QhXCH6DU9N_kRy4fM>EpmzFQE@P>i*Y{;i=R@4>>xj|skX zSKNY5!4*ynbl`Iyl}o!3twyRki##}sa13HeJ*S5abQBa-&T7kS;E7HjDl{-_)*_>? zFq+t@t}3!{iYWRR^6k7y6!kZaD`_#aYxJd}VH&=D<6Ym!93p zc$MDmB}Ga&PNKq?qZ)&5BP0C0b!D=^TYfyq1UPh!iU-UFu>MaI`2~i4u_XHn=NAT; zCodw==#IDk(?Kl|tQx9d2^i!gd>l>p0T((o4?YQ9IpiRXDA>b_dDNPx*p|s|cn#TP zMwtj%dT+UrCTXL(Q$A*D1t&~PlKcPw0{{#$ya3v_)+)WD)fG%2kw1b%VW5}Ky%H*t z>1e?ol&4Ke000VB0iQ2!LVo}NaZ#wnQLw$+NgB|L73USMVD;ci*`w2_1WySy3> zX`0m{jR7g6+tHv0V4wkX6t8AJqLiLEnFvAwDQW{YT<=C-0s_(cPxKpVV8h0p+J%EI)MQ=N#Vwb}QSC!{i20H`&B^^? z(F;_w{WIYzg-29@Oe22kBcEh_T>HfKWklcP)mED)%mH{In;VTcMw%CV3a(1^CDd;M z_v+R7)3e$CAWyLZAt*~|O9)7}vLh~t3j=G)uRw(k_m|Yj8fSYV6qay>#`BgdoYL^Wx7{L@&WCW3K9P+oS4YXKFwxj3S2 zZ0cLlOsYQtBm~h3K6n?G00Zxqy^%AhAxpd_N)_@K7 z_WMr}TR=rSD26zUn_R)0|GMKa%wL9jUfX-QSCzQAT%E8}*FGv!P^x!;c$Tu^c<%Zb zh8AR-w~lH_aLqoZUzFekKl{FnKxL7K>!AI^tcy7r);2CEo?cV+;o2QIu zYLNJGOxooNn3f1(OrnOJqJ*BR19ls^B+jN?Xein$UV_P5Rp$x@{;AgP@F0@y7B0El zOj)joR2Qcv?U~o7pV|qi@xF(aPsgyXk9RE<=GjvJMOG(SE_eOI$ zgT30nL3XOs6>PCHzUC@rIYd}Ksu?KTc9{jNJZ-ctw@t{>b3NC1bit;S@D37PHhYp_ zna?6~z7g8;^_tP5-)G1w0$*7D=VXpXp=9$!`ToEswQ*TZ@cHoQ;Zejh1xB+|$2;b? z_W>7Na-PSA-Y{B8W@9G7t4-CX3*P8ATTSL)(c1w9OVjIZ}5beElro6gFvHW{xAq#M5j3L)eBNRxZ+mR(YK#S# zuTWs@R2WH|OZy6+9OJ4cz2B$9wuafpm7IRip=Uh<%hSFnp_u@jyOsjt-N{X6oVOMV z%k4dh+Imku9tBGT3bXA9S-3eV)9(J(rei@Zd1g7$=%dTEaPk{a_mvNm?pf(ZTg_j) z)>7pfOnI1#e>V5_i7GK>>^1C)CgKItxRTflm=bBkwsNo$U0%ajDOgTadO5oDSy_$| zB(eCF+K4gS4C4bz_Ays3z# z{mn<0JD*GW8iNmg&R0M8q8{o3a9M|`mx5=Hdv40Jr6~=bB-z;2zHWP~0=Pp22nYM) zct>oF*cg{3d-|X#A7T}`GI520Yf)9cpt5I`dR$8U1$uaWt{MPPnKpur!4o{g z;R$3X5)}G!r$3hHTrFf>>r^Q;&6NfwK%*lUj2aQst?g4_{BdY8T}_hMXb9+(51!p8+1(Hy8~uT@k`pPK}o&K`=Q1#uwoo(Tgrn_ zbV7A{#p}2zvaz~~29m#uSr0nR@@QLXimZ6#2uegqrJ9-PnzG$@)IrBuhE24VB#4xK zLtKC`!9O_`tGoh{YC6;qjm7eCJHT#^W zJli`*Z1}W~YUTmtld258jXJ}mmc!nc!)UochB2Zli;0gGQBZCbsRTm+Pl#Z;x~>Du*k#|a(z0R21z7taV85yZ~^@IId#|Dh*}|HgP$ zF5{`gp2+Y8ONqFk1j#|Yo4JSJ^t}Ra6Dr6@nJ{@3Z1OZ)X<@}=nqUFS#VTeW91;23 z*m#*EeTFjMyh>&3z%PTmT)NN+{`Ei3s-DN}K4-}ja1zFQKU!pMM=(SV{j;%fHU>a5 zk0lmwFrtj^6C-EdH-+^ctlC8Kzk2>u(BFqOgUDqb(bee98jtt%HPukm=n>12^NV;o z^<##o7UqQhm{V=@ZAXZ8^D6lzva0_zZz{g)kwN;SYbuo|wQPdjZ~lVi*enTO)RuDY z)lO(;H0X^%9E<{tLNzu>pQLr7<%5hU(%DLXdK**iY%gL7i3)-zl2P#R;TI<2Wn4bo zn(+uat);ZXGZ;4dhc1DylPX%%u3bKN^JE+zJvOWfXknqf$P~H_CT+xi)9r#R6%{Ow z`PQAstvSqM-1Ra+x80Fy!m8i^5SDJ)b6QM& zpolPc(2xKCCZ$1}G&KksRR91EI^eg=zyv{As)S5r87Hn`eEPnszp)FB zOe}IuLGz+^Is$o1H-GQrN6NR9w|!x^82rFBut17MjA(G!yS87Z|N*NaE(T+5DMoi9*m8{7ye=0UErrF?`` zZxZJFzPzI+kWa_p2Zbn^nvPExSK&6JIzL@%(V9@fPgTATfpVLu{FZ(^`RF}WhMze& z(Yf-GUM_OjRd482eaDPPRDOo$hT20>JZ)v^X^ zlEEhiBx($t%$5_|a2t+zw2u-o9g;*b<+p_bMLhy5EFl5vOAY)8=9rWpS=uoHEHc&P zY(}ca2q?Cx>`nBj*!WtldbjaiYU85#Q!d|upbzggC~)%%Pjk>=O>l~kPXR%wXfGTF z#1&-Zv!`M6p6)%z`JNjQXAx6GLlXmrXjAx-4%5<{Fe}wIy8!Us8q%$~_?{J+ZO|G0 zUd7f@9P})q>JrzQ4IBZSIQZSq1Gd$FLsdv~JO-kI6?Q`rl2vO)GysK&H_}* znflgeP{#LStXON=AdpQI*s!C+yHPazedQG)m~UtZM(WK$7C3N#4EZ&B5%7}GG3wYg zzealfI10$|=sKYPIIgOfh8$^6c1ciDL|H5pa1i9u>UC7W&U*b6 z;d*TAy9zg4O)}#aa_qShjFnBAo(2#bdF*6*=kLP-8#S*ZH^g#EioNP@190kN__I4& zOs|c3LG*v0C)O692BUV3|H)%`&vp4Rt5x3ue$&9|k!~qZ%vd3}coPyHzhr4eX^?{Q zL!f#)rb`UgaXC8GTh5?~*7uj5I&{$bvN)Q`eZwT5y|Rxiv83RHKiPdUcvUi8D^6&5 z`2l%7BEWc~#u<6p&(LEgtRhwEQeWd5Z$)BY7G0yuRq3)GqF__v(KSD8W6fi~^X zKaWWe{l_z6Ae{KBbiTXCQyp6a)iB*Lp4 z28ghr{-NSu1(E;m?^7WCk#kAbB4A@u`^q6j#kD`w`wjlFBz7-=$ymwT`vene;e0L& zg;)#792Y&?Pj#3m!#<3000Hbpgb`vsukJQCoz9iDg&d$>rNzwa{K1AB)_=5J+7(@=WnF_P$S6*{b9U6IB$}30aIbY)wM+h19{=Q716<#^cOeNeR_W z?rcTtK~=}hcSE4Xkmj~YAC%$wLLKcQq9nwV&7>n%_~hsCT6BlpWx2h}tu)aS9&TVr zj7Kv|e@c_yRk73bvA#LPk?6iuM@#g|as+O8D1*EGOlUFnWjAFo?)jZsW5>O+PU$|c zuPMS64OC~fxSNW#rCQr+=G(O6zDW~jJzGR;AF|3+*j;se`>tvh35%q@Ds&|TF$~s) z#TR8Bdl?9zx|v?Ct-9QY;OKzqjK_MmIrJeky{<5o;Th_YQ! zy;)ansm1E={iD#HzTq?adon3S$24IuV>Ye@6Fa_0ZF5Slv;2kr8H{#~B{@Z0<+~%Q z?W|U51qCWI#x7g_nvo)Xe#-T`YD3<7&{Tp_ifS-x3!AA$;%IUG`aOFR77zi#8Z1P zxjiB`R64~L*Kj5e7Lg9;Y~DcZ!{dh-GA*-;$L6qKzumI`6ot}msoa$NPLxU{=1bO1 zJJ&ugvhW&;{?`!v6q?pjp_8#n?H{msAqFFv$SnuO3M`fBy^a~_mJj;=+|-5*h91Q} z$w}N@N^T?xHpvQrvvEmhH)v&1)xP2j#gwXv@V!Xo*MQ5{HsEr40EJ2e`yJ+&k8BMJ zhNAac);cGJSC;mZ*F7WyL)HOcM1NB&qAd}Q93i{RMyC+){BUSt!mVx5>*&3$sxxls zA#3aX8B{<~HB2aCatw-m{*uAR5u8fR(vuYqR9C*Fxqj0nsG@q00#H@0cG zwLm^5ItZn?Dkb5*ro>{}#Sx48Hm~%Kf@ws2y%{7Kw*>28Li*~Ljt~1yjQuM~BGj6w zCeCjQbwSaZ$WJY}q!lC9qLv-UJpi$vCpeATuSag>hrWg<*woE%FwF%LxH&Xa(yoNC zrK|RpK7Co5qoU3#_pVNGjcWrtWw0*wUleMED9D{argPere?}r$OtPf&BQ6XT#`I(c zfU@+6OY=A^P?=7Na8@l03jt|d zHGRl)iYclEDLaWdy zvwqicK-5Q17&me>K+*E%4K@T%P9w%!yhTZAW7G!~LdKg4QuB6=?Wmo$ClxeVw%n9k zAQYR7{nmGRVYeY^MH1C2gkfH!$M)+8H`91{vY^GhzLTywd8FCri(qk7hwXi{jwwjT zi%9RZgrjqUNowLW98anlNFW_*B}xG>Sd6V5gZa^zhiAf)r&d zs`rDev*49Z8e4!BUI+v^N{t;>m)Lda2QHs&fpJ~QJKB5FD?@{3VE6c2pS_=y%=(nE zJ%Y1K(Kn<^9OFLg~y$fISpNp_((+{H`C#86sth2$56M>#!A zv=kL!6+lllfP^n*$QXZm(t>XI9?d@T-qD}?F41q#@}iAWmypItW9W{b3#BiMIT0Gw zl>a28j|lx6&?1L*5{`iv{ai=6SJ=lKixcQ$n+#Iu^0 zk48mVPyP(v$>fk$rqku?5uCSa2g8Ql$2fTw`B|{!Ob`}T^u@m@q??qgTY34BByz}^ z*}aHKbFWKItJQyPq8W0b@6`4btz=JJdGFNqU%)i42G zcUqnX2Y6ibxU)FR5Xo_{?30}LXP_{l7}mU@=#W$c*g=Hsp{4+}#qo2UHiXYmpWV+{ z%E3hZ3b{h3c&cY_aM|4T{D>rdk3+Oh2PfE3DOVj=Td@*DmpjKr+Hn8@oVsN@Q@tvI zbCeYr*$i*|Y_`C<=cyD_|>AEDVS3;jG=`(brcH>q&r)J7#m;eEFm^|3V`sj9Yx&e|mFx(P4n4)PY z4Tqk~GvnIqsr8UmIXv%juy~Kvi}qYSh0|mwna>!5 zv1|#Y{K;ahb8(R$H`Cn(d0&kOl__scR&ry)=x|x!fjgXY`CAxysw-D3fa5rqcJnb z+KDB50(HATf!K6iN|dkr2xVHuf7q`qZ#2A}<*FP{0k=vm>nyM_Axh*AlIG^7X#sYmE{&ZTiM+9+l0SonYm|PDn=d+cdxm>Tm&h8NfYKdW+@QrDE0w{KPn?nk z)O_oDugVyZxNpjI9?%gJ}e#5B3Nzs<@muSSBM}(RdsRH^9a7MYsFm( z!Fx`H8TqKb{E&yQ3v%PF>GlVf_3L>46cJ@S{pfT`HBbJMfz&UBi`Mm!R=KEpoKZbmbO|Er(hznhDoWHvaRA|g0AX9OP=z$xLRj$1Yu#qI6-IxVZX zAN>hntsD~-Y{-!qc-MKp(;P8A{8oHSU_%Jev3*#9dn400)F3@spwZ*@cj6BRk{SEG zDF0Gr;LP0|21sQ5|eYUF#hwnj2W zAF1){T$^|^;<$rqWOZ%ACb1O|g030hQ)*m5P}o>E$M=yMiqJ_Yh($KB9WM^&5=%|J z8Nd|F>*^3Y`%a>tTA-cplfb?Qy*=HOw*@^nEJ%imU!g$2n+^)v5FqR0JT<{{oS)b9 z;n^v4V5QtO<@*xV@^EPM8+B#!@uy^GN16j3j_2OUmVFYCp5CZp+#&F{&<}PTz9M+7 zZ+1$R*R(`tneC+M_NJjo1t$4;5Sl)!YA%@6q(%pk7I5i6VeEdzOl#PD(gLb=iCKm1`c}l=vaI#C@(0O1TYQBM zWqPrz24KHkzh9x>2lj_lAGXyP93|~!K*8#U)@bJh@-xelI6=q@pZ+W-8#1t2H?dTO z5iqfe+e&C`L0UdOLNSPv`|sB$hTJfY>(GL7YEeQaNQXXO-POTEI;RIX?n&JKmA9aO zmoR6Ud5+%GCSa58?lVDjmsqeYZK~(z^+;%0qXkZ&%;2P5hD4#pEgO z!EjSCvY!+f`2N2*sTzi=)KHNopMW5naGFy!Cq18i6gJZ|bU27z>UfxDntx9;GW*rH zw}^qXO8Gb39XC+-CUL=Y`IYPIqRK~k!R&UucNNDLXo~f*c}AkY+Xl6x79>oP++nBO5B7xjxMSZztX*%aM!P^G6Vvkr*{CKA9V(%iGWB3Q-l5&!EC zO}dK@jrF3RPrD?V_bqH)Dq!d93=#Eh`<{U~p>Jq_v=Pj1RvP2iG7tC@RmHZqm97XE z(vq{7Cj@q}GjGSp@jIGvRL6V`?y;Cg{M`y9CK2j&lNbE+zp&f=`(6XrzQV-PFJy;g z!K`%@Rmec3DFv~|Q`AJoax;@81|lQ~)lj`J;NOxhUA3fqgz(sQ50rF`q<`>o1?j{+ z{qon}8rq(5G_5rRKwypM1fhf^3?`(@=CCf=BEoz-nDXeLo(&<67a2doogMWqtiS*^ zn(P1=)5w7$Kv(yPNh$W&tRmCw^T5oF-n5=gCe;Hp-AS>K z3=g!Jf<3<%E&W7e%7LBAQ0-WS4s8Z^@?%$`H82@e4=NzfPOs%y(I-MF2tEH?B)o6ZTRdx09Iacbq1&=Xp{1}ud||-0Jjso zg}L!yCrtjgHXm-m&s9AJidHC-TZE4oJ2V_9WPeo)VtBVPsj-{!X7rDdi1r=ZD`;>Q zK@(fGzjrIeavb2s$fSI!&)*R>Zib8Sp$ArA#=kvGzfB!Rx{=x)-TetKrZ^k(T8Auw z`A`mc6&dOT_HUjs04imy*joIEK{_yjX@YfD;4VjTRt|zs!R6S%?~qrRBLPA`z#P1% zI}9GGIf(?yNNklbs>lsXZRZTb|F79&^*3t2V}p-MgA9!=dl~{>4l^ytXTh(yr0E+{ z_!xw{sAYPt^6z9Mg9nckBoZfbi!V9X)<@XRR^+QndW8WlXcxm%OW8GvM@_c4-*7cn3HnEm_7 z8F4)>-y%T51!7&H0{DA%)n+p!PQ8{cqVIMoXBaf`Bl6tAO8-4UZ{>g7z^Adb?3K%V z|KTtY$PwvEVvj_B24<#DvG{#H%io{O>DtGF)^%{U%syHpiT2Bk6B=$^66CITv4AC7 zRi#|l*zH*1rAhl6p*G!G3#!-(jU152=hwJIGL0~Lbw}5xm|gkg+7)oN%VA~}nGReF z3KKHHjx22p9Bmjh2L$f8ZNpvhWqVj`*krA~)=nf@f)uoO^5Jp#%BM1y^Mc<3KTAb> z@Vsr=YPJr&Yp#ZeIool1D+h5#xS<2|Y;djJG3}pUXt=`*>vW7;03{Dr?FBLLh|1gP zxW>5W0S?8De&nwh|!8JORz1e&ObcK|;_cIe!gnQP?n%KvY4l?&R-fEG_G0Ie7 zl!^iJOz$Nh8VZ}>y>4#s?-!WEXnf8jHubzJ`c~@2+zpPJnJ>l6uqU~SP8zOj^o;u{R3WXos%q zg-bG1qRa1-W9{b&! z;_peZZc_Ieo65||^u&dKN?G(&3hMI%f$NhDiLWkp3(u60jtXc*F^h~JO?c3gJY56Y z_x2pHa6Bf>^xhuWC0}G`i%d#g!BA#`y`6IINpeN*df_j}I}zJo^G_I9Bu_~Tow>r%JP6{= zoEy@1hjqfiH2$Y2vz{tjj>1{Zt@lDl?zK82;q8CyQxT-iF%6&wes+9#rky$rdw7T) za4t}bf2D&L*j+2hIydP#t8stcFjG*#F@fbP;G22aePFFmzz9ilW1d)Zy$TGm33p?e z7c1E=)MC44hFSQej~0aU<3LIA?p^VtTOP0*IP9HBwXLjDn~o2ger_=z;B2~B>0*MI z_%;`%2uuPdW}nT0+IQ}Ph2CovBr9IGq+Em2aml3wk-KHUhedKhs8&+|y+7) zE*E1t7`L7F@nf*?(?U*OnKrrCm}26BE{;%#G9+geXiOCMVqd97 z>P2KakcduR>8A|31e=O&fnkN%kV=S@k}i!&!wFx!#vP!OvnYv#u3!+iA;Y2tA8Eq( z_v-csP;-znR_#(vtPu+402zQVv6yWct2v`4m%+t`d;2+r9`99}w5e>c@9M(XH+oG34Ffl`1S8;M!kvF2#Vvv(CeE*0k#75Urffwt^OG3oK@5+=*s zSPUt497GK%so!ZWI+?2LqwksIUx(cP25`A=$KxZy$(zY;J?A1@8b)@wiK19gNWTR`(pU&~$z!0|~H4ieaAtCVi0r zSmIyS+wz%DHJ$S*>LWsc1A6)yOI0T@e8L13SxzS^X3>y@PR*|ps+&d@1Xl7RE%2_3 z{IS?M68&Bm37hR>Gf6_G{N2m4&jZNhc{_+&$2XuxNaDg7c^SraoEq{p-)iQ8w^ zD?1Q^ir^m)BKj8PZ&_PEdd(mIB_0?f%wgH2U7D5gNUe*RpS?GZ8z@UuRtR5z(0EdL zL2p~}=*?apu^P$&K2(fVuCu*6Bb50^Iix;?8mF+AkS=-YVn3t2Elc~l9L zha{X+hB4-5g{28S+sS|`)e~FV z79kzyb8uExsm^L zCfi5*>>>$K&N>d6*2Nr&u5dO*SxKdI`q@*G3eABrZD3S~#qljmG0Njn%MaNM{If5c zQrhKKJw{s|Mf!WiONK=;xL|F0=#vn=8Zwv+9YQ^jSE~Bqx9zC0=L%iTpjVQ@tCYbG z0MXE96v0YK(w|>z@>+yUlgzIG;{ep=teZweTiC?4nL;sZFk~EV3AvVvj9;~-*|*!? z*i?SlOFbgPVS&45q+2xo6{m<&Q}IB^ zVg`%oboWSl53mo{T2@$=`wtqZH&VEN9WaSy!!$_R0L?grhfVgP1tk!DH@vHb$ae&6 zxSv2xuZu_vXv{jQwX-={b7ca9k|+$&V0HcbZP|?|Srt@HO2CaznwUMC{Sh$igVc41 z0WqrO*v*sWd43FakG9@AuJ!K@!48tCI7C_GHJ$J0u^zxg&?me%+()V)*m`Y6^)13yp~GhYco=k6=w-k9Cj) zQ9qTx(}ApnZn!?zf%--&xBYv5XFoO#y>IIR!ZHH+%#|Zej2u`Xkjxglr#IZ5UCl_5 zN76O$LTJNGCJ3@7K<83-d;gjBX@CE6HZ!YX^2En{0~Bbv%X$)gIbFXyEVriXzV6&J zqV|a+o)5iVz^KuC(EUKk@lXpum%%1#-s0uY#xxVMnI;B1sStgG;5BE~KN4fC<*`xz&cE=)8imhHmVcCvKS4kiwy%5*FFBt7*u^3 z<`S1EP%`=6KpBb zeOB=8Nz95L8nECcdnCL=(<%dRK6{AwFkRvGFc!3KQ1Rtx*H6vgI2Yg@5dH@u9x~pq zuU9A)knI4t9?oKk`4=D-A5QK}*b$P914?d_sne=kYH{VdC%05EOdcZ6w}HeaNF(q5=@#`s@j#C}a;`rP(v%gsGDrt>CiO^8 z?Iwo~u)fEm3P_h%cRS3>rM%!k>`#0Js<>15?)L7sMu>)Ppnum2O zgsev?uE4J-eStj!sI0k{8x0;U5!%a(BpSXj!5zSz&^<-;Hf((p-LYQ-6P1k$X8Ynf zzV05yXe_0%CDB%UiI!~#s?={9B+RobxL{&P6Kgwur_>zK{sk=N_a>Ya$3NzrQlP=T z^iV2TV3zsX8w0@2E}D;=PK-yF%6)*d%YuLypcY@={BsNeOiiq;EHFy!u$ku=Q10r@;+KG4C4 zKKVsdduT13C&sqY{W)pAq-Eetu)a7MK={o3jIExC#gRBlj3?0g&-rK8%{71Yo^y*_8MRbQ5v{*3m>9Q9cNTM}DsV)J*9yhq$ z@88`Yyi??zA^jdP(x;mm#p7l3mjNBn$GdhSk~;pt5apl#D5jM@2DNQ)m-C2hx;M4! zq!P&!iSK@ZC@$ZTn6`>8Zt3?xNQ+7QSJhpARuCyrFZJL3qV32fBP!6b$g63>Xo;wi zd)gWRxjKTi=^d0U7;Q!2*|nlAq`>YOo(oOdS z?-w^B&^bW)#s8@Fp}WbCVUb1^T~^x1-otYWEssC0gBiBNrPZr-L_mE9qGq73!6gX` zR@HC}FJz!P^g9cYo8$)<*%X0cQ+vc<&|68E;`N^H!q|tw=!|V%LYI<03g76Fy0|M) znujcZB&ndmhODH@*s?B6RMo z*%ZNt+G(9JZ6S&b)I&fd59c*!&CB9rN`Kruc9w)$uW#A}-^90wkak*uAh=w_R#bN; zYEXEByx-@yIG{MpI%m+VEKWD+X%3Opp(vWfLc z$U}e|TMjDGR>AKiI_pLSh0UiR<;OnOg^}fwIq~yp1>JCwNO=_{Bx>1{#h3r|7&K~U zBXUV;I)C5-98!XAoxK5~!~=k1%{ujurg$U%pf!W73yimb?c|J4XS<+kDI$flC9LmW zJ&&fSx~R<`m;lSjuSj``zZYOu0?%e;#IcK-b#UbBpvMLq65hMdy zHSCG1mN>QK6sE3m(f9|lSDfry(5eJew8>p~wYDZN*`?&xww|AX1$o=@K->8|lmETN z!`0%D#NSF1g3j@cqLI8yV-tgFD+hMjQT|#^W8&gwZ<(vDN#$ne>-u7I3;9DKK@9dB zn0pAtS5W`Sd9y9ed<-lV@P}gBM*IS^y&qjU;Ux2FJ(c_@Tl>xwKQvatq~F}p-4@uY zrRyOt&Gx3u3Hxb$ON0OG=9an0kv~O4V?uLMwYwHtzTD>|H1s9pO$7}7!K=;fjk2ud zlPMO3h_PmO5_5i0F)vQ1tp|vb1)6+3clbjsGlKML@}lBy@|-==+`L{r58HBb*FLvn zTwihhZ~DlCH+tk(oObD;Cz?4#abVw9?rr=*F`+bNT7$71r;>#ZAgpGgw7^rq{s^L- zEHW>2yA{wt;#Pvx$BO?c#F2tvo#O`PWNQ4LXq6HkTs|^PRQ!T@ao~}OKqsFQFuIU> z+$IrZ)os{^Nr}WN%)ORDAv%1EIK?B$`uG@`%DkBJun!`|Kwzogk5AHEeIBSCPdqC6 zx&cN`6II9K0JXgYhLD0)R_kJ}v}VHKDW&Y3RL{RNE(=$dS*oe*d*lRDY5PLmjAQ9| zec!z~Z`9S#PRy}WG>qFG6p)JXiq>o~eDhNXu5g6$Qd1!e7j=8-TcHfvf2iaCIh2mN zHPjQ@Dz=u`wgXp?U<5vx7=sut=OylR-k-28EnZ0&39CT{D8cbXfuD2TA~ zl>K;lIJY?%aO?al!qV!%)%T42-T;~P3CH3BcWg^uC3O+*)*$7LyeNBd{bo)(cLFw1 z)-x&45N|S%`f%%Rt0&K6o?KabqBQ*gGa%IE5EFvVm>y^v8vp)ikGTI#gZ(pT8s z0jiP5qH(EU@Nu10EzO@HhOIcWSEo1&Iv93(bmlXYPhkC8qTaeoHnvTqpv6hL^-V*H zVet8<&DIoj1(dSL;FeQ5BV_j^@JAH^y{xh{OQqY*n7%x3HTG7^lgT*i4Ji+#I(EWU zh_Q?hr@4l#?5FrMp^s%gJk;L{5GF4bgkM=2D*mHNF0JePTI`KDdz-S~{Mj8d?Fp}> z1KZzJOH>)I3v|@1+f>L^yE^@G&g} zdC{dWkNNZ4hL1&tgS6MRwnzw%m)0)bi;`z^RkGaMe(&8u2xanM`}K+Y7rpGcawJm3 z7ZJ@FEvX+ZB{D=+LQQV_b;JK}JxEN1<^_WnNv;us_i0C!R!gH6E%NU_Y5@LB(nD`o z?&5%Qs$bt2tGZg_Kvl#Z@UU~T#Zode__!T%?ShJgXyUk*a5pecV|boec%w#7kM(hB zhw3G>I(tnLvIpXpmo@_i{>HLSkuaOgWQ{X$!#?~BnFm`#-m}qY<89>=KePqX#80DM z#Tx3zck?Hw$Q277Znj-DyMS81Wf>3&66riPI;#!-99OfL&N%iF?6cBoZs~6F{XJl{ zd>0BpvesI-hx9mnF09}U6DLlL&d+k}C1BYjfy#3MD2>*SABgh1p~c`L7gZ;#)~IJ? zBBr%Q-8^`VvylQE$O z$sd}Cx1PQFe2K~BjooW=GT8x90*T*i)Vm~!y3o-~e6x8hn$`Kp6Eu7?Yroby8nAa1 zBc8rGfN2MWLZ~&NiWa^a*kJ5d<(+q8RQG>w=rHMW9nf!f>Q#u}Wl7y+o#k^czbr01 z)fm!wb!n~Qr9MJhjec||myy>}0&^8-o{ir8ZSy$7D9skD&qsH(TB@vHQKy zZrQUbHkM`NAw}}nAcDIjBM#nPhBhku3}duUpiUsfX{kJDApzm z{fHXY^s}{hbC^GH$jv_kvWkDjV6|R*iKL4mN34h7#`UXX|Ml~x@ESO2qN$`P1th&Y z(`vzcdt=>*r-!h84_H50#<)XT^4jD+{9f`*Rek7Zf zW+hCH$DKz>lmk4j>pVOX-Y!}Uf-){KUc?d&tuED|iFMDm|Ze3#bzx#qb$^cv+qLh0!{Ni0!68}t__O|Zsp z{L!ETPNtan3(D17?@KY|(<6kPq^dD1xi?RT+NaTXOGvt%SBIm59*zgUbrRfl_Km9O zjq6)M*!lQ{S+ zG6e-iJ)W>CdQ=ir&f(7k^~{cW+qjWj=6wu6ZHv=es(e0ETcF(4X@ubov^QLxv1HUc zadv4gwqmo>lF`F>y9kM_0rNYcDVHH?5z4Nm*4P+$4R>NgkYfWYGlrb7IKs_FjRBdb z2;lKcR81^$_*QBwnxyHsC|5(b%^z8=bW(9%L^#Y@+$?)oeNd! zl1948g#jN+N(2AFbD0VNt5<*{ZXE!b%U8uU7XHRhQgDM@VBjD%tl%uwg6U9jxxR|g zhcfAb0Jn;tAmhGFRs&$dvxBJ&=(+{``Pj@XW*&$g1CxD^LU#&2M{SOj#bI%tw){+q9O(LPx)4Lsk=vXG`^y{ zboD&3j#BSg3JwOt>*%J3^L6XyZ;M*j2de-S0D~uqm}rSUx)E5JhA@+iWV5dTdh6?J z1dKMcM+@7}49<^_lv75fHybgC(S2b5l#5^hthW+hhE@Q_W=??b`&+_&EeT_rPx1fSzK23?{U}HNIzFG}13CH!nAL z7xxHmGYR_H{D>5?TSMj%Wnde@>`{XFlE0UaS(M_YELC<4%d%5ggeNJfYMQ7viAk`K z1PkXt=eM2LbrQ*gou%%1s+m1PN0i-~Xkzl1D|aK=)C@r70HLBhH_BdW@}!=-(oSFl zfyWdkPiT@e;3ah%3;N<5_*Ah$yK9|x6~~*q&2@+D4BxCN*z$I|p7)ztSOsN)MZwIC zE8pkVX6Vn&MilkTHXDT&hLDac2yg0y=fFak0AObdYFrH6?c_xmK*O8!8Z&t?uKFBf z>8yKg5S33WKWOK@Nt0u14bscTZIpWMc1+N24a&x@X#xM=P>f)W$208hwPSIRFk%epucIh*(E; zNxKj7(RUX<+7Hv^q7!7kDx-(1ng6)-{a!vW5 zzYoVVi+i!EvJFp3M67ezwo8N-oR7pG0qd}K2C@*FMFVMCM=NT%<^Lecg-*h@U`S1T zIx)8{n;o=ZwUmPMF%nd6@Lys~3d68hMijj7r|?v!JptYp9Pg0#cJxk8jtu3AEk;8H zk86318!R+`TTgdq^u1aL5aZs!)lg^dYE?8G$HP!C$G{o@88?Wh)&YN0+H-_N6=tR? zHog4C4mIwG`?rydHP!K<10!B?ItqB9;H)ZtMnI>A>$FizUGPj2G(YqqG~AciM>m;3 zn8_LGJr8_Y(mtAf%wy)X4((&zDq4Fh8d_h0GCWYg>7hU8qG$+mTQ;qpDgzj z-iA`geGl$uWEEoV{B~YfL}RuDZ8E3f8nMlPsB`EjVJEDiT^rYKR3MYriw41lO*_3@ zGC!~mlS0%2o~GTkC(8=zFZBdi_}`EeK>-N8XQS!oKe&?pnOwfM8{r^q5@;JZVb^#% z_zle9){j}R#VS2JFK?Bz1P*P(ua#~qti{t~JUDrN)laZeZI=Q6CVHnBH(et%N28KI zqvDdhZOUEtf5(*B0@Y_%aLPZtJB(%m4pvI+RDE@Ne=Hq7z#OA*=p9&C zMX*HoM+vj{774Ea01N;DpK)mrp8x<)j~t6bRS1I1$nEKr%16d-fw>#+M1m@2ZdidS zG+rxnYSoD;l2tNN><93j=9w4G9hJ02eS`D zO^ywFI%xJ+1u$`mz1V06lQm|cL!=D*K{4i$P zQGd<;T2EPTyRe=d1c;$r?_4i8>xpDdX0J_I5<7(y6NFo#-FBX96@kW` zv4izHGJY!Im!K?HZvqDek7Ew>_@3%LZ6_-Zi&Z%f`7wHgk3eR9RAth( zHxqQsrma`WT0w~m0~5kx?b=%-DcK0b_qU=J2|V5MEq|skic1@H77>fI<)3%b*nibr*t(g+DxzEOe1CDiYWCW<(qBWPG}U)UinE z2snAE;^;5KF(9sOnkgleR*$DNq9%VlY0>m0@y_!WLo}-(-Xihw!{Cs@kb{rv+usi; z+Y5G@3$uUsNqrcc%l>|AtC_n=Bk=h(nwuj?i55j^lGA+lnex`XC+yTqtbr4|?=DW7 z1r`ABS?vhx<}+Z1wRnd;S@~%E@@dWAmB>3}1lpJTA2b9;N*&IGceS#$B1i*X`{RcM9AAYWlP`@&9n>{>ec9fDlvt|qA>=_l_-fmUO z!B?(;C3po=z#H>&#><5pWkI=q9OyY?we(=&*|!8xi=+h%Z!qY0P<_X{glFt@fU5Ovc?b<5$0VH5*_AN6;DV>TJ42_($L`r?i<&YU3 zi|2&#Pn22pIAOk4B1JvDNoq0OZ|MoDow4)a*V*quwV%lZ0C^e&-(*+^5LdY6%qz4H z20m=*5=2tk*pZZ0caRJwK!x>JelOQeeW{o?J{7;_jN>TJB|+reoPBS&&&7Sju`PGue=OPQ2uR+bna1NIze$ikeZ_woB*;@VBQoI z{2dOja=N&b;e2{#jRfCjWZ!C^XuiuER?K_?MkNw8=^Kepccxa?Amy1mTKi z(vwzA0#fT~MUfdNnw<%w^VB*&Rk(T@tT$Sxcpbcm;~9wFGr<-T@<^gWMQ&njVZ(VCNS_*ILcA2p6UYd}Nf*e~@5L;0k)VOJN+R$N|jl zsA-1KQ{;&l`CoUSq0mQ>2rhMS4@jM0`rgyP7X(JsH!9wabpty1A@H2o1lYUHB@AoH zFqrT+GK4qSXB0VPkXGMQ?r$)9{>E#rND#|6RtB2U6d>p2QiSXZD?>$j+eF7VL($uR z<88Qf>bDT-&8j8-nPTR83|j$O;H1;%x#mCYp_#t0M-2>7yZNCxw4e4A{BD`oDWLzL zB08osY}cM9^#4q=M^BOXY$v=Tc9Lv6&wLUHAg{(b_F#OKVhHsJ!I=9L3C;7`Vip(u zBvzI9O5#0JD>}C)SWAgJq*FWy3vP*S2~`#D9YSk9&8O?96;cMgXZA30%3bw@;2ehs zj{k&LtQ%}vKqFg?8c?kL80aL-Gn3D*a&;I$vP`Qos#88V3=4O(QhUhg!u-T+_8_ig z4jBpVzcquUAp)KmjsU>M%YzQ>_j<#f+<^D%ZKeq1E)EJ6FUU-b<@nsyj5~)6H5*P2 zX;{9Tdv7l&{TaqY2|?>s@%P;5sHm#2Ht|f1yxpi0rW%GUA*)Ny#m`c4_kz%fTHK8z z6TSLcSO@gw26CGo_H!4oXW($T==L~ZfoG1dMTnpAyT-mJ^qL>n{cJ2N4p=@mK_?e& ztAI-N@Eg;DhkZ&mlJ60EQYzlZXP-e@0>Lv8wX-BD`3Fdo!cjeazWHx@)`c)KX@v*9 zqGN1vKRqWW6n)EaE0vtQ#;LvDYef_%EEuxQF;>+#t_~gq48v!;) zU~80Ezb(?hC{4mw*{|6B38gMeA$bwS?NIwYjkZvCBPYs z_6JlbuM{Qik+$Oo(rH+@0M%nI>*l#p8zL*$G%?~^=Ob7V<*`Q;VgT$f* z+rdn{du3l9X%awg%QyZA+p4}0TUU_j)>ewWp&3|& z%WM&Un`=QpQuQmrTowm7@=PH&`Y)j6RYvI~*Lf;N5enwKtMp4KW;7x}#_9Z71?q}* zBBK;bgwAm9t}`nEfolO>k9lF(qP4=1;=|5zNl`*MJq5s)dha?>Pkhf+v2Tz#Xf@rz zc(NB~g^#O=@(}51bsMkNV1n7XnURdCq0e8tRn>r;c%xhRcNC^D(RN^y2M0Tshm*+!)GITDaUux6WzGh z3R@ik+hw*RU&Md$c>wOeW}K9%r?t^?j$mIwUtoq$ex`_W(-q@IYeKG{$nc%~k0`{a zAE^AVV#1}}=QV^(ZbJ#Lck$wZ{lTlg0@G>nWo+M}^{7Q56x&7Ydj>&kg59X=336#2 zO|&GBnNY)v@IYq*t;dUc$*dlT_+6k;{EkVAulwzQ`uwvXJt8X!d<%*US3Pqc^^F6` z%J7dC&~BSbpHX?ZeTnxCa5C^I9UfSP(JCjZD%xNl*rL{*0Q6p|@SM=592ENhU2+QW z7%=AE|GGWHf(=ml$f^=Bfv_CLw8Xw(onK`_b>6~ri;=4iJ9*cb(>Ip(ma3V_p{}*4VapJn<$8^b!6pAh>rnFNq#Z>NxG_@j;+){z2kWet0QWx0`c^tD#ji*op&8# zN>DM`aT;B@AL$73Xo&wPJ;IL0qHjC|)_`#Idwu_A_TlOhRmf8tWEYJN^u!)fcG+4H zUopysVLnm%=`Lz?hD4~Z_DbA~P%E@riBo7up-HG002XjLa-|t^gE?LV{g%8 zj(G>h`#T!bJKW0^R{z+}RL%ecL4O&*qeGr~f~1v-Tt2D_>l$$m}+*%DE>$4fhW@XM7}<4YC-{S(g3x zD2x_!MWFwMVBiq&vdDZ=Fv-PlbSKspsOTy4d28f$X49>GVO zQT!-c=<5p+9>aH#qS^h)eE!b{UG5V5wih3!LJ&Li*j#4VAoarqKVYB`o3*Cp-^y8e zXd7do=@KA-6$+!_sEgy%);CAVhr0L*>0!g-Sb`nd3_RQlE$a~$| zQvoC^({c%f`!h!_p)}F?&Ic120bP}tyG&1MZ^a&bww~J=Rgae{OyINRwZ4sK( zrs224Rf5^6STb@eNh@htSb(GTI*hbkaoH7T!dh00ie14hF)d`DNuIPX|6lnr`Eynk*5)oT=f(GC=e8; zt^L78h)P-CCQ4Xr(gaL=J|a-G32bG);4C5r@);{Snzp}F^X*4QMxWOZ+{ot z&s{>7XP=Sua`tf1fR3=mm$$Wcb8Qc7Jso8!^QWEhx~iFfR%z(exx^%B7eJN5ZtsxS znE*zEZcr)k-wl$pZ92VOU#SDer8&#=?qN^nv*It${yx#^(|bQy&B+jBPn}B=Od4#7 zp0gu^4ezEm(0@1VLY=}fAGJIug=7y7z0JRk@dfD}@aSJ0VZ)JJ|LrI3c>(yUjmQdCANOxfZC0^G6WUiwtRzaodI zT1a%GwcH&ZBq?~RgFQb$&V;&d6$!I8+0vw`7``^1xFg|YHX3YO~0m*k7;37$n z1)*k}zPAp4MtGpwOy%%u`!CrH zJ|4aOie_7`bWkGUcRtni%SrRen#?pze` zV5L90*|{w#eSsmVme_hkGQ^7WPNMwgT~oXZSY7zujbEvKaei1;-|;$ZamqLfp=Udm zkH~Et=%K5OXx2RRG`G`McB-=&GyUpFBnET7eZIpzd54`wZIgPETj&y(P(lLq`l+xI zX)Iy8M9sE z&Dnc1o5&fNquDrVY!=>idb~@)uEE_*3d!c9}`o+;V#wSgD)esq?-L_6AK@LU7_t+_C=oL5P)o_0a@3SG77kV z?LT(*ERv}D1ran8=KmSqt>pR9wKk_)K&9kL)n+Sf_U4ZIo0I}B{VF=`eK%v zdj>}M$6OuU?oP@F7Ws?sDB;nA-g?#^cXS&v^(zSB)QBkCl$y!2a!_Yr1wajHAf5?) zMDCz}edin$RWqx)T0mUf;O^#d(F#|yvu)RWeN=0>Ep z9wX~;=m)Ng6(I?k0XDb6je**+>y(Y#YBWXoEM)&9p4nZ65D2YqOJ2W?eB;=i`r*yY z{3&4jc?*^ynm@p_@++vnp3SP?K0aFqQ$} zeE)f8ZBsSrBzcbJbKk4Hmh$u9hPZp}(Ki}XC7R}Nr@R@@lsy7EvodqB=^vLnCs4gv z$lhcrcgHZ|lOrWO?{^op?4E-fw>!lTQ*||Whs~Zo+kz4jD@|L*DeyOUJd|z6k`HUF z@VGzgAGEbAgt6*4$dB#;Y>q{YyeTxY^Bya7!V$`_i}cgx*`#{w5X^38TB-Hyu^> zIB(e;q!T4C70kiigsC>z;I6ER{7IGIKlf%}05~ba-~qd-oR)vsFmE{`JJ5LKTk{%* zqHc~lkN7)>Y7;luCcp#%NIc{*C0kST{GNoGEJ*iJW%06HpawVA5S0F}MI7%5Vjk&u zvqZfMf`tPhB_UMOsr3i0?3n%w?N+?~a+kc$@* zdEZ<+42DJ+qx_*}5A+NSM>R%=l=XgJ2_>ujd#}g5ix@?_9VRhTw{!4bixV;Fz)Hqv zMr`#e9GB&t%wk@t*oI>twy$l096JNhb%wsn^2pI0nagmKQ4dqyn~yZqV1!u9i#=#0 z1Q!?Ds;5#t_UV&YCMw(yg{(ZIi=!Y$OWRF$t%(%^1`KRS!R2S5!wPQp1$gs0rBMd@ z`KT42f>e4?@0lZ40lKfr%>irN%1JrzLJ)@DsSB>#3*c{Vbc!9se|H|l`_9YNT6vDJ z{U|{TyGnE<&G7HaW&YxtJ|Ur+2+^owtL_`onD59DXApvscRMDuoEQvvHBEjdy&*(r zd#wksFsB|?ki4&0h2wbagN$N52Jnc3^u7H1)CufH^a`mz$51!NW7&&Z_m?ETQ+nCC zOGR3i)PHV^#pD6~Umz>ABoh=EcM)Sq43RRs4 z6->P7oZZfNXq;kx{)0)ND4t`3=C&~q*@Hxd9&UM4%@pB~10H}`upM3uWBUb+#h~vnnTMU3 zw%!2LSLo@+{gjig;?8^$*r=y>YS(?e#?O|85|5QZ zChYkzyJ-UcE~-5kr2;Eqsqk%Ue>8un=6Fp}bfPHw8s*>Xb|M#W*eL67&1+t+)Hl6! zR7j!IVy%AfYMJ`+xW`C!uz_+QtQ9dYd0ow928(vdql{9$`GnES1myA(%67%Wos*(@jcaqm16v+6D7U7IE~jz{Q8dTN;5H*=HC9hC zL(|b+jVK634lV#;1@OGm6TWN13n zP+#pT6ZT%pP2)79>JlG~%rH6V^(sF(5x~y~yCDA-yT`x4qkA?a4A!b{7LriBU17m* z6$`?*k%>|wur@gFp&uG{jd|R1sZLCnyIX%KXXm4s_{;l5clY?1zl}WoW2qYws5FZp z(~}`jul0y^v;7oPnXJ>06-xa4fwRpY_dxjI!LmJV4^Kj>HcQlmrQWn?JN0Uru$gCT z+j^gz66-T%3Vpq?8|W`8)EG-1t!tUmk>dA8K@1HgynF-2?sDeAB&TZJ1S2i8J?-0gz#FfrDkw5(wD)pUKLs-QuygtXvV9fJ|w zNziKYFITyclRK8*9y?jw0F!u#P<^goj-DpC{Rin25 zd}Uvh4C@NRImhr9 z7jOs>130GQiu^~{^w^;MEEdp1?G%b!U5{KL%nJtCNU*Lf$%BqeWzZ{flo&lYzVd7 zlZv$W?prYDCntv`A?svstz6;brI3IeXxvcG7oPAxxt>QY*ER}!ko`px@A;t|j|}!W zVbwx1bc^RXIh!y500RIhl@#+rfX}~KiG{Ue2oT2ccnee^UgIi6Ij&cCZW3izLj7>y zIejVEe#(+qayZ{UiVYJLf^0cr^$usWO-ZH~;>sRR91EI_a!vy1)Rn@M|=v zphcX>Dsn=~L$$-RkJAY{T0-;I-aF4q`RHgs>ish}Cw;Cc4hohcxc+t0C0tM_;kY4} z;%+_+_&OF>9kqUJpG+D@&z+S&M9|LAqvM9z;E(yHCc_>SksxSF)NCD(RWiF{Oah|S zM(lIa=X|{i5i3C=XU_|7o>Kr4^`ycQVNobuqZ260voRcu8EHEAo42?#5W5)>8;s;T z?XxJQ$!N=Y1rOj>YuF;)fjy<+!MT~$o=%Fu2q93=pI#1@#J#`yyX zGfVrd`{LhYBe-KT!$0y|HtBbkNoK!1Eqvf}260Wzq>JVr9LP^VYAYy3+3tN9*v#ftD2t#+A+?vmiw2dABu)99-bQj7+>7eX@*n z3EQE=(cmhwKAazy7nipu?i%WNOi^aR|tlNfe$U1A|{@mQPQ63@k{R4SM z&tn!P!cx0E)#&WPEb4$zPI%?<>;*stEod$0Dv64{MIIYG&ATMm8a$Af`+-r$fXt&H zzi8Zy54dcbf-We1giL;2otd?pHM8ojx5~KgDqm(l|~K8pepJ3&AjG7Vo6%Ls5h<$C2 zktBNK7!9tM>N>w%?;{{cDZP^=10v zEKk1CL9<}^91Ji=Q*8kjP_E%q+JKErVnTWXc1^vk1^R2zX+jWWSln{5!Wa!hV>FrX zYh*hQBA`<}VAOi;`HsN%>6-AaoRoIYa~Hnsqc? zvWc`sI8*D1&xejE5QbVu|3?4~kVQ&yEK&bH8{0CfGIWRJOUFMexNBzB>PIzBHWU%~ zoyr4%AIf-=kYf{<=bn27zAU%BYRe4u*20OH67e*ScyKAkf%-s$TVyp1+DOqM)g4sO z`Tcev>BNF)CY<$KfW?kbXdU5nJZ8dgv^l$dRIBdJMmR2=Dtl(rnvj^gHs?=52KQdsP+Ozca2VhZ>4* zCTGm#X>gYO6V{bb9>J=7}7h zOGt)0Cy%XgT$LN5!~+!>@yp^b7zL^2#(hNUJI+flt@SDlvb}Q#V7}Z4*YQ8utPl`S zLj7M#2Hd7aD?kSxURS>bYv2A6N}0q7DnqsUSk#ND9=KJdiUdAoJcM~7N4*mp!v^U< zsKl9YlHdUCkSKeQIMCvTP?9oy{CDUL?3yVhTg;mX&8g-D4AveC&vLGUa|#q@ktTAh zBT>-N!30zK?Qdf6J$tTWr_DZd3kgcN%_Q$FO{0o-8cKhk&`Dq99JcZo2MYCd(ru6X zX49eku)j;)BHA@j9h5DCqD>ME8AJE0u;~z2Wh*+nM8{GWk`oYazpgu^x*RbGRMUX- z-oHmCh0m_S9T;iyIplAw@EY59yy>i6GU$*Dx}mwxnJwJ~NO;x}1nN@uTGSgpdO0Hy zG#L+Zu@6--4O6klWJGbmDQ<3EDBv9KQF&uA1{BbuFJuWQFw8Z_fXCepOdh%^ql@ z@g!5IUD@2rsu9rt#^3t${3)qdZ`0P7xr0;KXIte^)s}FPiWYadAkyKzph3Z8X8W53 zx7}ITq}xyT=5kP6aHXcugk^D8Bw+j>#lltsq|P!3qi57J!F4GKbz)`bz_W#ymhZ4L zmv-qLDD$h!9N{M{3%#{8qp_;}5vi9}@?*ho$rTl zSj}smk&nbm-sPFRA3)SDtdxG2i#p~^W5DwTbZIu}K(2AjvyC*P>}uH;?y2Sa%&seT z|EPex_d;+WDAzL@NO@Z-z`koYGLq@=!gHM=|73HG#M4{mMQG+KHml|>ZvM^a=uFbF zDJU`)6~GxT|8KqZwBAi9le=+p>h^lwBK^L`P-90JUxforGG&Ye4792JW+*kM>fS5L zKxhtgzU16{L8gnSL4qMHzDaS;5eeXxlhx;Bhb0bhn5u4xnHfxZVbu~W=X~Tm*1)Ki zEdk$<>dyurANUTC7+-gEC*{^Ek)HmJf8P`!vjpqjD@becc>TXnPXIfIG?>x);N%Cy zu#pAiQWy#vEGk1qh}19v@&jB|f)R?oV=V+8IN(Xw<)Ay7>CU~1t(U`sBeB{O5*NVE zJAJ%SkQ!=N70Gn9_LU5hOgGrDTlVA~qr$wZ+osk;?at%PedHEsR7wX3iM*px_P){c z>bV-He~aMl3GyL_6ptOX^;&Ou!F2`h=Kdk_LAqMh5;!d6uABZ>jZu@CGK!|XfNhw9 zGdAZ9X0iZ{ds2${J9{83v-RIyF99htG(haA%}o~j6sjbAET-SJ`i~mXV?sZjgg~^v z!av>pE*1|%3lChyOAm@m?mO%k{pr(3X~G6WNh$WD>Q~u?0q2k6nyhM31@q9JPxWzf zg!7j*zPVlma#}Ek3p9I0Gv-Opx@l&CPBsEHJd4v>;AhCMgUtvS81RVAM(x^g0f-fN z0XeB3pnbQxruMrET&rp`gwsVni;FN1A|ZiKAdb4{?9+-XlGr_l1Ggtv2bZoIh8~E8 zLsuRdvGQW6j@p~^Hs1L*`v$E*FYt< zUv9ZU6gz(mGC%#4F}}=HA2)Sx=?J5K!p=iqhyCH+w<7&1*0-kchPxf&+RV#uLQ<@w zN*MyQP4(K6I$q)#`@5w&xoUIZ{?HR$v)ZJ#ky__$p2$3%OGS=`6+9GLl48I<_LMlB zNqfdykGB3qZ{k2j= z9Xe1llY|GDDp8O!_mnuz%^N0Ip)-p((8DH9{64*quG9@m(TO_4`BqP3H@4Rr0Ij9Z z8fi{Y8(_6j+dnY?iLlpcuz@xqEY3Bj@6sgr^7c_uJ>Zn1ySG}7eKquiSL!}?&RMhA zi?9+0g9YE_*e3egWVoXBDK5MsiKI~{1AbBv{~2n04tiL!kPM!JgW-c#>r5>AY%tm3 zSYwEQ)PLoSOBPgI0;q57in7>THv=*JgaRT4Vd*3(%EJyd+qx}%Upk?DE!)Dh+Ko0& z%O_t${aP6ktE419zF{9WP_2(nWe+f*p*^I69!e~D4?!;>aDVd%G)@-xh6X23jJk5v zStvx`YPcxHHqfygBEQ0i{zRa(f(oE7A8(NNgR~{JT)WlIL&! z-wp}qF`e5agdJZHol(mdF02=Q?n|KwUu-I>X!4=j_o4() zy-u(x4vPRDpBdhR9spnV&r}8(=5AEYbnl4ozy|>pKyJ^h#qR%pv zCaa%c%mne-MI;5mg6e?w0cw8_-d)dpMow@lSfoW}F@2eMPF|2iAbC;#)QZInsQ#?O zRHnC4ME&gOH%h=z!cJx`@D?V>yEy;4=HMe_Jnmebfs3x1&)q?%f4x=h(6Qw5=D-=pewD^!$l#3eFl|++8eD#7&0tYo5Y=~UdcG5r=`x5rTaEWf#WC< zChba?rzzPdf)KGLr6>fyU^Ge4h^)HL6S6g_R}U$PECx!$lZ$AWYKnK#AIF76sL( z)Kzah5AqC)q@cHCDt|yke4pc5jen*}`lR-?H+N6%-^0#?{ZcXmkdvW^+vlEj6cKs>t$7 zs`J)V?n)v@;U=ZgMttYc%5P2o0Qb6&;X)LaX^8!yrb@b?9YNF(Js`!OfpM`3*tJv} z&kgp`y7p=^L=7_v&e;~lHITrv6X-IhqNG9(df(ch{RfL?`uWJZso+;M&s-!_HH&)A zuSOvH>YoJTG9r#Wr1Vl#S|n{u`u#Qq<>d9nnR^EZqoaBL)GU&U5TzWbSSJG)V@QJqG1%89g2fT3`b0&MQJwUB0v?32_zHWR@0b{6hQnF+ z9&hueg;4-HpXZyPcQm3?qmrneo&UJ4Us{5mm1W*xAtsfi;wX3;&TqutZ7$Q(Cg@Po z($bZWrVmE7gc3g*##Y%;+Xr=~a^VE+M!=~C` z*Hy^@W-CYihV&X7ayKmYXF>3&?;sf|pV4^Z?3NDpuMb9XA)f30L`=N@rE&pg9+!oD zDeFu~k02Cl$Tvj8AyYWooF3BOJAUNd)@53uPbg4}QaX+^x3eXnkDfF1*r=?&97vRz z=gMMQaujP0wN1vb-d|g>7VM|E`WgG*23vHSY&scL5W}Gyu>ek1h0rRnRcl}YNHp19S z!74RIU}lWJ3fp&IT{Dc;)6MhinPus5Kw)}rF-x{|5`^*rjGnbHoMGs4eQB4;R-;>Q z?b53l2SPa6nz4pVxW!ZoRqVB79}jnSN=C0v4T*Is#O$6TZWQrK6}l&23Z5N!sv}*{ zc5H6VuSQyC7wntED0*GXJ171ew*k8Ar9Uu!Qyi-!h40z;NeIL6ODzi9nTGJIJRwZL zVQ=;qPf?+=VzRgKm_7egZX_S{a6KG!IZOk7?nNMM9$m8kkhru>0M=8xqGbl)hS^Be=IzKSD+G5d!b?2d{_BMDFV)GzK(MWh+8FaBs}6HGUI zAUY0eC9M9!4Iq1pWWohuMXM-yVn1XXY*%d$Ucorqb3)Zdzk6_DhRJ)p8NZ01X}C~y zbDnmqb1+z*iamg(<>J25FbeE;fMfymO^tIvFuw|Fnd%~O*I2l2jEX~;kqJCS<~g%O z+n*ro@T+%h5lWJLMAKdoc_tTq98j0)?nWD4#H+)PI1Q%1Y_}}ovB;i;(SKxCo;25O zd*?3m;`BRvcz}KqoL@DrwWy0)00-l0hWE&{y1IgEqnB~^Suu$3ZVQRD!p0n3(-vIS z^95J204na|PL{p)jcY5k37fgv_{vS{1}LXJg}PZzc{g8s4DB086{^jV!x7`Of&yaN zHJuMumtxE!c~S=*Iv6$J;)Sh_zOf=ce$bE@Mg4AOYOG7`#(fOYd&P=Uj{ItJ;t|90 zJS}lks?LEJ(fP`ETFn%WIq^4c!0AL-+WFy$*^KSqqf2=`zbFQ*egzWD8)QRG0<8EG zrYEwLw$N%{W>v!obE{#c#%2<1U=3Z*WhGJd)`X3vxnQr$_`r50wYNOx!zN2mN7sd4s3 zpXjl*{9kQK6ft(V`;7k?aVy=84%ZMh?22d*ftno7w{1NzN_Mu5HvjFoC)dZh=nQ%6lQKPa>y zW~lt*x&ov3M@zML0CS#(B*2T>*PzpHo zohuRrI#uX=Szsn?Kl*_5!4(~+!)AnoYsk{2X+_{Cet zVM!{up{jIXDU{rUU=iHXMRF}IOLnajRau)iyx>7t=S(EQ_buU;=9tXrlEo8TJP$<{ z17g)>Nboo6o;Mgp%(FFVDFarXZm$EI`YH|jc2S4-+&*NX??K4bv*P(CSnd^-r5ezG z&?J&r+G|PeMh6$4z#Vb8p+HssPYIp=xhsj|7%Mmg{Q#1zeNJ6M2eWNhIVdz9$2u} zu{uN3$pf=zMq`?Jo`dMDbO9s20PE|ozXs&CWr|K2h&XXB47KP_()@C(nc2;BGQr)X z`+{mCLvpdk0HC#+lAq#!T!* z8Q<};6=u3(XL=xqAuk>AHJr@tx3PX3GR6t6lr=ik7EJpfd_}LN3cdie3oCsymighV zk_ENBmnHX7R%R1z`^X>9jc}bHZV|k(7`M>q&U&g+e`3(8%TmtUg^JHOK*ChgswXQj zySwCsekj5FO#^os{2f8k8cSHgeHG zPnpFg?LvUo-3d$j?{NSB=|tZbHFWwLmSvc7P7rC=S#AReESVqiTUi8fA)o- z9;8!P*SN;fpqq5vy@N2*mD`Y(9pNE2b2k9=iz|{G~NZbbLr#~d3 z*JNy>&Tl9fGi^vV1a?ooMk|v&bDE1E0{@ZzISVzXMx>2@-SSSmix%S|ofdOldaTy% z$lhkqr>8Xos74#jZ+EFpr#PSaM!$L5iX;R`1U6SQ&{GuN#2I?uyjS^jmEm+?QTB?^ z4nHci3N+)!=1aeXkYF*8%BIuwG~7b5n8m$^+J)FR#$OvjTqNdcgTW%?GAv2lXBmM< zq#1qkl$O$PH_=DL<|r3E@qXlTgaAd&1UXRphnKlX(Ph87-I1v%mlP|eP?4eM1);>Q z-xme3OeS;A*$oiyXxwhq>vw3x@?acGpI$tYqdg{!j%FJ;C-{}f*5N2UAiViU91s|0 zA-(Dr81bh>TF@4Qhj;Vor5@-kcduyxRp|u%AtUM6Q|pY(Slw3A5ke=NF{P5*34z!O z3(fm;h4nMq0kfF0SYV5>Iv9mWX7Wl`^Yg9tsH}-%9(4gB;Cw6>=yB6)ICXgW0b|0w z$~3gz$L}xjTxYxAfYt!!EQlY&^Gwx@oKQd7jUuS-d0%o&=%< z@E(!dHs|VM*Ge&)+y2Wj&#N&w`wP;8WX~;@=L#C{_RF5FT4d}PI0qjTQG7zDkwaPKqIc zcv8QP*aO)d5OWq)p-)!vg2W(1c-& zT9=5>X>G`IN9_QDI0Z!Y?2F8}99d0_Qmp|#wUB}M6$oWa%; zL5W)971{LWL(iqbXsSo47TOY_#$D_4bQb=Te@X#b$f@!;|Jgi&26P6BsCn1#TsTIcvHA#Eq(3Zs>mU~6liiV$=u<} z{XK&Zn^bDbnBt_&6#Oj6*vD9=H>tIl7|lt6O80Fqi=eaa$i?R zpHoa!Noe`ky0x)9;7eS3s=p^AY8;T?ACx{e^7=Xb8K6FU7urUo4u#2%aZ1)Eb7|c~ zO-jPoMW9GaVc^2#4LyW%PQy@NcLCV>N9oVNn_;=4&THQ8;ApRI;qUw5=^$UB zADJifQ2c}G$NN$ozU))7M+MXY)g3ir5Jq9wb2kkOCey~X7hbDr{W2$W!gmEmEt~ZER4#SYG4?j7yYpiK@s@klEXogB&8>*! zn&DS?yp}(0*IXH<>Z=nz@jnF36D5;IyU9{|qdAJ8igm_sPS?&FgGpm7vzcShU=%Lz z^VZEIqooSldC^(2V-O7`edqug^k8c#t`0B`=M1*vm06w)wHe$FM0N z7hUMKn+5YxfWzmtdxj~>P$2TGZS?v@;`Hxr`+7#bGoE+)Z73uIFMPN!R)m9OXyHa!p`CzuM zOjeWD{5{O`l~|>}^07*Z$R7bkt|wQ{=Qc;y(C7L@o}^9ARzyEmfZ;beIiw{Dg*RWR z`+i#=kmL_|6&|7)p-)`SuZ*gkPy*MJB;?{4(uRwjsv78hDkULcDGV%$0BX(Jj{&T! ze2oKhynAYW4vPv5wz;cieAXP#_v4(}^lldp<#{YY;EqIWXJgEJm&G{ocw6*Yq_U@* z7s!!RP}utvBDHk_j1D1COBB6oGl{4%S>GIsTaVX(qo`AW%BTQ`yF-lWVk%&nlT>%T zKBkfE{8(`mmq>cM_8+FxGruKH9kATXc_!+`W+#7xzlJ4toR&3QgTETRf?D`(ZP~ z<4HM~;HiF+3?i;d>a+y&&3N;e;dqf*k;evwz;%u-8k8PqD{h=XO#}`Jv+HxPo;MPb z_OYhFqxBKLUH)6;qDyAujUzQ#kvywVG&Dha06o5y#oNNfX%c#5OGkHz^ZFf--=enK zo8;r-NVoTbTkBo4l}?GiFwZR#$h(?r!6gMA5-n?X4f#}!JSJ<0dE;3A>Q1mBx>B<0 zHmnJ_cGR@;OBJf)9xT=BS6A5_ZdJGAAkVitD;1q zQxe)6kfjFc9Ki`MDLpmchkJEY&HoHi9pM8Rp{EK?dsfsIQG(bV{nGYA9%$JBv~Yl3 zRyA9k3 zv}g2vTmJO-tQ(bA7Q+y+OAu$*MhnZuu)#vSIL8+9G16=&B z3EePn{C1>V6zc5T%#J2-a$(A(0S&p~&b_Kc2GS&w+SSRCBv)wvR*!1#ZR(Kz2`*L# z-_m;3g97fRcv@K!o7Pt%Ky}krrfdC2bvCLPn^uNRJQZ_J@5_BRcJGL6#MLS$FZF&6 z$Xp;T^r|1a;GLn5LP6VFD)K>uAAMM z96%|M6Nv?#f*WyYCp|4VjUAo~2Czgkb6A>z|Gr4g8i&6YC~@-6Vaxsq3FZy!hh?|u^cB? z?z%C9pXBtZj|P_AXD*Fi8+-phjky&itZJi}De|d~QT@G&kKd8tA?F}TYi^>f57rsSS~r-kFzcfm6029U}m`lthqgTMxEK>4Z-p?hj^OeOlzp zxZ=#xCPvY|aV>hV3<0M4Wji$+Vthphqskj)+c=tZlo>oijglV1TC~j5w`#Q`3sK%H zC>p*wwq1#W1-sfB?2bq?O9pg=LVgT%yYl=5-E`B*FrMd9Cd@P5Y@@{Zip^JJPGmdd zegG7BR}{>ridYoMaq_GT+Sc}!w_ZA5DQmA=pqX1*z zl9R_3Y{OfKTYD)ZIvs+2e$Z4W-&pYH`B+!{>0e~F@riI?2;h2Xz=ay+>*1i8j$SY5;{9(W zIxK9hF2K}eWh~8zO6Nb8R>8Xr%g@=S#i`E^{EwTn!??mfNE3_yvR>CtK>;hw>45v6)hUlIkT!p!(*sV&Nrj?#I6z0pdMV%iO~jXh!i93S@B`DW)*?P?Qo? z1wT>E(`AT}53jY03E2q?r)+fXaZp-d$P!& zIP0#qk`@n_op2}y;{)#lp25;cN)*6yz~%D*SU{)0H8rzFz;ay|uD%*iL7ho*=DX!j zMR3-vrDpxnYnTkD5xF|=9hdND^cy18yj(nMSgc=|UVml%1CjE}*<|~mJL&a1y%sT? z3-DAfiisR$J{A9o?|~w(Or*Fasw6!=ykyn|@10%s*nhToTVzah<6pHZ*90tk z@q9HKCR}pW6)Y-2Wx1H*ga8(xWak*iNr8etwQCn3Bd4aNf>DB-pB+Xh1XAf;9zbt1 zPK1vrYtLf%GDJ*P#kCz2b3{{z9@4t?)|tK5y)u1K`s+$4PWcT_6kP&@XO zCtICI;O1DL>j$~1(;+2`SwvYwGW?FSpcx!nq3)c2|(A!!3JhdHgTLUWH4 zPwnC{T95YijrPw1Lh6xf0457%=pbdZ1kGES=ai*9o%l^UoRw2i7s50-*`uU8$>?a{ z&MXGUE^^03+wD>S;&9Y2EYXGw;yh!c_0-|b#QfU%giAeL_-be3!fn;*TdW+#@A9*n zFUn&PbQLC@rqrfkD&0Sn6MS`LI5|rL7$A#yIopUJ47P3Wf{wA1-EFT`1zV9r;XwRa zB}`V?VmU;#dnCrhn)&TdWm!`4Q2wVDS}Tab7YKffZvu{!)tp*$fQD{ z;9iv>u}@NP@<4H@XYiI9xbbfB?>=`EFhF}Z=;47=^QH(q&QR1|F)Y)lv#h_jj615B zhO-R_Jv=g5?=&L?Bw$#3i`EVu{2rSK>tn;vs0a-EyCQnk z)NqEu`&W(S@ePgVLUsq0Vh&O4>hujh?fzxM{3 z&&9a5G@H5mD~P-f)O~m`ac-j}7*I%|3N$FZJ+2HX=_CU$z=IGX8FAnO$RV_YxE8MH zG7ezZ)Wse0melrPKg;$f)g<7M1=a1I^jyf5L1M{kbhgsdm@||sj%>@Y$@in7rD`gL z=+jg47Z$a`%kvkXe2<25j*=T;w(4rx;a8_I{}O1H;wt|LkDdc%^MD@YvkpqYCz zV9HZHq+cTO9CHs0CCD?sZr!RcB8@`b=ePz(AOoL}OELA;v8@j$Wqf4Kvb-jApfogY zb}wtcy$wrI#>YZ#RXFey!eZo8;fyOOB1i4jMP@mZ@cm9Bp&U8Oa|L$XQWH0Y__2tR zlt=~H$KDaWLu)cDZ?W}+33N}k!K=#bAhH&exml$OWW=!wBhmG+Vw|+)T^d;8VY;B- znx@CZ>2B{yMpBmZN#QPS`!Yt?RB*{IHmtjpZ}V=mGHA@o-H{-m6?EhUPM(8!fLD!N zc_Fkmj(s9+nf3&8{u_Pl3LOfsO4sKbq@2gZ;^ZGd)HG^9yjH}821xXJg~}Ysb9ki# zv4`zIWZH!rlwTxWYi^F@tIAKn60n-%3GWSj+fX;Y+=0dRGJU%`FRRcaG;ma!-~5*1 zly$1})upH3^cKE3F@Ql9g1BU)7CNTvRH(woh%OP*K`VdFI}!M3!ptc$0;FAo0^k1z zU2+xl#Mux8)8-ylIz5wMQC}pJ?}0zN{j5Z*-%{dDaDifIwyxn*vdn2*k78mZ_De20G>uGzOzy(j2k^B;JaWFh5*DJZ zmg6KliWha;CjGzwS;>C1l<(@mEN0TIwom(_$?G73D-M=m2DYcp7FC6)y@%-m#p4ba zV!AFOkO~R0<16qLq^|VH)%3ksW;{)UkoV>4stkiQiI+E+iG#mtTff<1(*Q1uYxhfMX z7$s4oZ>AaL2tsBQL7nY}69`%z>JfacYSu@nC@ek04^kE{aae6545xfXp`*>zc#G?B zxJrg)BG(qu4e*CP_E@&r_m2=kI+XJZ*?bjKC<(Se&%K1BcbrcYtO4`DTfD2adjDh3 zR{)j?J+Pn{lLyuzv5tW0ruV>;Q)1%S<2z)`_K}hf9EEQuAg}@=nuB%m`@`FJIog;e zoYDxCQF2On{zg$Z7q&=^fi}1@j=CyL8y9Z`3P}k{l!aH}1JwrFt`-CfJ2v08l5c3_ zl`#=`X_?wtGl_Lo5d|CQQkJERo*Jx8VfhlSX`kzva1taSLS1TQ_uX+(VQD_4pXbK7 z7OSWdCT^;~K^uAh=M~~mJ{D|kd;8`nn8bA#Wv6X zO!j@zYo~S{v%II7pGk9Pf$<{v+9JM~fCwdMz4hI9#UF~dy1QKxY4~T?sqG0jFq^3v z6l?-Np^D5sUF#>hT_Bzx`Bn(>tbf2tLkhDjG3g$AdR~5u$**?+uG5PDLxXPdq{OBT zr-9=nPr+(+PEW`l`mTSUF*B}Gd7Z5?m*+Kv^7>~GnRo!f#4Zr#9=)b}-9|iK?T1AD zKlMJ>4qovl0xoXugG7-B>_5B_ z{+m5cMU^caN&2GC<<4S5#%?zKY|_Hh zxqw!hjlOEyeed9<=_`gXQk|ZS;Zny)s4&I-lOstj6f=YJKXW)*G}rzCy+(fn#W5(_ z2QA3BK1c|z8{*QSdyZMWqC|Q^sVmz;a(y4X{q7?k&!y7I^qSq(%aV^tk4+P5bR~#N z#JjPO1OdflHAfN>6p&C3)a_`AU$vq*8OFH0qy`zAW5YOD{<0GeENvChF`Cxj*3Tze-Q2IrX-E8A$vq=?1fix`J=hIDQcbbr78{sg6aTM@Pm8I*?4g39K z{sbXOd!!(*y6IKmea7qh;=l_7xs9`yPFR-AR$zNGnoMhNID>Jm1_5A)!=Yp=7hI8E z_hpBe%Q+xzuEl2Mx9ck40jqJQr5@mBK{=Y5#SUgt89yOJMWesqGA;)`4^Wd6Orrb~ z>zsbNyRNjm^|*b0?mB+=bikgd*Kn2RV<4&<3XL~}Qua7QAvnQ>42mlBRPR<`>Gs-|TMj66 z835R>uPZxC^jij@yMNMs&)WX!A5S~!O^r%!uM_9sl`(jDd7gMgt8zD+1?HT%GP~z ztM7QQiqZ*u?GRAyNcSUS|8hxL(Y@<*(6ApQESh;VFcp(lMg-orZ+*B^ztmIZS}q)* zDG#DMIp*H?v0npumA*!$?CN}3P$k;y(Ph(2RUso+5%1bzWy-o(0*oA6+sT38#yLKcyvI+h5pVxsr3G_kYAt zo8KGi&cdS(^&jR=_~I|Q1f${-hUZ$uWo~*4OmK5*pO~r$w$6Cy8CU#YSX(XIK-o-S zlKCp)Yy(RdN>D$RhwIKk*e#Cx1~>rv!2?y+6`m@ zyTF2?ggvG~n!bA^vjCyZo59OPr!0v1`cYTL_FV3hF0jjOMs_s~x2#!w(bfzp$(h2) zAxn44E|wvFaIx)uW6aLo$@t@^UE{)C^b6i7O=HO3pz`7mg2JyjSDhPwo zr85XQ|JRK2(X=o^X+kuYDP4HEQ%d;%ls3s(ixUj2AUzEkGO|81&F!E5S3L6y_pAlN z(hTnlBad00R$WK}E;b zb{$k0bcK@LWnz)UErulwyVpyqH$u~~ozf#byZWLl1hGTY?V~i4`=&c03-PH9!-tnG z%0_bv)B-a6q|m%>3fu|B^A4xSLU9MUbSvb0TYP*>Lug#HZD`Ny(u>Bi1W$liU-ishC{vI5$H9vCl<3F#GKqS!CE8vj4m(q<9C*b)~c?Y~mS7G2W?N+sq6rzK0;N)&Ma0 z830p-2~R?zUAg$8!DUt?RIxkU1w+xmUy{+;W4kVBBtzrHS6EMYbE%maLNsWunQAF} z`3hO%MwuNNEJD=G0QL0KZ6Z)t8`S0^x28!KSR0 z((J3SPVLkWStI>l@(&6)000G?Z{Fh(*I1idTf}?2=98@c>;NnW56kV*T!!_XAG0MW zUDAE}#h06LDlxjLHeBtQ;G^zBwRr#l6?8$LmSmJfTr2+o09_^t)RQN;^6pLu64DUqL^cP=I5Zl6 zuJj>wDIsb;Ni$kcpmUOHCbY_C*{kntljv**fMbPI#0_gp@}+j-Kn8we^T)cPGpwiv zoBQwS#&6IrG=WS6U?a$mU51EZ%s}s=*-5<{>MSRDUcvPhlIh#LOf{+FNkCnMh1912 z00RLA1=>k`7@xtlFFgz-&4CFNDYz{GiWm}mj?i}|jKjF*Z*y2G`Q*gVi7Gyj+LNp3 z4+V;#HOF)|F_1l3_8CzzZuf7&sHUnhQ4q|N_c`yQ$M4cxzQ|sBo(v%6*$|~-J4-9> z(f2JUBN&kZpMkU$rhBX|pe6)H z{L``mmVjSjtEL9jrg-sTLGrU7V0M8U47(81ZpE8z>g$!s61r3|8Whkrb{w9HZ(!RH z)R?-;dFU+$D=G{D(rs>LQqB1g1$rGg5mHBbIpVyq1ouQ^{#vC1Js;Q6?bU(P>F*Fg zDB#YybY5MVss^*4v#u7h6shzWK%H~kzC?CB z%~R{cvXz+<)PM{GIeTXpeZ0itS})$Mm7u&~vHf?&WO* zLI|iPU;0BeKH2tOT4b#egK<%DAO@r#VJh?1P*$>lgF-8;*Su`D=gVR5Wiurj~;=C$H*^oK$~x|!Q=zGT%8qg zI@|@pXKcSYorDFLM$V#Ex#H)o52b|cGSbWh> z1X!=Uz3emdLf8*tirIBRJUOF;hg5-g_NiZD;?0YeR$CJZp$&K@Y2f8I$f5FAt>;&} zkRJS`3z(x6-2z?W5o*+Icu%gqzVmanK1`51e3N|-qXn{#G027njrcBb#Et+)L0D!Q zD=5L5m)(uE#r8d#2w=1tl2{Ngr`=>&QubWd$8NM*x-sm+KE8;8)Hh(to&^p3mVU=} z_DAd-PN<>)ZXfVTXf%xJ6&MpwDL&^(&69{kk$de#u6`DDF{AtHI`N>yC89#K?FoYt z75g`p>Acy0=i8+Sb$UJQu2$Yz)&9R}Hq`aGyfQCrDijq9Ps-@^tJ;5t#M{@orwQP& zlgza{ShEL_N4-Sq;f~zMkNAc3ZPuyNZZ*=KIJYMLcaJkPfJ6i8N^O@uTJ6frle2a< zB+uj#7R`~^-nu~UL%L^dL(wnRz;IgzxUJa5VT@QVC^Ql=k#0=qH&oqH6F5$^{?l=e zI*-MA`*=&0!zJl`r}1HROwZSe5OXrQTX!+F80V5?(c(V&`zY=i*sJBE^d|(!EzdXJI_hc z+4HR&vAzi^{m^2|?On%!1i?u`&ywvuNNA^Z`;+bYo;Xtbw5-+}fWprYmo5+51lY5I zg}Aq^j^3MH&uhV-BX!N9FC(ZF3oLzb247T*i62)($;Tv+uWwp*qv(xj>wv5I!vkvn z|KZ%KW*JMKc}wg`5|_6&MD_jm=QBkWz}sWmb_g1e*On-2qXoaZ_6Y4TnWrj|1%w^I%@-&|qT{M~fVGVtj5?N<~i=a50Y!b&{w(IKd1FtyB4HW2jQ z5GdarxPn3P6(JsR&<-9*^sH91e89v8{nRRvG8j4TaVh!TE!?t_!|5aH6uD{jlGY=0cy%$-$hZa%E@{X9B#D=KSG2C~V&dNaL* zca=uy0nj$x=l`xH>Og5(hH5hFX?Sj`Itsb&y0-~LHjd*t>r;$hRLu~Z`%scTj^xlNe)+BuS$|bfCaDb5pOdr9t)}6C%D(oqE z{N&(xl7waA2JQ`D_Ntg;BY05RQWc$ORThL>t8b%<7p!0u)kUV1rDJ5an>PCkz~XF` z{E#kE`f2cWhJ{sI?hEXgAy`;-OC4(T?y^5IIAZofPdF5)q zZZTuz$Vdu#az#wyUc({W(pSvO=hJmKy~7p$`!zn22vt!F3!IC#6tEYP{~qefq0V72 z^dMbJ{gb?{XKnLGn3_1FY&qRkE&f>C3X0}EtWm5!0=*=PjNI&m5MyEI&{+x$dL|T; zq#NMpJKIh*PO+MA{haY&vURR;DSa}AgVidcP zSCYLEMksgyDrh!U<*z!mYr@<%<)CumJ-Kb8Q(6je7`ddYoOpl*pCFgowVak( z7^=2Z&6B}D|Hkt*ENmi<3>XlFmD5a;sH}!wweh@}S(BREDl0?QgH-I+yc>O_DE}bx zEwkBVhJMpn>nI9iPH~2e* zq?)FX(X4!YYN-T#wT?|Vr=W3?Zu5b;;qK)dxI+fAZKLXJ50M_;xn|<^gOglJ0T=!& z5ON;~inXLNbuq~uXaUpFLZDJN zwye8P1~faE`aBA9fQ}-XhS)uib7NcJOFG|ak~kpmEht`g_kN7sQgTV(5<1>@@TikPe069Ip9m|1n*l0gFK(2 zL)hmW(IB_a=Cmq!hdIa_Awnvwhy=Ab65+A%iB+dKj&CswHl&v5We&$KR|DxEQRAi^%nYv?y(#S1KE;jwn_H*Wi?zs z7+oGKxm`<|-CFP9*B*qHJgRK{2tGD{+t4-Exf0vIR6;S4&SUEhFJfY@FJ8OjAn2kT zj%JLYXu|*pZgSv^v=~T5TRs@X<_5RQQ!~GcZK8htRvc+lo9PO4cw&2rk^HsBuI-|L z6U!!(eT5iNNAf^e%}n?(p0OF@bhm|Hib4dLPR463L}M4l;|TxGAu0e);Uow_~J3xkl}p4!m98_r@eoH zY?qsxh^BA<=LtbJDm}OaHD*k(C3uL_l zdTytk#25B*CXj0N^QBXx;adX0PCC0sxowUiivW%$b)8|IZ}=bV${``}F$E(vpiKFv zU$_R>mAg^(@L3t`6-U`>m+u#-P1fd=8!Hrd&{Xbu4#0~TCsQM00*u$H_p)%hNJXhP zd&i(a|lv;#5?MDVmAB&5 zX+5GW`HVYW!&yhE!&cyXv-vmKj!tL8>#K3-=6A174n*)d#b7%U4c%8-Y?~e8fC>-* z^0-tl6M#xFT=TBAJqV!SL zyJj2Dp%RiIU@(jt?QL!JPXmT2M)&Or6u^kOe5jmP85t|+dV?eyrq}C%&Aafik|Z+` z%&Va7Gly3YXG$+FZjJ;=;VrnGED=m6zjj|nJGU+n-=p2vY!~*oYh|L9<~=7SMNfBE zOd!eBRqUu?pDfqKN={>kzrK){xpdUn)^_@#{d;FXhhmGnWL_)|9j|+C{+EB+57skK zwI*{SIry988Lf$_GJ6(3skRTrLmgGiLg2k=BRGMt=m>u8!@b$;Wr;1p9I6mD=-cT+ zsm3Jz@sjBE_5Z0$QH%qoe^+sjb?kYtzwbeVBm_vze_ive2@mEaU%^p$GDF3$Efga0 zgR03gcru$l@+uEO_ef0S&;7~=fv#r%0PILd;Yv>#4xp41ka}Ew@5ZQ4IP3cj+`W}N zn-!G=oN~B(60GeGar}FXNQ+RPj}A#94*=f0U{K9T?Z9rfvzcukl<60sL_kYC+6`*+ zB=m}lEGUIo@4aIc}ZLTU>qkc!f<{^LSDOfd5DUaT{jY>tbSwUUeKY z$zPf8ugC5_6Jxx23CMLie5x7i;FN0Ua=esY!W+HcMwS)B&1^H9{+m|er+O2S%sLp1g=K4ADVYmbI2dt|7bw}!gvaNYgUApugKR#<|u@=h_5g%0Y-4uIxq5YIZ@R7`j(yio~j3qo3bJAZRK|6>t49C6242}id0!#2s$ zA4<8Z;@56h*DyRd0?d=fr!s<7NsFclC=bDlr^Ia5_Y`*@^~fDa`(ITQ?s*lKl!l!9 zz6W-f`%V7HHb-O9a$cviMK3Q611sVvObma}ocLQ{4LO0@1P;4el^& zP8$X}>8kbIujR^H31^T6X1(IDpU{Zv0n%O*P338+soiOR>}-f^kmHqd6*UQOjFJP^ z9zcTbJv%}9V|mU!5WNATtxLD7i<}1^A}ROG!K>RovFBvu1I41Pi#l7hZ6X-4YJKLp z)&J*Ind_~8#Ih6gQ|`!ewdkdM)LuY=l%$3|v7?#YOk~-gp{~fuZlV%o4MEv>|7E12 z8upuEoSmx>PP&P`jceCyKo$GW^;Pq!UIaSMFl}D;d_l*HNs;H+PNI!t-nxo?f;+}e za!IBkvqRo(cqWd%VLJ%fswhAlU`aR#53$)=0XGv~HKe$)AMvcYE8gLvf$xM~Ifu_E z5tOK=T00Y6sLDa^+PkTPxx=?5gYHiBZYYD~YmG*T0(H4TkseEA22xAvFyJU(aAWm|nwoISY3QVE{DofhUn6~6=I`0=Oqc&biOD3T4R~KLS-%e z33JO%OZi!8t2gubMl%P&-DsvMj&0Qvloo4Lz^I{vZB{{ndh|x!#6Woh*iL@qyt6fqS$ymQK9w;6n{k7e?A+k}#Sm%J*1O}um z8h}N5E9AOXPk)E~kku%k$;;TxsxTq1jf)}=BTxVVz=Tn*DgqncBCV{AW+gVj+EoA$ zm4!)l%L@4LO~6W3N7eb3ubisET874)B&YzMI;8VEfa5N9>WI-0I+y|WM$fL^!oEJ` zKDfJ}J753+5*PuWwP_Ha0041VDg(Kn>PF&@010HwI@|$*hJGVJ9^bBCh%~nmZL5}q z6$YI}pJPO)FZn}ppq=!x^`yYMs+gd$s~&%4_Wqux$|d7k#c*%VJP+sZ=ngwQ15Gpl z5Rwr>3m z+?cq9U72ce5nRv=Ox*~EC6tOJOQFYXn>m`aq_Vv z0!6e~_9fYXXI+^J0Q|2u>${1&NIqJXCqf}YCfiH z7mcl#Pn4KEamCv3H3gl`Tb$A9G?S7v406Q~vqAxc1jHP&El}=$g;Ea=AaNJVMWw@fMY`d5&9zqyGS{(PfRYm_C6u-RSf z%9(VvoMa6AY)J0qVRc!g|9LD`HZCa@Dlt}2BPtQBPGbqmJbO!%?rq3k3o*h(y0hrGXi0lU|GzB?!F8No zC)CtR{#pSxnrJ-b|K9_YL{t^4&dKoaXbWQcGKSlrZ_hKs*U6;S`<4XV zHMYFBcKUBsj)%woAWZ86?nV&!qy*kO42cuk3&t||=LH03FueF3bzyIVM=-j881hyO zR+|p#iNjUBc;ZU%$*Os*-S*VL#{Y$etOXLZl`U$TiA*BHG#qdAiFD?V6Io%H997Yq zkWQGFFM+g-E-1Zrj=u%C1ZMH+LL0MPZ0Gf5hcA}E8JkbV%#mfBuhxf2RsmvS2PC-- z`Xhi4p7)FGJa06K*k7_6qC}o^D20Unj&Zt?E{E-Q|CSB(u<{-;z8{~~$h zSf-LFZ_Nx`bwHVhQr}}an0-^AKC{c_GSJ$xs2PvIk*ewOn>S=agbr^nsw7`)pCv!b zqcuD1BP%Go(#Fl^}2t>jem1{ER0EO-*FqIgN6gMe*KldYC z8QJGV+W1|1B5bBc9LW0fEAjq!2&d(XCeAsuO|s*t6LwBR(sm^wd)zvnaXEO=+s(TXOeb#?@qN3(dD-e zVUtcOz}SQtqeVo^a}J{qT#l9|-e5$x+>@MWXrCDFmSd*|Up1R}260@dJX?TLakq0p z4pI_t6m9xLsiTiPnde$GrQR$H3VcoEKs(h8x=gPcU!SojrUHiRebceIJ`w6PPr-s^ z9AA10)O@~z1r8lc)oUj>t30jehZDewxqE0mGwr7}3=`26x6MW$Ptx<{TKnA8g4j>i zhYP^|t;*n-iPTUt>JE;ff#&^sf{e<*m$B@U`4Xo>MxqfvJ8Ur#lAed5??fosrg9fJ zlgRSC(nKVo>tB>R5*IWO071}3y*h$PCY?{9jyKsTacwC-@wEbT+K7q|92dc>qd$zD zTg6Y&YjksXdfSu&dajmkDFeG#a63lPEf>CdNE=K1Du=4c%mjtf?)b9Wd>ji%C+yR( zF7c2DXs&{SSL!Zw6SkFC-tx!Ya~D7$rsK8LnUm}~54z9Qj>EnZsQS#uqEiUxpM}W; zMky5ObIEUSpTcfmrd4Sc&Nz9GoF%5*T2(|d?UHv;f@N2+BFbbDxbt;h3a*=Cbh*rH zDv`Ti+@DPG*a?850&G;;=ms6S8f2^0M*u>q8dGd1Hpv8&kmu$2H`60><29Rz(pP%W{okf81!LAJGt4sXU~E$J`QM``TyYecU_nPhFcR z7Cy#SZconSYm>1#_8R=}6jYo*f4zfCe67Zd5V{JD(X-x z5rA1ghlHMsLj0cTi9|qaKSt~EtxVmVtcraFO9OfOE&m+jj3cdX{MI5i67J zs$EJ4icofv_Lo|Zqpx3|oN~qR^8P7ud4p@G2z`t%it)P@V_zjC8*DEVPQ?@nE%1)j zr)uvRK@9z19gOPQcD0-$IN>wsSw9;fLv6ajfjh*Tyv}|Sz%~`i{;Y1E(jp06Z<3Wk zA4~W*jqPoasa3ZNn&z9bT;<`27r7_Km48JI#=;KiKb)aBb%_tN_gt7{&LroPE9V#r zq~AX|%toyo*-#zyq+{(-mXdbWo9f5O_{9vf;w^!wfz5b(1U^v=x1T=cuF$!{rwWLJ zdMz6;G)|S(EvJG3^aun#xZuK&;oAOAOAps8pu)8=^w>ETas{`hMoWxOmDXRr9cz84 zus5gwtoQi4>Y0yZioog}1N?Vp+7mGY7T7D4%k~(1uQ5}V zBQS}xi!GlNX3IvY^Gv@;>X-Cg`zP(28S7YH6!9g-5EaisI|x)q7;m@}#E#dmx#*6} zPBv68D1toyw+CV{zUDmcXo^J+Lm(i|8ejjUOkglNu93I=mc`GyQpHR1alh?yH*wEz z>&{-gnqwRot5IuGbzecj(s%Qjv9n+xgV&z)crVMO=Q3iy0xy#de07AY#Tpq(t!+(} z#dZh(nh-5VNx>TTcD_HR_bswF&vAcx`BIr2`qp6W0`Y%<+k3L;H>1sfnvSFqh_JUmwg$&bB723Y{gx9ksMK=5= z$%nD;uW>INH+iroX3@yT0|+%BFkV*+w5BCay7qb@%Zeph6inS|ZlKN+Gc#MoX_{xe zj=UKzo-5S~*98ur zO~+UfhSP#ia^z2xSSaAk3N>?lI`W8p;@hf6^#YTHXj+w%7&({9>ak?`mY|3XfOAZpaHWqv&BrngfcKC&@LpI=JXTVAEbDO_aKBw>io9KfK74 zzM}=h@gCqun0hqxKm@;yu7|!}#MI_n%F$4v)3a7+h0NkL)gl*Rd0UAS3Od&;6NPy4 zVtO|YqrmH}ne;-ByuGoD?|@mJYrUdA&gak8ypJ9#0JGnx0G`NLetmDVBPQSTqWB~5 zV=|VP*6F`ks#{K78;7R}K~=Ci$6d~{L+11?PqGf!Gt+x|7Yl#EB{P^QhTFm8f{y$J zYd@73ZoaZiRc^sNu#3Qm1(^82+un8A2_==*pvmN}Yk|Ql;?GWf3G!57@u~)(LQu|@ z^67FWDGFTFdTRu}ORNqjX&2>y*2(r3Dqnecgch#7-ui61a?LLHOqRsp{!FFb!<GqRzH}xayZE zt1|mQtyA~p*d`QO2XW>NBNM~>Ipcr2KmR`qU&T#;Gu%hCzgEW=dkAsw5?c>BSKURZ zAS4DbiUbWt6UW0njmFmjzxbw=)-VAeo&P*Cl7**h^Q1sGs&!U z*$fQNJ6Rkoso&Xz4c-U`4&a|#K7LKP9!wdNq;Rs8h2C1W%VmM-BBBf ztjoCFg*Q%MJmOlwA6NIN`)0nbSKT=rStI^&wyV5TIymmmy{HJ8p%Talo#(+;!|$M$ z+p|6VPZS3$^EG1-uf+&Qy;i!69(`8LR&=b_@g=_9p63d`JK$iPC5$X;K8Grm*v7u4 z3JIWwffe@TqJju$SfvxH^gPffI$AS)-HpeIKd_Nn$YYUE>#TN6@UugogD5z%!9AY4 zuT)TFit019irU4(|6iBI=IxxojjcWQ?(;?tW!Dp_Zj+(pjkT>@%@Q}kjKZU~Lfkcw zbDmBj4$-KM@m@8T`gC%eX=GlNRfp2GE3+D!X`Z?zOFFM7^r0bx!xXSTsMh*Ps6-F* zfo>U&+x|eK@#X#a1DhPS6^7)oSYf&V25}@2mF>;dP6Nik7yk!#4k?X{hPD4_IPeuS zP(Fj*gQA(#@;p4rj}2E=gXerbaa-uhfgj5j7A~o91T;8#0lIrc>|=FjiDjurFT0+Z zW5hFrwu%WJB0%oxV2%p)`MrTxl@0;KHnG27C5na~U=r6NH)xO}8lDX|d;T(NnJGcB z;B{1*!>_Nv3-2GNgb{&7DHdj6#tY_L$7v8t*`P{S{0}vTP;rdFX)X_B8l`XLF``fa;OswL3GtWE*a{F3)}S_;342XCU>2$%P)UiWxhGnDrl+2%nU+!}L!= zV|CmjB`f?+oVoj9aa{Y)WB>pI04_RRA3s{YGX-|u--M&9B+jS)nLR_<<#8zSEi@*F z$xcRo+S4Pbf_d$0tfc?|3^f6tw{Ajz0041OsKrriXQqf%DZu#v4s&J*>U(Y23 zIl_RX4NC7J`F2^pS@7DCkj1WI z2LZ^iyq^zgQW`DkgZlj!H4K_9*kl+YYw**Q`y0)-SCQ+OPGXDZF||1d=11s0E0+CAZx#Ap-*}6zS`g=W?&6|Z8vIzBl4G=73%PADSVUb%m<&_kX&`U zG2QbqjpZuL2}A0%3I;UQ^w}k16eS5>|NkT94@N5TH^0^DAClrSkmbp+5jt!aKPUzD zz^fBcJR!Cfp~8lSix~QxCbcWoB1%8oI?2j`{Ym@u?{=BTvsASnc5vgu{ap#c#;HIW zjqtNe!>f0tTL}2Jv{fAjuY=b1o)**wtu8);M-7Q3l__N{5~LN>~%HBFb+cxEt#r;MZ!IRPW#_9 zpO_(oav(p;EJ`SVND!1!vLvmu)xoCquQLKc7mqt(>iX42MFQs!tJh!rjb+aR+DdVF zeQQoWVEpEcL87Kc>M#1b`1PLpkW!OySg4E2yX3@%EZd1G8qlA33NUlyb)x4d<9>=1 zK)*G6UvFWWBn1HIWT=erXzKK4W+oeN8-b3<%Y}HuVF)9@L#!rZPngdrmlTW!CD9VwaTL=*f%~#FdgELV^RWs}wpZIZr;6*wO5s1ue`e=UiPluxrx?>((?C8Fw z@v5j1!r*DJrU-Y}wF1;#`xqNU)w(04Y9d}`frm}-;0qiWQk(yaAMoEVUJ`~!cS#&E zebO0b?^g@Qa5o7??y*%eIInISu;uJaFTW{F=;Q zS@H#8fDmB@EVpgK@bx4Sk*g>Tm`QWtQ^gwl_Lwg`r^aSm@Ui_gDQ^LXLHFn=Ppk~B z-!UaPiP2=^F|`-QDv&&m*SV+jx0%V#-V3R}q{WEovMr8;%>+O}FGA#I`TO1YU%>6aE-2^2&Ih)Z$h+p}8Y8<5*L$jBGS-a;)CEgH1Fx;4x;jt|8D`DF&o zxoqd36VZuy+kIq5QMRPzE-4QBFX5}YEK`N{GF86ouOVa#1|Ii5R(4w9V|t2hDC#M^ z!Tu_;eN3#3aENriiEx@T@e6Y6Ap*rdU8y*n8lLl z8Hp{%ePuG`xZWeT-Z1VWr%jk;D?uCpvv36RxOWfHeH+(@OW?vw#P|8?c_sRutlQz= z@+WC|fAD4qWQZc}o7Ztd;z2#*Pgqy-rM%T4yW7|1%zA>^j%eCb1 zpFO}+j)JStbls9r5*yu_y)zZyT$P_$Vp=57n4;#*VN#ev590;e?pV3Z{S^1Hr;S(%9^jIR0#| zc~DoVFeHMr&<8dw^?oSF2ljdzxo{pn0^*`|Y$j*Y8cc{RkQMWcR_#qz62P2ENayqAS16iHjv)gB z{~k_%c?vZZuN7;+Y83%yU8QO?&8eStKNZ}tpx3sT*v&2yl5mn!CIvUdS(1Xj309rt$zjl%j=kRO#^D0oW`YAZA+e|t*_bFxw~ z*F3>H0j$BRd$6DsYI=FB%YyG2gR||hxD*;p4o;A8UTLz@jIHaH&5QtOSvmR379IUK~1O!J%3YyX4EUH8=q?z(}D_0z8s=huSd zh89na&V2f4l|oP!b2>*2`9QDc$Uk+!-F}jkxUO1M9w`qCznS3s*oHi~S=jaEnS9}! z`8kG7XHHJ5bj^>7JrI%UF@#^U0^Lc2>x?{A2C`=SdWf?CiHcYAjAay!B^~cew_5H= zhlq43Kby8#alUYb0Fw|5+z6dW_ZV?&Sh`_6mGDh&jt=T5b+4>qg7 zS|l{SXRp~+k!}cJ_cvYVQdg9DVEAXpj+r&Y4CH$c2wcJcj|>_LOnxQZ*ZVk~t9{z$ z3wTO+PJ8WJh&$M6t@`ZFnlhcr=#pXUx{a5Ew@MUxui?t=x!fqorY>%g(bYbrmX#hB zq_OF?d0zIU3GA2-9TZ0P<2pRfv;n2p0O8KD03XZPe4!z>8Y?nkwMSsR+mn3YXjXn5 zyKxMk6A2YdQvE?R#Mo~yl>0`}8qJ;{(liFK1dK|o^=8!BZ_tLF0aud>H6Y00J^*85 znN5r6@`>^C)BO@`zK>7vTZCg4{4d+7PRi7Hu3n-aLdexx)_v8AyNJekTGqY}rchVV zuhvRx;V7v|l_=L6ouJEs*e%^_L$(=3vIVScY$4U~SO@DI#b`3A<(OTnEpTe#tKprc zVjCaOKWO7#QQwIO;3b|<9XVl>~^i25B#;urvy=}G)DweuD zmio0H?$Gb-E(P+?;!3DOHB_tVcxx!uQn#*QJTC`A)>Jkyr;(jP71mFAmF=la3#q>0 zZyd0Dv~uLfkW}KDh3e?V7nWMVpf=yF<570x8H$c%{i!_Ys!NJ74L&*K3$WI#Au!=8d001j`L7Tia2ra2Hm;^Wf{;E{~01rWV zN4x+iNYB(+@*d9^v-~&vw>gF6nH?dQa0Zx@wS)d%IqHnf38|$*{#RZr6NJTK)jRZo zuJ|=pn(WpJK3_@yfJL_D%GtW6Nv&XJRzKB`D1QFkH=D{w;x4;DMAGOPbg_X@JJ|Ze z%&@$sD3TQvfRw-;fET4XJ{&L2eO&`qO`9_a7(i~WqMcYessW#v+(Rlx4QU*2DFmHY z>&D1L4vhA4#F9!_&)(D%e;{?^Az2Xh#U{V0G9=gOP0hmZF1^)BJIqZkzQ3umx)qcg z)Ub}2!FyXCZ4YXLm*y0a-&d|7zr?f*H&rDR9USWl%BZr1r2HFpuRAG>@xickriZEd zOb9WZK7Du~UX;Qbg(@xlMo_}(Pu3I09L@3Y^AX0NAgn~eCnS1l?@4LwA=h;xUIuL; zMDrL(D$>}C(7e=d!Pk|~FS&tqzF=^+&=VdR09p7tLL*b)*Q*Na3();zwuoo&4vP_i z);_@DJpGC8FmVJQPiUgP8@9To#-phztEOQdSU$3+K2)L{1RIR)tUB+WrX3#<oiPEAhhsjV;9ZV8lj127LvfH zmXa}~brVWBRM)Ccl!#x?hH5DSe&h3&(y|LV)Im9zwu&5JN?%yDmQNHQ&6Dx?+f$A3 zy2@&Hha(&F^BrBeOFmyzUMwaMrc5BWDTm#91AxvY3dd`d&<_~{DIwX~Pf^3ips<=H zS!ZqI9q{qN@YatjAc}}4-{5C#EP7NIKDgs_twL650t-hanG`PH1glZd4|B4%e}gx4 zUmkP4v)WM>)CD;VUpr;-ZOXB3R>Scr1?+k}n$>q7U7wUw^2HBh2$!y8@pO32gH2RJCxa&w`zaW-Cr&NaIUFKN}+l2OuFXe&EtB5f5m?Fe&gYG>1+hQQk{e zA&K&%5+JMs4$pG)DbN_fb~RDA5cYQZrU6DpKO6^cNlzhL-NHrYv)R0rM!qn-gK&ew z6;v`G0@g>i28S>WzD)LNwCU`)^W`OzQ(UnWUXY`A9m%@ZeW-v3bPe|HgdSuT^>u0Jb^!^j_1o7 zI-=z^|5#}1<^O`e%TVVp|5w$;R|p4S2$rG!y&v2&Q`OdnQe7TAr6#HDWFJwet;0xMarhzn`xG|5a?cT3_^vj69z`soW49_Sze=+J#(SH>|yRHDrXIL7dYeJ zAQPX|;8s(=;q>})`=T1)1~KMgxDw(Yo<@bs9#yZ|-TjcDbA8p#AebxkoSH#J(l2DyHlEHM^ulix6jIzHyL13=zRO_s#YB4-*Hx9}ayLIdBFZ)HSC z3J0$3(5rGIigle=4`bPpB4-A-W3&)Nbw1Oy4vNK7DAu*e$PWMRU}Xg%Z4GvEz(mtB z`(15Yh}wF_s2fCwV?e^G{&q>7p3T#Ly$VFvgAN?59{_szMfj7b*#V-W`Uk$B$3pd_ zMK@nu^+WXp0mv&ELU5RM0P!6oYRl9!RDbPkpp6`?38I}E^q!Xx8qi-M!;VnJiofP$ z?i}r4IZDcasntAI*RK;-VmfbU3iIqhJo}0Y0sjNUv66w#qbvuUM~-&;A?LIK&RX{3 zV++O%F?#>q;=|{3+t3%r87vIfM5bJ=>lC?NF0&bbO6Kefn-41Ub3TRU{{>bd!Wh&#+gHvcL zRYkA9C03$*NnMo6vAgZ6c#64q5ChkkCkM~UlUdyGVP(gYlUJ?QGg(EYcMINb0<$|n z;*$96^k%ya`RZ`5=OmUSMBdD*97nS)m>7XFWhvq3G3n>^F<@%omBsGh!Bh0FSIfu1 zm#(?KNqs5G7um)*c0Po@+37tY zmzEG>Eey>o;KR6hX!_L=aR>iHV-kXFqWiG_Oxg}}R6qzQo%#(nq44{4#PQ;Jn^uKg z?4w-4o9+xJAjFPSX9UNvO^P)ax?NuCDur)1E?g~IY*F~pHeW%bUah{^^TV;7b@dv! z*wau-i4)a=WgVGc@LTbcqce2evlVgBHgy09=@QwWzgI^D@KLE-}S_nlc z!U-Q>w#-~9`iXRW9%vC^%Yt9GShfsAT#7uWoPk%`Jn)Ed*?{Kqsq>SXet7PoMz!l- z=+ZCMf}NMeDZH5cw5IzKp)YmyTAgvl+3mqm8ww{(rdHm1HILrFwM0cZPj=-j{{t^VvbfgqCZ?*087q zewt71mj5>nz`h=2UhUP=7wSz-bZzfyI6?;l%)zBx{7cIkS!??JWA}OJ{&9L;CrVlC zlgim-7yVka;~R$R5snYST0U3s|`&l-IP z#`3pO-_=J{_p`SUCwGftMoMFX(a>=y}#Xp>VY45jlE{)|67ll(k_m~&cN65{mdafpanTm z$mT|jZH<5{j{cM0#Wf#RHga>)%n#3Vky@VmhB1s7rOS}tzlnjgq5ZEpCJ;@e0ys__KfNXcH=ZSc#gkFjQb#}Ai?#G7#J`EOW7cqEa%4K ztA`M0Zp#j8)za3`ys~Kzao0dLb)i!x*RkP5?>}6-wIpuQ$@b{8{6M`md^Jz1Bz0CM z$5l`@Kko041ZL6paJdh#qHEGyvGH~UMwLbS2(Ulw4n>M{v)pB=oJ9i{B-}Oy&=)Nf zA4%GKG4fWeeu)>$@8)w?&U1ojTgVs~R(KT?4AR~)A6mgm+`=bAF$d|Jte~RY**^hZdUH$0H8xz1->?E{V4$gy2jo_weADZF|8fsNK73^C*M^-$N4uj#@v(z1p;``8Zyte#X#{=Zb zPBhJmvj599dXF~gs||sfmH1;nv6Ut`W+_0X_EEtK_v%+79=Zu6w+I@ClO?Q>R#c!Z zA2@~MLcq&2$cR?O3_?uC%E2(E#G4XDJn|$46_;zo48kgg&_jW0WXnp#j;lYMKpGMe z9bVQ|q4z3N_YVsp^BXU8L#&vZAEvr{UIV)$gLlyIlwmGRJYSb_&$~@05;x3(a&Q+9 z-3CibMwfGKoe$2mJp~IXewo=OsZa6aN1M`D>Y$Tz5e&vp%RpqP1^-P!TnwO*2-;G`&;ZYSBCa;i@??0E(v($U+oHeNUeHF zQkAM$&7U3!w`g>q+Kq8^S7m+~a@MO{b*CBL;{mSq#K~S+>Oj1gD_iv9_y+nlK1(~I z5&0m~jBQBrnS$Vor7=R?dQdj)Qzp|GfDIod-i%N-{@<`h(FJ7M)q zkEc(!Hzpb%&pvv0q#gCbxAfo!SI_S^szTC@ZvEYF zD{g(=w3WvesW6?jLS!)Im-9~UIJ*qZ$h2n$HuheR7g&s1SBR2EC$h4Pfj%dv#}W2j z#+ec}`&~sXwe30c^Vhm{kL|{%%PgAQJH7$G0~<2u0;<;gQum;AwUT2;w~!(2)`zo6 zHO39@-0gjiG%2mitXWTgKkwrV6}+KF$e;vmo1>Io;H8_|PK35lE;1gNSpp&cYidoe zXsMsTRX<(SWp)XfUdjPoVr)(7d^2uFqO*UC?iX7m29^%B94zY58cOD#Pps(41OSPr!g1 z6FVs^HQj^dtL188_>}k!Vc0sBTL+pUj%r@`SMihpY0C`QCocC;G@lfP_sMRP!N_nG zM5Gt?VVF9N#m^@nT)dMbRmD)k(ADBs*KCl}{bXXBtE6ZH9W1-fA-~MC&>}xCo~jK> zp&kvtjdP1J8HVNN`W9zb9m1bS*T`S)bw~*+*a%NU3VK2lNW}~oB@C4EXf=K>sa6zv zn9SOQGyH~=Klj&*PgJ{s6ZeH(&_Q^hH3qFX98v4w;q@JBDe+)lCa?7C+4;r;l>`NV zUdVLGhquDMcj6>UmLTb(9a{-V?cEku z#M}n#wtg?s1RPr0xAiL3-OQ}wv#3TH=)2~}3|j@qyV2=Gjol_o!1_D@GWS8#sWPw+ zGO;W2dnZNS9@fRKsn&JcTeth^!=cPJ7+gT4=Sg`a>m}X3v-E9jyv0(5C0BN6wFwu| zV=l1i>8tDH3-3?wAFAi`@{nA4kqd*RN=9Y!d&kK@b>yLZViYLJ6dZ%nGa;zn zUAAcjT}0ppC8ibnnT}-7^KMgxyt&51-&qr$lq;9+#eh&jP64JXnBS>4_XnwZjNn@% z56@Ez&rdha3Ap$kk09&@qF&%da+gAU3h0dfkx8*nd*&sk_yNk)b2*TqPvLrfb2bIl zGU8mW?VgfUl(lzkEC#0n*l}!4<_psa6_jYdf+d%O0w1)zjKdE%5Fd4w-2OeuP3o&{ zf^(7w^xz1c#W|1>K&cX?YXX@+7lMI$gCA7gr@K?`n2oJM@4+2{Kp_YdI{@02(=6RH zhsZ`A#8BCykzKhc+oJC*|UF_pNXT22E*{*5u+QKVop1 z2KVdHUYn%~r4lpg9S2}RnA83lw0J(OmqO@yh%EFFLp5B_OB##$y8&T97Hi-X>?q|Y zWY#5ERBb-{kpkO#1C*D5%C96>Sd{+Z=h?H)wo(;@__Ex4tPa=Ilu0+<*id$*f9RGX z@D!&$yl=V^cL8z`EQFASlIxv9KsScdCS9ftt$?ANH2N&&Y)49?o^?Awq3p_q6q*H= z5knZ-ER4C99aI-end#Y)n~--E!u&cv%{m_U+B{-+pxn0F9J-LJud~O?4=G^-`TP;6 zPRGDoslh>^VxEO}E5x^`T(X%xAQeT#*I}#|Fx&*H2(A1DBG$QMU5MwTZ+Ju>H5Ob` zC@VPXiH=nm5Cw~rPxLGSVefBJh%hsTI(&Lzqtx>rD@|!ZQ5|?r1$S9barX|h^3e|o zZz|m&Ky?P9rsAGZfUBX~Qk80ke;AH^Eee+5^jhxQ%BsjMjE^vHbjwSw?#8&xOc3;U z0bpT8bkHnVJMl&9 zq1C2E-(CL`Y1HETHx8L`#-3k+eXXM44=&K^?4|P1*$PtFqH(iIk9TepOZ=nKl!Vll zlQ@d*4>Ner3W%HwLB$(LdF5wfbZG#ROP$B6n4l7M&X)Iu6PS!?`#QRV-x#RCTl_>r z8_3nTA0#p$L~ucSOOTOCcMWYtlsLqIb^ozJ?{6EIR5c9_b+VQA>)pM=+2;`0sKf~R z9r08yx%j?Q$6Bv4OzxSk0atx#vn9(jy?-8|v3?GS3{y_npjM=pd9)(xE?Qr33CYNl z@A={*aLin4qq8DIW?^)6t$f&y=417ETQfObxCc9a3QQ8bF&{@=Go-}8$Q?KbLd zZEF_E-~K@uqA3&gNBt-py5c?cLCFEugDOcOKe_h$#DCrEhB2ai0=TMxK;=H`knRt? z?C^I_!4c^>i2sumkn8FOwG1n7&|=eY^Q$h&Hk#)0@qYo1!dA1;niB|-Kf0o1(jm_O zAd`a8X~Hk?`kjb%{3=a8P1L~5B#e>(<^2;$kmeI9IDCsm9qusfa_KML7uxwXt8*FC zU7m=oQ=xOt0H74$ioNDoP|e*8iU$zGvWW&jRVMhj5oP^r4VUqA5qH)gMNWk(1Gsf+ z{c*W%bZugz%>2im#Qm_TucsO_yqNTgPxa|ybH7D%haK6~B~&O&T`z*0ww+MOo)&d=(drNC13RbS`~>di!XkP*!hp0*ON14gkO;#|2tvsdYkK zKlx<+nTX#RU9_#WenUv3ZElJMHpTORsr`UPI~*CSFt|<;etTkpu1cFGm_9ZbdhE z&cauJFRlqkl|ddL7cI>9{giBqGcb8 z?5P2)!}t5Lu)m-CsonglUbbB(w~KBgh>-H0v5`{HA8me1klav8!Rr{JH%5u`1ySWK znjhy6w8M~arzB;Aq^>wiik0|JZt#XF!kWv`-5>o()Ukv-rbS&?Wb~A1dKmUg56w2- zR~tWuH2pYV8gXzc62Dc!zD19g)K){Ge(c=7*98lnETf6}%d(WmGx0Ge1M5{}Dve{9 z&~SU+-o9UcO&}MKMPqD`Quv)ZY7% zp77C2Mr-Cln7HfyK*Ky zlWB`S3o^VUhN!ZhS7~%>q#8u@pDkAj{LSa6mdpDRmykm`egbp08vdkZ-TW45Az_1B z?a31|u&bpDgnVI9b`%YGFT;%%(WOrXLbde_IrTo63x#IQ7A7#%L4`1R$F*lc00Y-_ zp4lr#rK)NgM+vzU8aQ?=cPxxqU71BxHUz|{J}HpMV;OzuIhgTcGWiuODurmYx~R6aiyg%{hwtU8}=P%}Q_E=!U!sO?V`+i8gj_}oV-l=ktR;g(6GQ+;rzMe9$ zIA~hK5Vse_<11@Cs+z^PRM{&qFoKoZhKzXK%__(;80;9xmDQ^hXC^Z?#aVbaHb#5L z1A_UU#hGug0%+tHWl8QW)iYxg1cYqGw+&Xc?Ja7?nbr0Vti^U^m=l{bsy@3TS`#R; z0DxMAY6?=52p9>XI%%Qga{>IUhSfB|Cnup1>#AwIKdB+)j13q5q%g@0F$)yw?k=(F zUOFx!qOcq##;Y>5v_d@N4ixjnf_)4M^U4C-&4F2TVr=E$rvWwMFs)L~H;Y&q@3aKF z(;qjjoIl?ZA{M)NQL8XzD+xFqL98=Q%heYjDP%qGoMY;n%(E-!gR*2lRVKI2iZi${{BlU;BNV)K zZ3T_TrR@#9pn^idv_(R`Mjp}YNoN(Qmg*6`GWc=V0orO6 z@)BUv)9lTli%Z3BWz^|wapGx&D5{k#dSw~u=yAfHpaq$aU9jm4J=h%G=IMb!3(93k zK}sCO%?BVU13*51|m}H7K@UavMcRAf(GUad@asFX4dW3M%;sS)3F*{*G(MAa%>5hw=T@4h0vI1^#d#-C03v}d4&{GEfw zeJLCSy1M$?jvD`h;}mkNVaBgPN6S^KAy3nhqEGdx(sHZ@$OqRgf$W!j9iyRn#(zH% zPgTnZQpzo1*aUeS**r7_>}`A-kt`gdE_AvpNzKac>bm>+liD#KH8Eb*$vS$2!hd)% z>A4ib5it_Q*%aR{uiP4-@9V5aK586oMY14FBVx(oA0NIi7P z*I2#v(MjF>`DvPV_fD^?UDQy*kh{cFm%;q72F-ckpAo=m3~wbcL_L;8g-tzQH$)Cg zHSTK(36Nu$Sbd<+0|Y?hE}Agx9U0(-Fd$KQ5K}7s_(^OJNR4OnbS;VD} z^+0Mg>X5_}KJ(wLjQtnpi)9H%-69?Y!JQu=TkuYJe)Ec0IZXu+WQ&!SWf!?-YDeoJ zP2SRf%#tobA@dc9CWcn^Q9;MV*CvuX-h|*70hLrWQv3%<+xa<<12I$-cWPx%PFDJ7 zeFC`8s~nPRDAWKTwB5l4IbYUsn1@kQrmT1YUy^*uz?$(EcXj7N+I#uquEU#bRykf* zhl5G-gpz|bNfR6)dqU_z)7ESweGZ18a#|n7?v+(W6P%3C;>Yk=!s!ir8XH;Zolj2T z-kh~grfHICIxn2AN^%&qIwqCFJ$*rfCItApjRQ>3^0p=vM4Q17L)1g569b6{oR)J? zr3njO$)oTS^lH*pF+PI|^Nw~_a}h8+ZLhObf)`xvT+B`lh^?IoDVk8ur2y>uMl032 zdc&Wf$j0-~P3W|iiC87{?gJc66pHu`b(pLSN&RZo#{O!E~aPWm6NRKD##ycM@aKV(XZ%lL-X0C3_#w7bcwzY}Bu+grmaZ;Ea{iGTDw$f4 zf1k$T#`A@DA1R;(k8F(zl=>>Ph$odPVBdt9GJ`|_YT$|=ZtL~cVby5lf=srWuli18 zrv-R~*L!RO@jh^5KG!CJA445Sy<>DVWnKgJlmA=(*Fsei&;aZN>7dl@w-HqNn^AJK z;dA*ASe#MOpAXvcSbIXIgrM3gi~%K$_?46jY?i~g?j%AVV!~~}(3qtejb3>0AouMX z8<=>NTbTOOIg~z_|=2Fb5G?p1X9CIY(FOoC#efVIRB~1jY$3P3N)|akj3;4f5L$1;!-`H{R17OD zKyB@iyyUyXLyRnR_oOgG=G-K49CpW^#Xr|^qvDl|U~8c_(1inv1@De4eC;}TcM|$UiIjMs zF(&lHQ43QK$1)C>1Z)-x24A6kweGs&ru|WcUHcVvfe9H~VbU}*b#Vj~x5l6aut?f` zT!p6c5=LaUB(z+Sy7{L~xZM`HP_&r%KPut=1^xtl8O_!oSv}1tYU$a#ku)L4x&iyO z5#_K^E>WH-!immdQDVLwsDHVo`*QX_o*MrgHo0_si)T#i+yW#50C7sCyW97Rud4E9 zNM9hD1Pja*_@bxV#_^=)4#Wq4v98*2+mTdF&sVJN=zbi^mNMjzED74<>3hZWSrJYZ zS+erpTD8=FLnuIBti?8uT468bk>21w|G1;i19qMwkkgTB4xhaQ5gAcIHD?z}qW`UT zjbneus}GO*->YJT-yAS1o`w-)m6A@SLc_8uuKjMFPLc?>U>>PF#Nguo5z_=#OU7Rn ziwyo6EyD4Zqv&lxLxsk8DMUvOmf5y^AAOW-&R&N3pQ%l|j*&k8c!qylXu$E+0G@^N zFI03NTG$~^Ro0cJw0OxlKT;qQq`I@gZ_45eB*c3iRq7vtZV zV@bhe9^0X4_rJ5`qNY3nqOBn6(qI(3r72iO*H4dX$?ZaOfiAVA8>y$kn*$tankYrO z4hKUpzP7Eavw`3@M|#y5)VdG>6Z4JC+&Q){wd+|h6>^*YD@v{fd&y^2!x6}APO4evuEoKJlI zdhyb%gkEW0zX=IV5q8zET}Eaa2Qu04Z1j~yO5OCN7|v&W%t(K-v`Mo3cr5WLMROOR z|MJ0-?odk6i%UQZ&>IrCB!NDHSNnGfqU40mjsdpZfq(!27K}lk+GLbOTr2+o09_+& zbtKLSz1j!2W16c8Nat(>K~;qlLEPmGdiFcG*Z6c}ehST|s1JAnHC1r*Te2HC%=xOj zOh|ngd@*U*=^zI1mhcp@3TL48`r(%$-EoADte{J$F+aoo-g%=r!AugC);{*79B1Y* zJF%}xB#T#N4P+64`+KbqE#C-a6g+$KZ0wL4jQKZus#m|yM9Iv6 z9=+VA>Tlpgd^_fgRHUO~d1FShn%(oo^I9&*UUFm=naoWBKY-l=tEBvEwQojXi56G| zVJqE)3xJLw05TYOU;Ix_lr>-VsYYQVz|Rm%Ip)35D321;T&9`Xf1Byz5&UZQ$if%Ox7m%GTokwRk-8O^L%~}JI(&YRv zX@7%>#&Wg)Gs#e9VLW}|x9ko~Et=KP8`*?L{raP8k>j$gvFIy^t-tEFaBg`^t9bn; zUT)uirmI~h9h*!BxU-&n<><9uGBC{GcMkRTo&c!FV(JIus>~b?O;((a@s{*_-~!TH zRPg_bv7Xeg6zu;;Lv{ISAq_vMDK}CrG=wy+jqBDUG18dnrXTAtT4)Bbo6w1^1f1Kc z&ptJ$SJb>t$!K#%ITL7{*m;%7LqA<0yN%QflE7OMUMZ&UbQao1#m*KJNP2iwJuk!( z8_SS@GLB5i3oqFH06H!wS-e=3O}ci?<$Vd2mS4|Mc-x~Vgi?dqTfQ*}7E0f!1lVZs zs~lfJ%Z_-|6Hou^Ike41()p%xEPRoB@>y9WI((zZM9a@@>(AY62-eX8a2XnG=jf7OfU0kU6Tv0E&6>K9d`ITW63+EdJ{ZyO6mZoHuO2S#n zj>b9f<|LCzQyPNDdiZykmABV_py4#p=+;dN+Tx(5^pO8+8~?Aj5MeF^yYd1}AQRrX z9!Q=k_Fbd3zXo=x%rMgYGy4g7Q{NXrG&Klt*$fY97 zu``I}!q<}RbPmmd&*gOoa|!^@D%@e@H@lL^MBo8ZHZ@L?VWroc5YY^1gY#L!fd67>AOF;?+l(_crbv!{GhG;!TS?z?52b6no?uP>%b(% z0DLxFWpXT5tX1Sz3a`JWc^}ROOWQw-LT%>0?*!P9$xa1{9czjHCgND47-|q(m1$1E z^nk*-XWMEQ#fjoO+q5?I*)`d^5ZbHDK7aJ(C}y%#86%`QDfeU&_}{9B1n%E9SdNx$ znC&Xi>fy$eo~?fjjtAfX1!2^&0&cf9y(yI5c}K%w{b-b=luOBSm=5Ix5T>(~c`OG) z0-eh?LgWgHI+T&n9&Od;j(o~d9C9}Nie2q{h~KnXHd6yNR`9TjH}E|X;DYO+(aHo# zkP2xp(RIRp-e6$4`|WI*oI|dikIXAP>~v^4X(1HkNnGB_X~JqBWW3CgrkIPWa;r_8 z^w$QVx7T$h@=%P8dh107x*2q@Nwf!!qd;Rf-=ha zB~$p4&@h0B54|9Ob)9z&yWyVaQe3ZkKv-w*GmyjEW@_~9dpS$zu`^*{WWT=X&Q$skG3kO=VD9Nn+PCfr9JZRZm0Q$gBiB2NX7GxrNAtmom8cWFX z+VS8K0DXk0ppMD3ywOt_G_>4xw|asOB_~sWN-j_inu=uax~r1*s`${H${W1wO;hb| z;q2UIV&?!1#wOj{*-cSh9!1rWou`z^MSolX8uL&L&{cEO4_chytjb*>w3L0CaPUu3 za689H98yo^-)ZZ0MR{$af#?l6H$)vgDntst`f^l3rSa*jkuu3cqnt_aw_tV493WSP zo8?Tbre*p*bFVv*2j$RmmMU~~^du=wBnJ&1Ms;Zp@)a#%XlF|>H}w(MAU(DXiLam3 z`urFQ4r)hAbK@GX>4l1DaDGyQ9R$q8K?3=r<`QV1()x*<5^rYwH_qYy!ze9HJuWg~ z4}6S-Pu}TY^(PM?^Y@D{`#2OY1<({$7IURVz^ORVv#p$R)d^ceWv9N@4aVhZSr}TJ@SK8SgZzt#k4zIAVq-ceL-8cit5h)6jMQ+^*TT zVV2{kT;4J!X#dB=NXtVXRqn~T^AQ8KA1K}RmqZyPIlt|15B^OeWkSc;2oucxCg9OswV6&h zr7T#WrHiE%^$3F*3hrN&F}VqlFs_S5!K3ggI?)Lf7MJWR)jpTBnz4Uo@vOA zd@JUKPgmKZipt&jU_B5cPX}pPj?Y61z=rnJ`k0Vu@g^dc*Pn8l_@yTKRbOZYafy0$ zX5>hMC(IFuQ+CEbu=3b3z1Px|y37dKBN}jg?ErtVhZeiAI|vqq94LKo3U^Ixs5cDK zurL@!;yQn6ms-ndO=}~2M4ud0$qJJw9={vtaAE%reA}sVAM-%LaNw45dkvuz2j@Iz zi7wwFfcYup{MrL|&|zCN5)psKP=*UW1Uj&i{CA;kfNFkssnY?9a?|M}6tLOOS95?7 zS~5P>p|kTaxuGj=MEuOzvZi<07&#uBMxvjRKy>LFTbYD_M0YjtA5dL2$3l71tprFO z|B+I&GZ@&1mM}G~fVawJ(8R@JB8zG$0JZ=2%^;sj4pKqX`Iv)<5_L+*MArB4Exrgc zlH<0lRg@)4YA~{`?&V38#N>V)Ja4k8TM-^LTGE?D8-RVAK5==hrS$;!_Q#*V8D|?$ zFak_>EHG+%ODuRQ^p<=JGbXNxb)y)4qVTQ6;$Y5vORtfSSA$m7ma0$jW#NsD?D@Wh zgUe$MV;KzRJg1VKgwW!k6?8*zp$$dBh`SnTnS%4i0C2KMHCR3G`XJd$Y9$kjw59*5 zwv#)3ut3ZChKt8`(SE6R<|vtzHjje~hOJa`5w-Br3rRKQ1AA){E7h(#E`>e= zgIat9n`f#@0Pd>s=7yd?sSzOuRQN#c^vhESvvGHunam;ETCZlRkA{8mw*(RXX{>zy z77{B~@iEFEn%r2*&9D+4kqGh_2LjoIgs6RVPa8Mgg2x7T zvuEr#GzFG)7zL*BO=d?`v5w9CI7B74h)eo()~%>xTVgq9c!8 z03&ZhA`DP8JH;ez$u z?V9WvtV}qFi}Ja)mt+R_9dspXy3|ziMCxJ!YtbhYvoC76X<@#oQCUPea; z|8olF9I>TxhJIz3aNx~9XVJ9JeAY}!n*IbBi(SmK&U*KtgNoJ*XTtbLK~Uzus#iSb zJGHWvOI>FAK;0t9EeJ z1z45}I^H?`S4`aMct~dU!U&ag80maVb5tC{TYHG(AgHFQ)&I zs^Nd8>mDzDIqtvlNb%EsO$_{oxa*;5mt+8E#ADU6qo*{I;zq}Oj^Z<_Itd7=C1yo6 z<*!g=j)M24P*eJ523 zG6gcd%!^ip9kMsCVp88(fg3e%0aI(90*b}vzHVs^MG8PaoPJ~cJ^jt(ar-`Rt`#cR zn_0-#DH~d|Deua*^LfU2#F>8{G)oh{XBvJnpT zF=9z?40uun>KRW0L`+gR#$rV2uy2VjJ-nS)Ghliq&b2#CG!n{A2gk&U|s|y zU(5FFCK^6~S3-)AazdRijadWF)ZXi2dk*t-y>B{njigp^ru>VP; zl+|-s1H}S%>T3nI=P#W$2a_EcgsL-F+}UEW34fu&UG5j-lTKV$sy>Fb(RVx8diI=} zbAvFb)F>;b6q2xe1rX9HZ9L~cdQcsBw{Y4dF6gzn*^k&7HHntmy|c0$SH0ab>rl+- zlSinb(TI&8AUv|oP$}^^!I+HTr%qO+yK=3KAmXUt{*9(ES`k}w2L2G8lqS5a!E2zH zu0Bq;LS7rnmi)*7I;?S=@^fS}& zxG{hNHT)Re%f_<9DT0By@u;OyztCYIA7PX1=kTCe_~!S8Htf)e+TXFuf!XCU!}&IL zO7DhC^2-!z&tvTRY$PzHz42@OL8QZd@%<@9XL~IN<yv(=0 za(#c@)E35|t>Sp=8%rOV*F)#v@UTLTm|p#EIN`(YZNutX@4!hXUJ=2tI*1kH%^Y~1 zt9@z!GR+v!8j_uw(zu8?yU>&&bU6M~UFvyhOdaIL?SR&nBU0Cdm84_ky+S->Q|y6G z-Nh*xtZfs%3|EjwYs@i^5WTy69;1y?MgfBhTB>DG4E)FiiD((uwRjanE`ncaI>F-v zd%7PRTM|z(>pg;#kr}1*b6D+}`iwlZzLMBuayrA4ACkuhnu7p0`gApaeOy>9Rl@YN z)3q=Ru0At$Phmmj2*umzkK^$CU{Hu;i2 zaI7|C2}?Kr3Rr-<`*_4n3=`zQWkMDNsBX2ksKDoLRP_!Ss_07?qR!uC>>1t967cRa zDMXpwL)F`yy<__)V7$i%P;Gib6p?XH*={bvi5q-*5mJ2N(|8%GsVe~|I@Mu2O4X5L zBAX+29IIhH$Sc&?6^2Z#q#C7V+%bajzvbiJ1HZL{-5zo2Fr08m4!#4z;U*wvS8xxj zE+s}D;x9s7!zKn+J730ykS1DBt z3lHUSBHV*e!=#jb_?v*sLDZC0<`W4Y3&^J8>$BJ#LjV+_$9Hd~Kt7=W01tivpZRGJ zp8x<)j~!s`?9o~kTALqoSFNp=cWig7Id4I%DkG&pAuVpdw#F&1Lr+#-U02FL4XPZ` za^C`nCKX0*3-<$MyA%272q2BX0mW3$cAoGaakCBqodM|=jb8Wo+XC~URZ)NmAKxj- zy&2I2YMAxs;{l7bHzqNTr+g-xK9j>jG6jafv%Iap{{Q&&F@^7R{wdhg!EP`@_p!zY zEb`i!-#f$M`0H{Mo0EA|HYuJg;~oxoM%Rql*FG9Ag%J^y;!Zf@4FW8-Eh}6YVZHRK z{>PmeZ?8FffaxZ6#RuGzx17R_Nm2VtT#)UQVhx5N)upH$dNv$=WuoZzr5f7u?i=*F zdEs5RXg|^Ur}Y>rNeQG_1!~VzE86>zM5ZHthWfjr>pP?}wEUBp)%9a6S6arCCm9_m zcA)VT>j}gxO8!?mAetWfq3%?E~ZPtx5?sEVE$~@&(db{~6&0?}B!z`twJRc>Zn40>Kway1ccLk{G@li>UjVjK_ zV@ks>klTC}aF3DhlZ8sL-}fSb%BA9>9^8r({|lxoWdc=bXe;_tyzKBEO4-C>cX3 zawE7qeSYdAd-ccTu#EO1&XiFxO154MxCm=eB?9~AR7rw2+wy!a^2OkqZ|##Sy!6)i z%O0)aMDZNEWWnSh}`<@(JVu+dImIKHd>23hE=7ONphP%F7$^V_}x zQXQcl;!PuUXHu3Ay@zgKN@X8>>wf}ntzg~yZ21^5wZTE@5?@@`W47^s^1ibYZ z_poXkxpbxX?r3)RkPE-#hucPpgXPsk(!|1dk#{rL9N3()w*{PC8yyr+4{#`X8+4_|Fi$cqdUj ziBXHV%cOsQc@x!DW-G>J`3lLz+g|G_0&5c8o=UjtB`n64)5-eqW{s`Ue_utN7F;AjrkHc`(``kF9x0zoBeCj>eI2Ih7u`K{@xZOb# z=W<3)Y}&7{CjsCV$sW9T^ z{*jxdH7gj^*O}K3@#6f06+JuIUA70{8Mf1=oJ>*v6b_0I04u9}By#oeJ1OlYzJ#VB zwX45REG1?G^EkY;3sH^n$E}_ck`$dyJkZo_HWw@Xs^iF?XGYb+T|J@FqL0%+OUd@L zZTjnw;wMBvlkNJ0BZhs5OxJpBl*A$>w~Ira+x1NiUS5SB^ez@!Vak;r_6efDZNQw=a}G4D2TbJf;-FX}wf3o|E$25y)T0$@-c-^H?3|7LX=@b=?Dvg-&!s%E5sGo4F< z+G*T7`f4|N=9te;0GG`NLV>GeCk%~;0&O@AmF49~E@g8pkA|hHNU)h+<0uoOZe~|t z_m~Ep6YHSvFCorI8^G=<`qc$Y9nV{O)tSUE2w}iO>V_0+rV>A{%aq}HL)T=MH8qx_ zW2f$ExMSDl5e$`BI|17bihF-Qh5K}`^n4;m?2`a?j|$>=>?q_?ql_}m9Ie=7Y~yja zPK34yWF1%DTzk`$i#`=Sk%Px8@coZ`7Bk4AxpSZxE9lBo2Ey7wYCpM!ac8EZslj_8 zK4pdU7lrQq-}ihQvlKmsFM&vx*K2!bU5MfkB-$Bf$-g?gXHstLitCUl8pIYPcWYGn zc7`W>I|uKJX~4^o9EaM=Mu5-@F%}A47YR40S-X;)QJ22+WD{+u@O5p3+2r={@m@}n zVzmaUKdS^kMQd3xttG(g&@OA;M!0?YA}gdo`eLaX%^-Tu$}cuY1~r6UwO2x{jA-S& zueI8$!{`|x3@EkXBRFia4~Jn~+=#(D2 z*tVwgHHJ9u5$7+}rG~|6BZ0T<`rsDYt`LuaiJ7+c(tlVTWUn?coYRA9W7&n@Ro$it zf(+D29nDF5lRar}xLw5G$b|r6CO+g{MFnQW4_K`3Ya7{--Z`=UU-D8^W(a_JBU;;Q zfYtY^5-Tva5lHWf8oO#A9&YKzY%*$^pcuDR-!zQ9hOS$mwa-E#x6JuaBMBqBkNt(I z_MkVE(gmTh8`5^dEe?mI>0LX`M%~E~5mNRM;!$0~HUl&YMx**AQJM6R?jU8*J=6*g z?n8&Y*%~!Srgl5?ek}4GlcY{2#n!zdW4ZSsNs~fd1h9y0YTON8p?AaX+P5?mj%8dsQrL|miHP2Ek zm)Fr;%rf`?@^`jKQynzZy;9RqbGo^^y&Pyt`3xJpo#Q7vNYxKF?~TMTa*|nH2uJ*% z2gJPnrQ@J^9A^v>m*n;NT&$n1ez~Q1eS&C}zR&SE%UIU1lmAkFX1an+(beOd8n9sc z`e~)}P14!bfX@GTT|~3-EusP$eq9UJ~c`O>to!uUEj0+k*+J_w|2T-?5oLZ*+ zMaGhvZN*}CniJb#yPRY{cZRM+D4R)IH%+VuP2sX2H;q^Ps~ew}{d_v6$I^*;-F$5#oJaxQnGp33I*11=lx-p!pLa?Ptn*rCGL7Po{Mo+vCADG*DE{+ zGldzi1HR)Mo9L&FSC4{6NH|#{MsJ6as<*Ovb!e#)5Dq_9sI_~Pd`s+$I1X(yKq>p< z`qm}K3it<1cBoCg*cI0a5M!UfWX3pCUYy>ZzqWOD5xX8?UW%}BPJszvHV}q&x5hne zSb@bH^V@c+?HV!Ru4;Lc;!fjyKymzVePR6{>YYMHhqa?qSEDG#H3puL=W~6&%v+Z6 zQD|ajj0x0g2OY5A)6p&D7&+Zr>?$nE{+7NAE9E?R6$CyX(O5a(@73~e06XywOXZ>8 z=NO)owuH^ zJ}D(8Bm@!Mbp>0i7fko+TIXYW4H}1zBR^f4xqPSaB#3LyL}!cYJ7 zc*RrA)1XyJ+KJww2vcJ;r@(6Do6wX17@?ys%;uzv zT+AGZl+b_S6Od$mGwJ1mx{r`SKhbk{KfKoaEjtV}>y_`wEXA|akwE0PNfh1P&hVF# zMbR71J0u>9h32Mp%>*YCgm0wYum6!hr5O{SqRJ8JM^8q7^+3%e97j`p2cfS66#E-S>5q z4Y@U-HvWwUuFtg;*YnW{u)wI$00FKi06Alkz&<6Cq1nba2Ppu}xt^E4SJ@(0jf)Rn zD2&|z07b7hOaK5AqyeA%ZbE+m08gMh8;p>;xbYg~AX_x7x=o)&n-Mo$U$DHi9seZR zRO8^X97r$^5*cHL?i4uuXlv$R1*T^Jq4YA#3WD_#jeVDYzNug^mjD7i_0O`W{F!0q zol_A`$kgYkxct3k(_YRoFojh6X^@zOag0^f>%~KqWHoiKc3NJ{zv+H(We}@)x;&qE z2_pi(tZ>TT|MF)*%@PMGW119fj)7T0#{u#%Oh{5l_IlF;g%>{vQ#F*!jF_-jPAK{J z@_ROt1m+ioR{Zv7Z8A+%e#L;sU~l{+-#w2nJ`ipKo?%X4=Lyd#=i6f;a_2HYxXoMTSUQk{K&8}Med``E z<9b^08krQh&6vrs?) zFAxRT1V*}IJ9etK6L(jzsIdK;H(mS_JH+{_6E~(dPP&1dV5v_id*I&KgH8H_p$<-W z9}+eC4K(v|Tl*E@YZ!Y7O}6NOrb@Z5VA5>I_#5g$ty;U%nlG3koiv~knXRSnzE$6z z9<3}q*n$iYN41KJEKjb?DyDVw$2B*CQx`jWmb;cTHfSYBy+f!}0v4;m9;^X6KdtH| zsaguhD#a<&wgkzEW`IGn7GBi2JFqMRe1%EaTGT4NHwP>*@5MnobK5}b0rMD*<@(?o zg8LnN?J0uJ2n@Ax#)l=3R$+r8p?0AvEu za~KP~?M;Bq^p0bZB#&~c-bEp1)FVlZdKxV#!)Uq|w=*vE5l3$&LEbG_RY)JSNW#I) zkncr|A9K|cLBT%kd&_kXrOPoVcq=a#2#E?w$?`#oFoFEkJh2tfS6T$uwjs>VY;n}| zm!v*VolsXz>A9}0AnSX=cp8;PYLI?p$4-^~xV30&ET83Ww`+mMsptt+<}fvY&(Y~wa=5u|TsSW--kvSUV{$-T zQ2GhwZz#XO_#x#g@kPUNw!LJZ3tNg7<>bvjm`{8E$Rz0P()$cU8D65-C)jDs+ulbR( z@Wl4q3?(Z-CEn>wUUu)Zwcgttz&WVzKV}T<3Q}`K`s*zF>oSvZf#$9ec_wX|Zl*dK<9Y2#>3~5e4Z|?u4C%rx5VW0sn zdSn**R#=Of88ub+I-Qvg+?~QacJbn?}XB z&%>UX92g`?VAV|)_BJn@K-+=qOfbNgy>Y@@4}MV6_T-xDfs|hBwn@P_BbEk}*Fztn zSZ2Rp2`YP}vCdKY?CjmvkEni&5m>nsMD5=pJk=!zE0N*IW^ zoaPqiLzGDd-)el;+^8LJVFrf%5GjxFu*dRD)?edo9Zy`Yg`*Hls> ze-itHAk7RzF>(gMiuq~`dft45Qrg!QdG3?PdNU2@${LhBS80n}RG;TML!P)7DxuY1 zD3;XKCrBLqWbc2?OCvAkL-$oS{2P>v)xicksJBA;37h$0-t`B>IEa+-nM}uoR08mX zp5Xg?Ya6%T#bmANYrlbPZ`yS2uq2c|Fx~kbcvK#`7LkkE&U3SyD41#3v?vE1Zbst# zY^Pz%kquXxAF@vU>CM75;4I;NU~+LEKJ-lU5Hpsf`F8z6`EO}2wal$qlTX#G>g$?i zb`-Di%*H2B#6!^075cx$=JS~&(K?Sj}rKHqs%wzjJzqDmRqSEfAyQEw1 zp2h|TT(F)3G$c0N>}T?1EZ<*5Kvga6kKBfa82wNuJw6AF;#4 z!M;&^4rXSBmPAq^=I1z;_wjtWMj=kdNFx{r^?{&;#10n&uz`Zf&6RA zrIK=6J=N+kz5dlgC~Z5UOcVvRN%G!^q#JeQ*SmI6ID}|?a31!;OK3K+5YsZAY%JK6z~%VL#pE}ClVX+ zbhtRNfbDXI#LcjXz050@M{2aTB(J7x&E*`U1Uzc$;_>@?0s|a9x>mC_yp7(E$?Y~Z%p|}q+ z7DBOl2a}60gZI2iZeQmuZpw==1Qn~5~o#B!=K1qfYFDeWJOWPW_JDbx^-3(G_* zOC9&1eJ<*+UXXDz594XbSK7G%IVufut%Ri|XHyT0(KG63gmoM|$NtNnM17bnO0Tj> z&q&1|6aAGl3r!ynKZKaR?!*Dy^&ChVL(V^-tiyU??SJEeyQ510P0x$1*`@@B z2C_vIa;KPqz1@C!{>QpWO8BLW_Rm&dY)KTxDaRNw!y8f5>UEXr0oJ>&HY)g4k4-4) zP{CfS;PHdpqg$fs1B6@+ca17-Sa5%iV)yiPAUT?Zh&QQVemqILeoUfNdK$#;t6KUD&Z`h!zmwIVZ-@Vs z?8;|Qr}yh$E4UeY(~*4mE)?byZ3A`TA`QBYd?925=}MOzylc^=@`Y+a3YH9XD6%ez zUvI9S`!`!M$SwCO^n>nGNtel!GVu-Lc|m*%z+d%Cnm9c|Z-D^9ZJsX9(-f%*w&+%GRZqGNK|6kT-=&v|8x^bN7Cck3dn^Fx>C^e{J zT>j(Aic(y-7RVESTIJ|ab~*=fbTS=cz#+9Ga2IVTPy1`nZMx%|gn&oK7aYbYRn|^u z!$H*?<9C<_M#?pP#%bW;m%8e=I?Lt#`sGnt5H#v`&V9audxcb3Kfa4*K?m*$8Hp5{ zT9Md7&C&~nFvw34GYR?p!$~8H4lcnRywnV~xnH7MCuUlKah}IDrSP4Z1bxg(-!<3) zfePq&z&V_pI%_h9ns`0xH&aaY51voWis9YJpe?gWHXu4_S>Df zVLYigkvl~?pJ&j#7QuFV)4A2AMdE{^+di`az<=N`cE!3`BwqkthV$*FWNi9n zgQj$NFb;wvq9!lFqJ(V`l(vmAc(Ok7OH~>%s#D}MS}cqkBPGaAavV=>rjAj1@%-&v=)T7!C`-i)yEOKhCJ(h zN=IXY1+(q9-72e%)<)_=cQ_eb25#BkD>x~j8^MWdqS#K~aGDbtSab~e9g3t9*n3*A z4P1oDWDgm!Q-%i$U~pw6Xq*?viYwqw0;NEuam)u~6I2X^u<}RFSdwtSK0UsU+6HFei?7vbU}wo&gl7kFtPZ1d=Tld5ox2)a>bH z=#I16nCf;MBtyA>lI}&_DSC%=uV?+qh7*JMB~sn2X(z798^G+VBWG%EviPy)zLx;o zzn4BBM<{U0*CX1jMs>3X_@lzuAbWxdZnoa-P?}wN3(_P)%NxHw*%&CyGW-+hS>-q} zK8~&JN=CURI{n=#!akD!Anps1h!aesi2idi&V0c~QE0-;qILyHbQRWHRq|}#&E;Y`N7hPmYR~x${=XOf1AB#lMJWu5 z#13VI0uyui`7tb`0f4rLP`DMZb60dhHb6$p8{^W}fYeZW$ZhKokg)3yc8k5jEOe1h zFed}7dTSP08-JD_xp)FiA_3KIw}Q19;{pzHL2+Sozcaj{+dqiNKPT<1WwE&UJr$*WyHXetAVEEj6Hf&wk2|Y3_(tnq z7&}VJ$=>!`_e`&%XqC4g?=+s9S2-#*w@?G8taBU{;5ETgm@Ike(}MFZfZpf~~r84hp<44rumM@`GLU7xZTCZr1 zYL6b}7u&OmEI^LyPCmC)HXQf8)_vS14dsE0-nY%0w;<%7;LZ&OC?X&Wb8ub~dL(}j z2=Ss9?avKP~kfn<*u$FWjS2Vp~f8&fXMubyaqK| zy$s(C(~pSJOP%gFPZlRDn03Km>o`?jp79syOY$sOv1ws-N_)572XL|I1)fR1=G~Zs zjhDC4f7B`eu=9R1q^Yn(B``f`VRP*?lPGp20X;yoDSjUx>`U9m7ACd3SV&pSQOFG> zKs3xF3#(Z2YuflSN??suB7RTBe=dc4t(cOvXvY6cT2$N@l$P&(FB@WDl-GM>+V~4qq|4fdBwV z)j^x!H3%)KGMEH6|Ng2~000h87w?F0im5xO0R9p0Nt69S9{Xc7h5@XYVL*3&Tq8Eq ztJS^~L+v*@^HAu)I^FGXr|bW*tGI&qYphiSeFlE2YBvoXy7yC%Tyf+n7ds~bCBd|5 z`zjY?0DrAwix24s8jd>l9Nz^b9PId;Fy91m@N@W52{A`Il?R!+V!$Cxwmp(+;zYBd z{et;t6CiKnpR7XFs{4gQldJSuEpjKG*8wwkWuLucfb)V<$zSj{Dh89Q!<6r}Bt zsFdz~Ur5ubkcD60E3!0-sfB=j4Ynef*+$l%KtAZHMsY|P9gbQ<6C{*JTkvua{3n(PbQegtZPv)$;1`DfKcvUd;pm+SBi*Xu*$SV zCUvv3UX4y{El5$FI|!JKkVM~4QB!7Pi;sJ<&H2U zGnVS^W#nfS4d<%cnJw`PH-yx)!c7)or~kAcEq;RnlLc4S%e1%BvJFIaX4+49iMv{* zR`~WRD@_hrvp)CM!NNa24P*&9z2b*3JGtqzo7!SeoX1-rP2h6|1{JaF62W9o( za9ZW+%OmgX3QyqjvVCIuVo|~f%gRarin8vz$$5G_VE`KT$M}kU_=%zL9R}e)w7VtB zY1E?V7~8?wRBY@jHtlA?+cEYiQh6}v~xw= z7WuxCdCjMR20-3gOd}!oV}?-#oi->}Z`!xU*txvT6D0&0y=D)x8tw3EU_Ww(0*eJM zcTzh{=IZ{(pQ=v^hDrccK07qfCX;rqBcFRID4){IH* zFGxQcyF%8qls7N~;9Pv$UEH|UsbBaUpY9dghNBIf-J7Q_)mvoQ>&RwfVkcV~4KN|Oz`c-arO%HD8 zC-%*rE=SjGhysMJr$JVDS7wIn#SrvrLa-~<%he3$$Y*Gw=SGl@m|=)PB^PM&N?Z)) zCh9F~k~(`=;ISo*xFuKnN{>JB`v-`y{sGv#q=7HoZLo<|g+$MPHE3MHZ{GvL<7&5!9Wp24fg(k3A>UyFC+H)^?kNfp^*R_y@vzqZ(MkKvWE+ zQ`m`JDHv^OVgWH$7sN@|uNU2JFu&|P>FVrxMIz*-bWJM&+SJiCxhm4*;6lXCx=u?8 zue3u&pSitk>kC6e!FmKw-SRAvFV3^&vg;+iW9eC!410S68vA&!UK8pDQ%Y2N5ee9p z+0ymlOsb)(QXh3||JOsEYRvtiae%Pz=0DF;0t0x=c(YwJQ#VUD0=16aI1=W6e%X@x zYT5kfyE{ycxM4jREd$uqa+CTfCG#l}LR55&MgLaj+Y0V53=Lpjja{|+E(Gj%#&0JS zwi=c9=>y!sMhy@MV2DvD7$U-2t(Y(eeuF)x2PXpi(p?{CIOKvIWSD?S0-8c7^}w%b z0KehEJ8n)hEn!53tEowf)Nh|J?4`v)c$Pn3nSG33YEu2y=`l6u+hS>m6Ou zvjX-dEtU0j1z-9z_5=}!eL~C-&J`>A(DmgPQ47rbMd=lOdG;vU@(J>qy+eRx&f}%g zvq;$4?6h*P{v=u%GM|2LFhC$6oD&YvY3%uohKKJc!r9<%5(}cooGM_XEq`CQbh8$m zxcYnm90!x+*bNFR=HaDJHYT9~;Uw5zmB{#hb4{%vMXxK0e+q1ydHP1R{aUr4v3(uj z1yN0v)haMGi2&VnoDA&!duiz8a~#J;hd9m2?|!wj z6(ja)e#-roD2c(^z(ji0N3gQ#TMoeVsW>() z?@*Z777T-O?*zh}tumUdSrL$kNsM(gc1k78wAGebXVI9;8M(*&q4B&f&p!)19fR|* zOEIpcg7p^@Wii)BWhSZpV2z-;?~T~V`2NP4%Ts&pQ-9lDmN6*Z5#})s*9@T5W#$Zv z^cvn+tw#{`pz@sf5}J-Xhz7x&9U)Nk_(}G1u1a`*kvRTUZ&d0%l*^-+=cCc!QvXw?#b z9LuBMBG?*#?k;BfqFl*Ke@ogLn?o{*8U-%J2}Y>I@pYgx4IT8EN)lev+FmYrJ7p26 z++@0fD&Hkzo-ROdA!BK-bx+0|T=Nqtj zJEap))eob35_@ z?KmAZ*4D!?J-I(lIEeL09>Fg&$W`3cKIl`%IW)E#oElN}^q29S$GR`#C8^ID3Rzfu z*U97B+^1y@*$uO$tY{^9)7tj4qZ+>#sc_39@?fi>lX5$CY!Vw+gpm~8w6L^Y;@L8P%EZ~GE zw3uW|9fcP3^@vWGf8oTp+-hon1b6MUCCIAe7d8InQuqFI+&)YLYd6pY3E#L|cD%*m zNX3s_MxGc+XZql1hiF(0Z#w`E0UFS3#2w#C##o}h@bu-NQAuoo{GnB?!X?Tns+TN} zxme8-zt*p8f#b>-apsvvfH&GYMmCX{hL%aGBv{$oi)9X$!yC3HL_EJD1G7ih+yT zA8SxN!o8KKobdcY$HWT0GKcxOVk+oI59dSdQaEwpFrJ8M0t9h2nYrMXlG0@evrd)W zT+$|eZpCZzxpfIwU|l?Tn07E>@v+sa6%%CDMS0ZggjaqnB3LCjB(oKJLW65M0u@#N zp<-Oc&v1|*%L#su;RLoX_P@LghxEyKr__e{p6|NLkz!&byu*6F$>K@kv?Q!^&^LYs z4bB2Vj$~bLGJ$q=?u%2|ge8T!=kg^hew{7+Hm)rIttZ-K$ArU3hY@(L!4_V_{&|?R zY>kS{ zk|+)Vm5zm|d(RU)=IkKdDr&#*?gsw)mJXL{-n|J&0h=PM1)-ixQRDoRzr{dlAhOt3 zVnU?#E3!C^#hVsJFJd%MH*#48^sIKzVCERm3+})m!ZB}I0eRrrg^LeaOq2ag)j^28 z#K_r}+!nN%!U@T$j(GbFe33s$o$=lPL+}&=>w$yYwRqWoirz=W#{I&KJ^2%OEYuNe z#Q?21NY%{DF3}Y|JdU#G=^9Xq)qs|!HHuHE>Mw0o-iXvhHyB4T|M%t4Bzx@*@@QzT zxr0pF=jNA42w83)KQYV-x;TGdypZ96>ew|6S3j^{FW2Si6`__)-)yUIiI!`P$~mo- z(FS$bdXqFztyuvNt_YViT8nc7(F)MtRm#?WXXgKu&b9dqwRi%tCc~C*_DQWcjfVb~ zq>@8x0u*#d(g7hl@pt&GueHJASzJ>jicZ3eUg0Q|jwZU)Wa{C40=!56Fqlr8!oc9B z)r>}vQI1rfxAduc7gGg7+YdJ%R<5{;b%ZuL92$(-+7~1mZP=M-QC26O`I!SZi?7@% zXylc9tL<@r*(f++X@U`$3gZ&}3@9Mq3#h*9cTzd342miO)Cs1;o`#afLYFy+)V+>J z`sZou&TClXv;98jOMKCiD(E@tm|{d2m&aZhFnMfDMcd=WWnKJboxhf&D8R(siZFH4-Db@hQ?CE24CaqY7ZCI9fg zUHFx;XFCoPd%RUrTuJaxborpL#Pyz=z@*J$E#5z()q#`3D=*NR_X?FnI8989jL8tg zJ%lO-9}C~CoQ_M_e|_iWXZ%asLaE;QPV3zovGkMxO^;Z48CbQ>6?XB%N~>64U+&XG&Q)~&+>zKBkY5)f)PDQ90yT)x4Uf<9~gEYI{z+TO!d zyRdYrCk9U0m)tGsXRtzq+7ggZpEu%L2NCna{NFlrWEp?J`#5UP$KV?fje{9FhZfTm zD|?kFSjkzhfdYC;Dz#_h-LYLcbStTZj?0+w=-)6O{aNb4w?eL^T|L?``xsphu7|k+ zhf1i}xL+iKEn+r==D=ZI5}=6*9>wXeP^<3u%r~H=8B6S4?NH=+XrA(Ipa!pCg_`fb`pFn5s1D}eyruh7fqmy171YQ zj;*S}8ttR!Vb5MqA0yRjL>-a`&V$r5=Ugg9FhZd*yH`(R1MCBxLk7E3{r72NYnKk} zFjARl^qj^u%9uSN#x-AbR$#I~2PEVYCqM`MzI~)~Owua!J3Ys$_h%VQ{CHzS%-*lC zDK=50S_x`XmZkNj8YzwJ80J&-dZe0~8jJ8~W>V0EfDK^xJwJ+by~X{e(CZmMu!Igs zs2cQPgc;gS7{%@tbC%`)2$GCUbfzc%n$+A@rxpM=xAz+0&!R*P*VGr$T+EcE;RT%c z-SHty(k!6h@uF$zZAlR8p-|ex0JZ?QN)`- zc?8Cfgy(%6kzn6zw$t?BSvC#$A&O5~RU0OG>hbsD=?O~AOXvO@4o9@e)TG?brYXU& zFzi5|$kvu*dcLw>Hy~>^i~Q#V-Cfi`dxghP5hyJti7vxQ-1Yni^KTu7;Mh4VwVjf6 zQ4MV=h+Q>|cT%{jHtO+941`-q2eJKvO@xdw(4EO7F@8Rfgq~;hlQeZDeV+`q$zE_{Y0o6{~!`tUj0<{|r01pzFPi;%W9vhfDcCq46Sm;gs~^4wf4-?Zx11E-0o7*%Xe#<|enE-o?o0Bv z7lR^%JbaFwvQ6O>XclOh9W`HL_`17HC+iTab7GhGeOZ2Z{OnR!P# zXzzmUyk;tkelB*0d;}&x8)?&EzE}d)GhK5$J%Qhyj~VrXy^!VckeNkQ5oUu&{#GVz zx@QS($lF~jm~?g#et&PAGUHo^-0_>2yBK@GPMg+JHsgY&$|i`?5FBq558zmh&h#5E zvT*hxMs05fR>`lP+^!5>ZMo-P-MCPNSNk6PcynFc1{;cK`5*YYR7oQ>_pbpBI1S{R z_X78VDA^3$`k!l}j6=oxocbmxBZihp;bq|V!M)k}yn0@uqN3`)*CLu`&kM3x zA=9taZ!~xKU2|l-CgW%FZCJWC&Yz@po}UIat1L$C2o@qVBXYvA?XITSDR2`YGM1w& zJ)5-XCd$OWM{eu{i|a^DK3RD~RbxQWySABS&FwpmAI(u4eMG-{GwD(U^}Rz0mFLxF z7B=3!O}fb0k^RRz#qM{H(G2*&&0;AI7p1e((monJ!?O(-PjFeY_VRm;0`7>PsK)J< zp&G9(aml7$JMTXv4;R*h3ieU&6e~Zf>D1=S_!E9)VJcR9?!+Zj8$eHsID{!CFJ@F} zj+Id)JgzuWmg=xs)gOW+ug#rjFFG23^5pkNR#uSH&ROEV#)1vgGO4Qg0#&>ljOR-m z2De;$zC`NYm^dJ{EU`HrEGv49{BzR1D*CT72hA@IuBMZFIf5@)2YGl9*pJ403NMQNl z;-5-$wstA{{B>T?a&Oa1>9FAeUp!ih#UvSjUj^+$> z{1tG1q()esP#TmJ8RZeSt6|j(PCBlArOhaB;2DYy_VycYV1E%F}e759Gk z$KEpN%^PWpAabS&yN8C;VcQR>ux_`Im9ss2ze4!ON~E>{6nLFnH2=!K!DcjxL$A%n zmGrhVo=x|yM#>#NRc*j*kb;l+SuJ||`@m$ylZH7r3`o$YWy>96W#7HwTmlvMH%E3j|dmLSvnsJ30x3(Zv} z&5ziX5toDVmAnA*VvTIhdviH}5QQnPBYZsIGrZ!J)KJCtPjl|IV=|c1>5Z7i!w0WK zw9MoB1WH=(L-xAG!TfneD|Po?~TbqgZ}}fkbBd%c0a7 z)YO=en8rj^(OqHlTK@MplQI@t%J`zbk`f(Jh?P@E`Ob@F_D!QeuGH;Cyx5AdfbWd` z$hnITul!EH+1fAU&Hx}16*Co}y0xU8%;*9|vtaWm5_`^!<*3)`&sWy^S)z;`ygY%I zMp}D>q$CvOdBUZ*X@QbwLvG8*1tVR~A1s=9@1D9MTcMrxyq52|;I5dDp_kSbVE`I} zf|*EBh@hRmjpI`gBnNfr4z>``N-qtiQc_WY3(37s9x$v)BsY&)sT9OdB-O$T!uI$Q z?^(>W5RZ*qaATwmQi7CIiFp*K92$vGZ!BVJ()Ve8ufyuE(Z7!4Ezimcku(A=Ts9TE zVB{b)vgL2H_alsu=#oSdCn8tj$6G;&Xb!v~F z)?>l&x9I&}BzAsZ<2Y^OqYIKA{caD}vc<7?sc3SX2T7dbP@+*Y&y}}j6cKJaFF{=J zTQ(tHlv}Ej8=!lzrW;aj!C)HCiw}1k9#Y6H3B+j^i_PN8N{p(C{;aq;TpA2g^6mL2hc9 ze9vy;7q()uMyz~Zj#;d0L}oM!*cqC_5r#H}?uLTSik`tM??KdW&pl^GKtJ!y0ndz9 z#w1g8CULVLq7gK7SI0*i%p-uPnygSlg5QT|r) zQBQw)wQ-Nyagypwj^%;_m2i8Xx~nx(HVJ19U>ue=Gpr>%+22xG-0M@z;@)$?UYqHo zK=Chcfw&viM~sg00`=1Adkz66gnk-Jsd>Wt{$pe(7cgbKgUuM(ObgaHV}YC7c)S8S zrgmpbi0vJVsRV>YdI4$((wy;#Ec{P%i)8HY#z{3`@Pk9zwhVsFjEEB+gA%a{FS$&S zS*5_2l)oHKs~V)jd$3%zfLD|D@0&{m+be8pk0^0rZHgWd6) z)4{*X3|tEsrWFVtHG?VF)l{il?`&r?u{l^&Pb8;Vy_f6KVa*OiD;;-&Bph@qm|o9Q zIEt>6~Tiy+gp7%)z+k3F;;nK-jpRd8zHzog0(D%_b{v{8NO;r?p-)K z`2-pO<#$Y)^3`i?Y~$-9s%Rn-O@z*g2wvf&%cfV45(&_H@@0_UOKfu-- zOtgVY+Z)75d08sxxIP=P{UdWu`&Sz?J2CtY@atQ&JtnBojU_CbwiUGNgOW|R83grLW1zKe zLi78ef=noKjus2Q+0d|ev?op)1*93wqsOUz_2;j9((?8RJwvqIcPfK`-V%41W2!Pu zkvNytyIb1>FR;!5(Y=dgRoun}D5uLN%xW(EaUeSPWzlF))zH!400M~U4qg<0TIXAV z7QoS01<`X$6FT#91hbNq{fMTlxvCfqsYL7I#GnF?h2NgnJ__kdQWhidOCRx+oQYx( z2_IOE1J~;d4QZAFLc3%lY)zW7ZN2T972y!05<#UPY^zP37@~Xr4{;jPi7@EsO%?P` zxYW3vXysM~BVn`@2v59m8mSGLCBZXr(*Hr!G|ehAv!R zO!g@cY`&cm=|T=qk5C!$yg(g>quF*`?&Ac(2=9WvtD-1(>adaFM<`jw;vojs zQ9=TIkX~dp5HW4GY4NPC-{G_ra4yi>10cD!WMiaN-a|h_==rZD!~c&5Kt%rJccaGS z-6LfCk3i9&{cy09)+G@5XOh3Ko9vA4qAngzD-|vhR>2Oesj6MrCkC8o0@;?`2@Oqp z!jv52mZ%lcTW^p;D>+c)pb@^XCk!FxS||dWA`jkb0s7_iFm{aikVT*b`B^@|pF>4J5zf=oHd4oGYUy;ar*O=; z_wsV{-%jC;{>`B}&F%H>SM;B;;=_NVDDQCCBLh7C+MbKlU;k0%^PvCba6F5hvFh~M z=vncyeZa&@HeU*nviVRH(hQ2bHK38IZ*KJ_?||Dm=4hwfstSuI&eahbZ;MBTW|)q; z80elh=na?{9Px8bg5(6&)l=sZV-GIe&dOrcM(PUgwQd zajseZH_ilIpZ?V@zoHod;JnqE9|cKc1uR!Jc^Tds*~W0&iTy3!PO%7XvwsWH4NW{CqnPV zqP0doGc!+FSo8ggN#(O>cVBtOAoS(3)07HYFxh*u;?$;-RQlvK?sid!EDLsJ9GfUS zJ`90Z+-89iI=I`D3u7K`5@1HAu7s4HTHFYoaWQqI)*!P`aEhd6dIeBJHkl%z9Dudl zmFo8ym)SWWPnT4%PCh#g+*Tnh%(ry=m<9I-G*zDRbOF=pg>P^R_ zzn%p;==4AZfpD!)1cY_elvPu4MtasiY^Lj1a{ngGL6 z1mC))5TeRk_azDNyYlukQDvNmfY_C`6p>KY1zP<$$rkLpb&l*AxhR9ti|EWQVXY!& zk2OJ3it*ouNHta$1Z(>-C17*{3R)Qpa@>PS>`p0z-tbaJo^VoY7s@M!Tv9Q83eA;o zmu8}+aohXUi}jN0zOjG*7`1WK!ZVq@i2a-NHQRI<=^wa~9_P*LVAA^htaFb5Mlk&q zsR4tOC>eT*TA-U1J}s$@ihK%p80c(p@e%T4%r3w{wgKB(?I*f!2pEsY`nE^QVsm{f}flU_stoSt&(L- zlo{bqR#;=bP3=TFLr97QpnHG7_vaRx{DV1Oo%meFl&93d1W+93m=|grK9DNwx$8e2 z$YmhHUJZEn`ZKgOKyb>jEy_gkpHH5GnEloXpu>pD!+s?R$364XgB7Jl5=S%V9lM!| zrBf3rNVzd{?MS+|ZRK)bf%JTP)C_^oY%3{t{5p@~lXh5?ZzvnXA@@^fnW$hw0Atoa7jy13XiIfpOmfW_prm*llAH2^ zA>(`d4W+jBIA6{YHjIJQ@ZFC~*}732(ZlbG0X)p5jD?PR#-AbLRpa)0Mf_{N2Ho47 zcpY`>?fn8?FC_5IeFs7zRROrUO%cgdqOz)abNn^jeaKbqnAO=i-tB<;x#Bawf*0O8 z`>&c6jC;_Ju)Q zJM^MfSS04)-%R~8avR-OwRL2gHkoXs!icAmTPC(z9)Zv5h!De|^^=?Q3L^lIlq+$! zqZgIpyh+iRPog*`WUdvW_cvQP$=&l?CC57@;?wuT18UMD%RL+4!plE$)YbsCTq%h1$4Qe@>@!c&*;OD{U@b&Tyo!cBYi zpwIcx`Xu{FApQ>P*CIrzZ&(X7xsXi-8rg+jHLY_{NNrW&VNZYxlcxr4TZ{RCForZ>tdiq|oN z0EZPa3$?aftP)`BnMOp7HW$BJ;T=*M{%YxuDwjg*$R?mPwL)OfO^09-dxV=FF3I`R z*$xgn{Vw(=n`Gl&&N4g$L^^g%9$C<-Mde50>c3;WF`e;+B6X2LK@@*!$;y~XjXX^r z5T(;02UnBgpRd-bE$bDx@B zZe1u70XFQ1+n{j8)jAEQC)1ndFarlQoA|q;lY~ouPyNZys4Cy2P8>DH?WENM5>BMe zHQy!RKjxlvMKS3s@yoq6fAF5KwceC|&8$yJM)sPhCCR^VRIb3;09UCmSD>GOVOZjw zserws&L6Dt7MojsW$-HA{_5c@O36K$euO|HGZ2^@++i@`pC+ z9!Wdxy0{s>8jN5m880;EN(X-~ALPtcPM{swpn)g8WhYEvQ@txuuTv6q!*5~>NrFI0 z^*LO~DUpXC&)~Vr(1u4xEhad$S6 zgo#&=$U2e8VeE{CX#c)skyXl#bOozoBC8vOuFM7^6+_TK(s^mL(~<3x!9z(C~Rk z?S?2925`0pxv>GKF7bl}d7$-nZj5_jTEdBQp6Kr;N5=t&a3M2Z9}Dz`C!vq_7tqU#Q$pC`0%g!ZC0wR3uF=Br&x0A`zdD2HQA!1{aG()P zX?Xsyfant5v&R@H(lK`dZQ2NcLe@wD8tE8^1ofR!iO<-*bxZGG&WrEDPnhJXt#Z^G z_ouE00m0juoEGB?hH@^mksL~G?&ZQdAi1X;%=x6H;PlW4k>%I(p`V*)J=Ux-!Em10 z6_4vUYvh|v;#+1}6}v%LD-B5K!Ei#WKf|q^&Z3re(k&GEgCCAd+Uq^XTO{}D7dd;h z^S=b3tBUB5^x^)7o?M?-E;MSph|x=B5i=wAgzm3>no)W;omlAWhNn5g1k3MmAMG@i zgf2eSSWW}!n#yT!)OZ3-bKC0mT@_y`SI?)D3*wH#i;Elr{^-=2Bz`~f@<=*w@;uc1 zc>GYSm8ky`r6ccFLS`srZa@K>ds}MFQ+b_<5g68iBkmGW10hWMG4fj3U^LoMm6JUJ zZ|Cfo3El*U{bY0~xqa58kK@wEo6@?ZnkR8A3$ZjC5_LDowQ4!Np5)~JXOg^6?D-f$ zx1Xo>{}t%@3^9HqHk==ozX(=qnU=!_pt?J}1(M?-?RZqj+KY8$__2s_idW>wsZJ-c zp$)`Cbpi*U#V0Xx_w2c@M~OhUM?`WtD2n9@F!f4d#{4PKWt+AF8m&w}sJscIC^9b6 zR~9#Un{ICkht~R zuvtE3HQl!hBYGHboFWGmcC7h67gWiYkNHkRbB5sNM2aPiuJHZ0dhb<*_d5yHt58G7 zjerry2;r3V&`b)5$=dpD&3JXE)!QD(&cHuU-Z6>l8@OSWli8txK?YWaFbF3Tx@pXU z+b1WCQ&zIu-@LfjSVBCzB|OB0RxBsli8HCRGUUtE=Iy4!^sFJXE$b_6LL_@f_P|g= zNF%yT4pVBID@Np9t%2#4@t-PHPYIQVcxSrY&PBcYMp4vJ_0g&hV;6b5=vAo>siZ;q zUqK@T&J1GgP{z%6N=XZY>cO+5$1sf2MPUN*sgn-cxln?*2-~_b0 zEc6=?a&Sc_i@p@5ckJHEnZ9^kPgw z{ui>foX8g^@2ifhXm^_lY89)C2paR#D6)|yL_0_3zXeq7EE}?szhypbRJ$%8Ws2ju zXIh}cyk%%)R(z`V(CGVM!I6D#+UR2F7qUbzlQOy_l&3P8MZ3APS^hx-3tev& z94gK6glMJ+EC7!9Hurn9HySJE0;3}@PQ*Juiq$B;^nua`0nn{gSYV?&X}L{p0K zgsLN5)N%xST0*>r#|*WbN;v<{+A-AaJiYO|4HJ!_12YS`5&Rg8Suea$7JFIW`GO?O z$%x2s`0Hg(k7tUze&mIyuzt?rcCFBqSlDo*J!+;MHG5=|NO4DmVVvyq-{{$|13_}a z_PyZm2e@q@&_p!RGOvXNVZ8D-ZbGI)(&5mZb#zTcV5l4ODq)y2*tN3{l3XN$3~24M zDAL^N5%07U>XJ zBRCSIEnfZ;MbRm*RN&ip_W$!%G{q1T=BcV4G0>dj5xIKAnZmOR%pjD@5#_ng@sa$) zw}%may<@GP@WgwIWka@F}E*sS=g-SkK_14oB{Q% zew^fBiJN>TlrtLhZ&ZcUxf>~Erz4F->)1+Z$$2Lq+K|hZ!|g@0mrb8)m&wR1uk1#4 z-4}N(Xu<{W-2B@ZKZiy#QEK+NK}O!8u~7dDtuUotpu(CdOUB@d_Z&Of41s+EYy+Bo zG7Rf@qFvC_2w_U>bo`8cDi+e z#^*o$V!k1LAZ?G8dTnW#yy9at5g+H7g3?wHr;14mUpFC!R=pIuXo znD<%xg@YC7=q{@(Bp)ri5%$9DGj$N_Nt`gEU58AtK6^hhm_^YY zj+zr4xj(GcKDUAfUOb%c3Qh3DMi+5u0El=iKqK7+8v!h>Y)#v520MaL z*C(Pk!9QY>^wqi9k_11eH~(hmVB+1BZ{$DXeh#f#;%u(w3%4a%|69d2jJ{z zLl_A9&!{a#GsvQUT8>HqPrG5{4!$_P$rY%r%PYy@)Cbbs6pQ zwX^!dinbpnkd7E4Lib~b^u^Hhs;`6Fl%ty>6Gf_#e&9ewSL@Y;R>=kQuH^Azl#y4Z zlz|ea-R(V^zIC~K@MM9LJ~xyg*%0G8#V<~RlGYf2P^x)t@w}pyf0UF0jdvL>DqFr+VBbPD6|MZ(M#N^R%etPapU^3c%nCBK_O-Y^5EC~u@; zbi`%)@X&4P$Pz5-o-1LjbaOmJMj?6cDH+mgsMjW9fDHuRaX2BZo4N&{@<->RO^;yc zZ}_|3k<5{kG9+BQVG6wPM-tW=X>iJapSp#o2y5HJ5O_yN4iX;tXfXbb@v<}8W2xa? zU7bCyqt#R^W9=b`A|HRiA_X4#3~1fJC(Z|5j2v@g6oYa39U0=XTxbN>pqdT#6sqoFb3Hgmg{{pWALkb$aX+zR~G4<;rz6MZ>3THH$ zz{p)m6vCvmi))|X8V{I>twh!j(~V9xB*rR-Ivg>kBsyP+@TrwHB^ zfyj+n+}1$zukFcQzzm@CMrGLYrOs_lL`hwN}&xZ@KTnYf~>o zTyiDr{N3=P?6WC0F-<~&y3a9`Rni=zzoJa|nq zkHAx3nbezrqK~(WaDl%4;wpozOkobNU(X-9u4VnW`CgWKur!pK)y-igofeB0?6t`k zvxz*t#1Oeo@}z5NHh?F2&hy^5`J7L+EOI>7kRu#slny@16E~#l4{P?~TH{m* zuxrUrcDIQ6`~=oxQ;x9!Fk}DVc`({w0>%kH z&;;RMR;Kk=Lg=j2S{82J!+oZ`J(@2m{_#cFUqyDIspln}9 z{xfY;^@x=$a~uspa85J+>~h(gei~uvw*PJ1dZ_mq9Mk_=9eZeb_!t440yiX6Yr7mm zTD4CRCmZXYI-R|=>MNu{^Z;_Dmutq5KR4(akz-J8T}hlh==Ya6Z5Yv zwNrp)KkEOo`AXs|fL+0s*HtD2d&dMpB#BKkQWHfFn;DCG;%-o3=7}j;<$s3kkyf;6Z zFe(DO*<1SOH67mAlWG#-@8th)K60)kI68E2RLjB17Kp0rJNNzhZa>WaX*EsP3PA~q z{jCgK`nl<`xI5=vG#fz1Lpqe5hCoI1rAF++0cYfV6mV}Zh9sIB`iNh$3W0V4QXBk* zm=?G;=S5&9(k~!R44$C>ZQPh~Sut#0CYeRTx zknaR0F!7&GCw_j}%L1ioA$~^CpkJ?|JwV}xp(bd4eb{9E6JX%LSBMDI09TuScRQyq zT5lC{2c3S!t}<QKa1LsFmTh8U>}{*u)OX57~cU&PhEMyybTmSB;xw40JHAew${cid!a%k&1bx0)Q< zoNy+yZu0J)Rj7C@MI6`65L0^Z$paR^D6<~t5=N<3j#^W^S81+DC3FJQH-v_64&509 z*#UND`_HC6M0ccLeL~ZbXQw!m*C=phwOorTgK4#otm~~c;qjfe-8-sm3+Vo7+UT_$ zt+5u~3t?hgaKMsc(zhnYaK2XHvOofAelYa7w74Ny!^8i|yJT9o?fL5NyDzG$VhLW1 zg$;RlgXq*(doqT&iUIcgL2WC&T1(fOp}7Y(*u&`d2)>c0@5UQ>LddFFdo?!2YV8XX zsWSVSu-nb(+#@y1>L)iQ_{D}WurOf2l&j^hqo#E#0n*6gM!kcWYwUT8`YvhOF2vAA z?a2(b0z#}vPdW6g6K52!w^h#`K^dqpJ0?=a-&Y$qlQ<67lciXp2wL?PzqEB|Zk=~n zWCfS@X(I5`7XiV^7$p3CzLK)|f!Y?Waf^O0h&-pam@OMVryd$I`svp@MiMhRLSVI} z%D#;-1c6C1`QnBnZFa;;&4}3J|@6tk~_{7_1bI`95+bzYPx#EWc*0$?sf%VUb(*juX8a?#mH^nunP0DyWl-QiXeO05qbk z^3UILfj_2e)x3GBwqIm@g-F;F(gC25B^6p~?6myQ$1{t1OyGD_1_J9op3~ipM7V?Q z0b9L#YUV3Vd$-CA2y6Xd9p5VpX3MxZtdzHCW+O7d9)|5N)}$Lp%h1uAEFX5(mQECB z_o(W+^A5{vM-T#hCO8dYu>RB0XAJ~?YF1PHbZR4Wx;=dqO`WSbyPOA*I0_wPF=cF`v6$2rTO z{Jc>c?g)OLRuQZ8AsxAI_NT~E2Ako!DIw_vmW{D4BxUthkMbkX@;m;5{WsQ9R~|$* z!inn3s!0QZxr<-E22BBFJFgl9`v2+;Fq*knNfE4MMMxo>(rF$lP9y}Y^Ge3Y111c> z^{@$WW}2=KMLOiUcJ6U@LA2sQ9%j-_l(=;aFQCaKto0=c01sK20Hd8G)w3eXA_CUE zxYMogk5)()D5ZJSiXN8_ak>QHW1l@l!@hrum2KZu3j*n69eH+Iq7pLZ6&z}vo(Z4m)iO1XOL;SUBp*uQr^Wd7 zLP&sc!K~nbogr}|(tS2h+-@4}z)Yu`k1^n-n(b}cKZ-6S+ITtfGhCz-s1N!B?^*`d zD#o?LTgTHH{bimU^bjs^+8lj2lg=|m!>)k!+)O7k&VY|8fjM|)Pb)TV#`z2|0!L_y z;kk-cPl3#p(Gh$0gsW~d--Q1HnV3c6L zpGeUo0hYx9M;Exen{gphlytjIsZ(p1DYoBDGF5Q7T|`!0E1RFfMzdN=^TQ8g#i-Y* z9qG4cr^H>xuwnpHjY}xNuZeb21^73j-mmgZ#fX&~wl>{bxzn>In=~auZFgCa*p(JW zPpopF_UAe!2lRRz3FuJ2=tSX>v<=Qg;kGX#xPWcaIZd2;p4g?!pyo0${aQj zriHh0vPzR5@)KQ-0Q*OCrg9}H@ZiWlFl82!y1kQonNgC8LKM5As*%p&H{1E8UROnE zxj$?*wsk>k`rD23+#g})-~p&$7>%;-21h#6cFtiU#US7Zg${`pH(G&z62+brr7J4O z@$U0Sz#nQB@Zjm19xKh_fw=|F{Sc~OpoF*3F}bOc5w4#zN{qK$!h*lYmIQgO zZ@{y&{+K1GuWYnj8OW0`b>g{*?|6a|8&%q&tGR8Nyl_DP02yjQo*rbBL|iNX003Pk z3DlD~B}BxdUDj5x%KtLB?K^gGEq3^RS<`doeI4>m~IY=sq^se-5PDl6aW7u^B$U+ziHo0 z(3(NyobT69f?EO2!IX)1F`-zH*WIOx=rOQ7;`eOhUe2NsdX(Ay-VL=0SKXYb!5HO! z)&ra;=in()zw>Zyg;sao-EPQyJw@r2N8_s3K{%F;-1u>pfyouc&PLBE=ybyW`6f^8 z6-m>PTbbq!DClL#_$NIJ7_hkzTB%d%(smhfsfA_&9h0p%8Nm_agIX%~wVRFODVZiL zOGY-!rj4Gq-A{JrW$cIv*f!U33Q2Ui0XpBv)u%3yFwIDH&&EEM7Ksdq^e+__HU9> z(ld75X7L{56BP4#L6W%~Jmwm3z#O3HP(Myvp(eE093Cz_ELMntN2@RxqNk*L z)~?%d*rzz}XHb_3a^-1st8)yz@RIYRp-ioPDJ{XAD5o((zo19QKSV{4+>b3$nQ$yh zICP@v=5zivN78}dZz;+C9ey+cjBrx9oh!x0cRRfQjjbk7inarcgt0d2zLhiJ18JJ} z-n=moq3)$?vz7#7L#rkt>{ujK1z|r!y1yQIgM)jJ z4%DRUag%9vq0s+4G1+&eOH+i`Wn_(429R*K*?g5+&y#XkmK%1%E9TA3zR!IiSe9Yb zTehmuIjGbS`@gKV129iS-Yc}S$pX6F;kPg=$#gcdt^3qadH#^$8OQSBEz)yhjt#cc zBc~?FTjrLAmi|94WVg|_<3d6JF|^{suJ%*?nEg)wmHePHp}a_z9w?jK8-##(>%;w; zs$F6=y$&#Jk0!sQZqIwO)u(>uXzl-L3wppS18{7TtXqNsRgqK&CGI#hhY9qiojIPl z@Nvc)Z()H_Cje?#oonc+i%RV1=}2!DHYqP1+}ptA9jkhaw{=rgYSOcBF8M~=GL1mP zD1&2Db)zcnWBQY-%deL;FOA4UTc_d(SQZqegfibG`NCAfhZGrp?(YwiEPqb>v3N_5 zG}|n8F$LFA98LgaUT<{-FsZ>Q~qt-+`d3s9XKL7;Y@x0E zLCBK}^%_-HnmA~wBe_CzQnhr00}n~SwQt|ghb&$*pD-l3#Rh-^7_X}id;nU)c8SkN@hnUa@UF0mM|HKFdGSW0iM!}A6T?VCs9o^hE_5)aN123;Py4k78Nw2i zUH_dJ-7H+3{vr-yf|3FSGNVqkTWyB_n>&%+2m`q;GWUCDJ6^zZRhBbAtZ-#1r+Vd9ZQ*v?#I^6G~KI7qw27ci2APrx@3?}z3 z()vF@p?!qal(MqIf5|}>u{B!KW-7|b9$h9N!DQJG!Z=m)Xt5^25o3TetCEHMtiLBs z7o0Xrmm*PeF2d3}(hY1y-{uMDdOF;{gK9Yq5xeRgNC8Lh@2Vh^m=6RC{Xs(hJpkiA zvy&hKzIq&N-lqePy1^Dklw+WsFl?@p!Okm>N+{~D4p5tKiabLTFQ`LoQf`Boq9#pY zJtnet{WZ%4RSFojX00vgA8dQiePH<}mjYjfVJT;B1Gm82Z`661NnkTT%`D#JZN6Q* ztdgC+O@*q%B|L<>H8w+@ea`-R?NP`D51PD+U^&Y&!%%V1i2(dykW0Pj9@nhlr9COB z*LyN!wlEJ=-5K!$NCO7k#E*WKvtY|$DO7VfCFhW{8I)0PCwKRYlIDtQ=#1$8#vCF; zsS#WZbUEaR&L8D_D^F5qipN%q|D~Tup9OCYCRfC1-JTFx$|Nws62fPV|1N7b#pnN` z5++fJ|F1K`MHaJ!?unpx4o`>^>c(Q`V$bqF9eXr_${1)QA6>a`r$#Q$(U~B*TG8Z) zx4vHLM{IW>+eZdbz5z-eg_Ugrg5*yaVq^c8OyU+FufCqb_AfFFPE3Qmk9~dyySDH1 zCm!GRaV@7Uay@#cNsp*J`DJVFk3T$n56XKP&{S5n!wOM^l(2D1FvMOob?iRrF|E$a zFE!DCXMg+a0`H?CXUm%4<2ZnYp>0~t!2ur98CJz>@;h>h4@>ISAB$UTW?d!X|=|wPNmv8W>c1w zOO3~)V6LL`=dE-}h3H;>+R&Rsj(Ea&2JeJg zC-puBHs1$&g7LFiK#```?aG0#+Ns;Bk`=W_d|%Z})#!vQPdTU%uqB%w%zOS93b2c> zOA>K49obFY0KAOdW`Zai=T=RQ+}sW6+;)=w`D8fSZl}Fzr*2}vt0sIWQa|RQQ<*b+ zM-NWU?@;g~2re*DoN5$wDMWWIHBv z#2RkRzGBy2If!H~@xq-ViEOEIHDqf*{0TD(1;G$l|NY zv*+j#?SBS3AWH=EuAXMGQ@)Q*;bq>p7NfR9(m{*T;FXuONkGUf%Fp+A?b~cJ|rq4P-lADJw&SoRX*^JKi?wW zwoq6{X->|C%eDk`QE2t>(vm`}nyI~BOPGxAA0(H60UG%UH)Re8F4>B^8@rgH(1UH{ z^$W-s-#SM;|Gqoq@1#fSKZ;5YR`X~wC#~PL98u8#kkoqkqgO^PDIjazS}3xQ1JjK) z%LGv%dHYlL;Cu5t0dgyfm`oOEDajy-pi;pRJOR(2NoUP7jkw@(V3Z$2D@)T}ye|oe zRMPpRB;Jy%;?;lD{;=eT{7Lc=`yolbw>}9GdNefer+kTnIjaBW71e-5_LZJl zTz;z4ciGr|cNQQp{}SoZ?+iX(mz_moHfVzzKo%W@T6sH7c#}TaeqHz9M#tjw0Z*vG z`8giYL6*aWbHYjTg$~Hc5VFs?jHnCiM@RCls!}^fx?L;W65Ee03z+(50skwHBCR-~ z%!0d58DaP(&4+R~0P$pJ4Ju90kXpV-d-nkgZq9~6xOVae>;nRa@oIctq2dU%61{|w zj0(PWOB&+m_kolcWF&%*SxN((3-6WTT$6@-PVjk*b5d+o+&z52ZyLI9ymEsVn|%>o zZ3MpQ{IEEzy;#ZxRKbwD5STRM?``A?8a5N#Z+!|Hb)(+dtS*{`0s^kMK+q*kuF1d*Pn6Lot_NK0zbZ|tSA#kENhCMTD#>_|jUn#AAQp=3eJ zUIg!+u7IJXT-0^JGjjkrK*qmg1!`0%f9ai8JfoR#o3vj>00uaG4V?h4x>M@FVGSWA zh@ddX7-t~?@`|(Od>8U14dpO{9gi#XK_4Vk=+><;`oV=k!8#hYSJ_cU6{arz=7pV^ z+=asQH8#-?&HXzcARK3m6>459dXf+n99_p0^%`w0)Yc&}vBgkl?ex-$ez-Nvw%3Q9 zT!Y9dY=Ps4jD#0EooFew*}4;3$jnk6t{IEUnq483@80kbFI^RBicFjhMKqjQ=XoM2 zi~9?vG4`Y^n)EifZT@?Vg55^y8u3fk%G=2ct)0MTUf>-hQvU%Ll?* zQ)6WxrF!(dx5d~7n&g!MMfOp*dh_bD0Q|cSQ37{p{(%{;h7?S1YB8X+4_Gx$s?_~p zwgR|e)Vcx13+(T-##tw>Z*1g*ZQB#UqpIk(%#H+Z69wkBUNjn1hl^~0lLcm}9N^9M zG5q-ArVjgOA*o{^Kzm)wlC%y7);|m8hOrkN97eK;pRR8RCWhlZ^xN%eLw8cGFD`d= zmNLdYxX46v7i1k@b>k5_24%ztAj8CJjXxZ)CB8Afd0XY8mhJ!LV`mTm(mSZ;8v{yR zz=FM}It4W5d1_*!0pDUuVSGCU5)}Dx>)MC!M|JPqy|oO5kw{u_+yUCm{}0iCdMwj( z)8(^wr$aj@9*H>}Qti?(H!v0i=IpRHL||Wp{$i{-)6wmFU4CJsyJE&? zm(x6Z`B>bA5hdUbhS1DVy&1uk%KaKyW%?dlCV5zN0c(o^@;5mJe_27UWY`YrplEMO z%$zookAghbhFqdlN_D?LD(^U#;xmG9AMV*0VK6WyvSj{c)xx6KEk!xlaosVFiv^5% zzYAsza^(16C+-c#4+9}k!fPwE;A&E7H0Pfp&Vy^Lfy8!UW_p$38-Pwwx~ zW3_RK!n4gfTr!eSC>)~m6&sZ(&OlgE*gStF56dc74mLJ!PP}ttR+4=lGKuHw)K#U3 zjG}U-VH4Nj&(dVbL{@M*Pu}wW5qbjeFc#7wpxWIVC7Wo$M?8c{7 zEzi%o`jX9CZ>P{FO1L#s{rK!yJny(vLnZ=G{bM%&GySTo!mM-YlCpQ zvxy-v1L;`C@^XDdlD=&fO?L^lx-Kde&jw#<20ZejZ5nuhfv>v0!Gb!^>7tAY9&r3y z%0aFVotXNRAg&Cl=T_oDj9KSY*4V7Ym!?R^F0rUwa2=S{_&|dge_##lvJ7mN+EXV! zdbFt4v}dYN)TRi%D=muV^%ee>pO;oeSp6S8T51oSuO@!8?eP4&Az8Fffp<_cUqcqvv{;S$f*R}FCZYAxsUrDFjzvX7MS(azd*WdQ$w3WxVPnodA!=H4 zB~RMjKn(2Aqx=NIbLZO9rkTc5s>(tLpX%fnDXFAoxa=~tcpFZy3ldGUu$G)fqU-v$ z{Vh%dfr4B&?m_Ngi;%*gox}wADqVKtWNQB7?e3t(vR7Y8xp3v3Cf7t^RMafYR{U6@ zi%+LbsJbA7c0C&i>bFP9IC*&;1WB-!bAWxQR4FeM~eUuJ|exT{4{4UBNGncrH$T=kuv?v<{?@bPI z455DXy^xLRf_N{?K-FfsRGp;m>6=Y4og4yI&FW28*lz3+!JM*A5qCuEj-q~Z3F)o*-EipnEh*Fyd<#ld zMZVTiglY5vD!$+P-Ea_t#*RAP0Wij~`tJaQzzb7TJRYauK1kduNMz0|FqI3+Ol*qd z&AE|$s(!0X`vu0rdZmhfFgfMhKT$A*c&4b6Hwo1*ew+9Mx2~Tu;lA87Mu+o*qLyf2 zm8>w=D=`POD=gJjjF$9j;|^A=>Wq+5rjc?hhJfIoWX{u0{mEa3ECcW=CK&wygsGw% zW4R3tom6?k;wbXNK->=j&x&)(yf9Zjy<)ppBKR=Ak4Fj8COH z#qv@^;i>n=oHjL3>8KB!>g(~-eN`p>tqhJzuK&+GekOmnfn2je3*{yGu+i3T>i-lk z;zob`kFz3trluQ;VV{}zx7w|KkemNF@iV_8oI07tz zJSjb(1QX!Ns=9eS#$ixuwxD|oe&(r0cPCV4BE$xMH9eTs{u0hIct$eF5ouP9D(rlc-bXna4gR4jTB8vp<#`I-$& zj0Q){Uow(ILNsQ`7q13hw?>=6IuN$LY@jxqUsZ5Gf!ktv))C>F}QxU>I*wcRCS&HO4cr?yx2qXCMF7{hVTI#j@T zzlRC?ks?)8j3`k|8}&HhY-swas1rh!(9alP@-#lFBqh&(xO{Kl06bKmM5m+YBD;ZG z=v#GKy}_)?ZLUYoDB^+FPZ4x$VR97S%A=ljXrD51n?)Cwj-Q_I?g=YQta?c0nC;dt z8q#jkVRx?x7z?*mQFyznJ{3+<{hAmmGsN=nH!!E52GxGGn_otdFW|3XVB$yqt{1pH~6VqyVX-OXT{ zNgsn?a#)rfE?m&zse4Vrd`n=sBCj)|2`k2AbaDSLG~^Lt%0y~Vi&b*1$<@b+dW(a} z(r~M9ZGj?$)EIuU9Vb*ZB9>|``Mw6r{Y++b^1p}JiM?p5rZ4~i7JVw(56dC&B3fp1 z7N!<-1*_P2SXNR-4!){#I`7pYY04|h5 z545Vl3}iLJjd7G$C&X@GDaC*R&zX|~Sm}$MLmnc}q+fQZfm!_k4Xd~T;048qhnjX*JE7}_^nHrBHDVV#9R zwiwD|=^xa8k71xPPu9*mM-#7@(pBNq6lbb-q^2D^f0w~1H>RI3P2Fdozw(9Mph8cEL4F+;?)cJ}WtpH{R>6C2>IhS9Ps-ja z8LBX(qgpTnh%|un6>z5b0Z?DC&%(}nkdnaRlldcg@IGfH7jMR$x|w1tpTGR1i02YX zPVi2Z)PQ`B@iYN_YKfHi?dB^xMu0q%8sW&?;Ab;bY zz$)$)^=aP^7wWj#(p%-dtI{{Tp2qGT_*->Qm7xzax?Kc5z0)(}$dD*Nlz9+CU_P^M z!0RRN#bLF!fN@Pdi)j4K=|Bov*%7uQ?jRv&;C8gD+)cW>y!ONaaueU#czn)fq7O5li@AbL2`Q z(!tl=o`GEb)MQ1`pW6_NR0FZI z;J_SfrTteKI(Vxvp1$Ncq_zsr9u0Ow8`Aam8$#(iMvUSx8Q4jFkP32r5B=D%35q6Q zf69l4m639PCeX}Yzd##^#584PB79pV0Z|K0ucboL#GtR(CC1VRr){guUOEuzS4KzF zT~mfGh1Tu>w?R^i@0@*Gl~F4FS1v}g7|_z(WEm%EoLF@OFG2`rk0=>*y=f=8o+My) z=j;+0s|Bnai_?)~o46CiP_!BhLeJ%Dr{a#O=CjDkjeo=Bvbh}z-E5q!xR6^+7C(1~ zEGe(%MyUkgc*g?>09Qu*x;}y-wCx-scDs0i8kIx>~9Y#yK!eT$2835f@mHkJ;{)j0b;lghafeI^BH{A82bUOwg&eo|erqgkIit#p_Z4-S#e~%N zgJ+D0s*ihmJ7=;KB(S)nDMst>W4RP^hu75=g%pGel#NS?nb z#_9=X@bk!Z1<8P7hiL*a54Mm@S+ELD6Fh!qRRcNzdqJBL=}X?7aY_0-|3(S z5zo+&QZ~Goh!JhjWRi-cmX}1CXs%d4#Q2-TWLO$eT%?`i7T#k_bsS`gs@pJCa8TNU zeT-#o-#ym*GYyGKPk}(@zj#OM3Xs&xtYQJ2m9t}-2NG_6#sW>W)wh&rs$2v5eTQ9SpMJXvhGtrS<;! zu11}FtbY=*)nY`u?`FVI(Vo;IkKZ6aSIqTgl#>XJTkvp)ve6yU3>op%D%^0h7Sd-u zmw{ejgHSjk8Ogh?F)z2{1FDV#%cf&|MjSE0x9q0}8wj}muXMqm`D2gLHc4i04|-su zoHmrM)lQr;$N>->DF#*c#ROAA{yX0uiSKjhklir2Mhi!{(5%+Lui^J6kjk`vGg*h5 z4O1qiJ(SOq0;`w&KOT5E&BH&Ud|ZHL)Ksf3kLPt>ad1D~*ASvmIR{qAo-};#cGvA5 zrgs+in@u|oo#?@x`@^Kuo`HXz3>H>s27EOnzojDFt~eRs#nf2^Zo4OV3+Q+i+_DDf zBP6!e%xjFMQw@um@dyb3vha+-gHqWsl*-yF_gf5)iqu%C7`^8%vj<*eKik0yB!CCn zy_on)k@XA~JPC~Cb#DiEDDFta<9fLH8H@!_MZGXtmHu2NSew`5^-XM8ZI4+vQcL3} z&vDh;K}#yflEGiHk7x%1>XZ)I)vbbj`zUT@Y~J!bLm|Q|mP$ZBu^d4(#BzDlY_9R9 zZ2=S!;%XFZ@^igk)yi&8^0qL&g)T$?%?JtSn|4Wo$usA;qWoz6YLKXOW)S$T2dp>Hu*kuRd9@(4Gj90zGt7x<`W^FADGm z-|PNA%nc&56J~+nOAYyrz zrD63Jn@8BVHx)aVN6tYAl~*F+Jb<+}c^+=9itI~z+vzVGM1b=4oM@EMPvE&_F3f`9 zF}&R|gbb8jbYjj8vH_Hqz8bZo#!PAWzO?UafUs4YPnblNq<~)m#ES|oM~cfygahVm zK1C0JHIWmB{0PwP&UX~QAO6B}zFf4BN{{-Zq{@3Tk}2p_OsVKsz9C~rIxQEZJ>sqP zb3t>&cGBbpfnLl$sLjI}p`}hNBd;qnmyio+B-d3WYQOqU05}5Y(E_>KLD=Juzu)sr z++aofv3e;l-jLX2+4KV&Bt0mR-!%bo_5DA%yW7pQo#?u5tEVlTYQ0?$MXkt-l;wbx z?wE73F3~e5CcBk295D^#jMSD=1Uc_Bbl)rAQ|>-SWY=c?W3BMABy7!oY9kNvNd-bM z*CnkBB1#+AX4`+yNK?$o@{lKDs&278UT<6zu&bne#Pz=o=4=B@4bIAX5#lHs=l%%RJiA5G0ws#lrrC3Q22Gn{B32Mbp&n;(^?S8gzJC$9X;1HHCl-QRkAmTMqXKc=D zn#JK_Ac{aFxXL+?z576hc;a1Y>ga&D0K|NzbRWbH{$jO@2!%>4$|mOfmV_zy+%{xm z#B@XNj-rbF*1MGobE$wJ1xy@OlGmgWZn>tciT6@ph;+xw6%_a-rRs$r8X9bb@G;JS z63k(}ycCrP7&-KT)3@?5YA=1X{e;|v9F^PX)1s%xb!9>xpCruWOna-*#_25Buz_R} z-x-@ultGdvo+F*Js^eqrkz3H#n7AS}SXQ?Q)~be=Cg;xrc-C)8 z$WR^`c!a+X#Olx(X6-_=rDHa4^qfW~x@{_nZ_fp}7gTiYHM@v26XiI-VffcnnUP8X z(z{ET#Z-bj;7wR($^k^Y`BH;KL@Br}r?G%|UNgE2lqHJrCol|4;;Yfl%Z9T82IXhA z{H8@lV0EESdVF@GndeKK%!u3)g3QtK6jJj;zft2iB}^6Et_>`(g`y|3$P;W2M7@F6fdb zqjBH?#`3^LyznJ*ZMcGx`-t(sCDD7I-6-rdcDeSSs8|{b+wRtx{AT|BG;-!#N zo=AXLn0fchn#I8?cZ{hr(uPcZzbA=1Ql++PQePr;q|6x# zyaWhG&~H$`6m!HRWn$73huDGt*m#>RRpzrAW2h2{cC_;(8S7@j(f6C8NA{W)1N<|R)ixPLBrxgoQ6d|4f@iAE&tUFhwDeba6 z@qb)xnhEcgZwhIZdyGe{>|-RW7TSf-fvb;vbPz}PTKk~^IGxz>X)TNU<}pRHA*VR zdDVB4Q^4*2w~G`^*suHJsv=J936!V9E}m=AVAt&t)9v$CTJ~V8m#mHL)*<)sY_UpJ zGt42qmLbg4%MZ`we&?n8-ra&+hJNbASAc*05BvHENb*_FwNG|VLo9wgicc(cCEc_z z$InoF9cnksvHb;BB3f%L0aKwN8tfnxY%vzAJ&45Wn~$1K&z3sU`gIe=W?dC*V7Q+# za2CZBquZS!X|UoB0Cc-?*wa!Dx}c55rxX;Xpiojt#y4i?hHkbYaek!$cnOLmO5Sj- zWn|g|q*{tkl8)+WcT0~>-HYC~u^5C1PeMGRQvwXN()^dydpPGF9C^CrZd(>l$Y|j# zjXrpR7^PJ0JWc7-F+B7C#&jD_k>jF%DvyZV#z4Y2VRBOlHVbQA;UiyOU;)K>I^Rmwu0ZlTDC!SHwUt7KB|!+8ifDqTNRpOygz*iRA@dn8 zQA=jZR$C2E#)6;H8o+oiVnMg97MFb~NpQloe(PI-J+}1I<;fKns{=09Tp%;|K1Qph zo@6&YXf#>I7loyMs!@7(kzD24Iss+T3iEiC_IKYO?nx478NKk>xOgt&g2-l``?Wx?}bj36_((N;Vz!0OlSZAG*{CV%?M9~ZFfa- zjgq`v+g%iiNLPf!>Hd+3)Vnp+_yl-Mmh`04G@j zhro(7vk6?QG2cv>^A#HJ0WN!|!l;uTZSH=%^r;OtO1=pIbA5mTrV|0jER*!uZ~;2Z zKGm;FQhzc(G5>+QYS;~Rcb&?#MC_{WvzOO3$({$D^aAc7ec#y*B%F``t1)1@0>7_7M?%Yja&O2wyrB=W(7PdDlgaGM-XaG6DB;d7WaY!XL14$7&m1xaj)5vwYH|Y3r z09mS*)UYOG2&iT%uD`3D3S3O9{i_iT%goTLO-Be!gg8}TNQQWWIk?!-4P!DcC1S%}&=DP)G$E46i0!feIo3Av=(rR4i zW1<5=RNk2FyVHQ%M5Aky-To`l-OzJj&=NIQvV^-HK>l}<&3h8N`GLZDM+uSE(f-JO z>Ql0WPY}&(EsX2<%N_6cJ@tnThzr|F-{#5{~jr#lyvx_4nbGtw^uha-$L+ zpPX|!1Y7Q^SA|$Aj*3IOQWthghYzbj(PgHw5qQ6vk$Jw+RpAc@q)56!OSarMD9l%ow z4w6}vNfBY1hEHR>iN>$&(Rnk~3mFMhQ>Y(+^ee=y&S7-A?=1$J0;3kh3QIb;B?ni> zb;n@A5ec`>*5fS+5am2oR(FbmVy6PHfux%yBzvw#bgNSi-X-s%z_y>w2ECs zA;EWzK{=>E(g;URxiukx6qdGff>=p1!AAPJ%xS*qWIn ztgaG7BQ#v=j9`HCg8@7H(kUx38UX9KVR$i3pQV5l6}Df}`!i3x_4JyiN)oB2u9bn$ z!1sG<#o?rnmF$CKT&)1seiBI`s9Xgr3Oace_X{3_ElH+$Z79>wSc+c16J<}7UQ<+^ zU@B`kKQxTzGoh3{Z_*G#_S(3&wwNfa6!y23X+qtFd66{oFXr$)9g*UaXG!}H_h z(AiVc~(A)ID|dSci6Yn3;dMsu4ivOtBt;jOtrT!~$F})W+m3`tfx2Zq65DsH}sw zu7;H`jc0X@NQBH*xGwrZ#0=-~hKBr3b2m>r&`D`kG#W;B)QN!1%=sY-4MLaL6j8Nm z?g@-!q~3}gZ2pdC5$Wb`lwVAl>B#rt;D_8YjU`6W5x<`@gxS%kd4&}4#E1-q<_Dg; zHJzV(|GoMXAb*O%uyQDUf69c~GcQmr@fMwH#Ac7}l2sRBD zk7s|-`*F{;Sv>*Sf?t@Ul!AU_ZKsu%Iqc8yoge^*+|U{{MMe`o4sg1jBOrkFyhTHV zv`u+b@7i3nrm9ustiL6d#lhhB0~@93T@zpCO>F2?bw8!M8{v@XZW(Ok8ol8u-QEcd z?I0c$4OpesL#~yQ=a<(<7c4u1_b_xDt!CVM-Uqn2wRH=N2rP z--}+|Tx07YbUMMH7SPRX?0;%KoyQo2EARPHo&bCXw6iC}yMyzPpi)J#lgLh}rB%ce zWFTHdPextxpybs5FJS^BrC8J&ST+yFDCH>n%`KUnjayVw>C(u*>GjO$>BT5y*I`B1 z*pZ^5;`zwWuxJFxHKpQ;%r9@SdZf-(g|thv(u!jl_=MZ$aadl;xp8ipG80=@66ToPd$~}=J8@uM z;PI(FT&@f#S)&6rZdW~j)@_dDM<$(6LdA*61thWjEEDklFyqYI9~r_KMVGSDUhu`_ zM+`1g^y)@IM^^Ni2`_o#B7)(u;PJ_&gp4&B#Od<7InKF@-%Yg&gSeshwD7CPxjBTH z#d+r;r<6~fQ^oI5IA!tV$HVmx*`QhmUpNKsVbFuIF?My6eZql4XFw%^3JGm`P3sQ)G?H34Ji9Y@}^Ul{ZMPoMnVlzsU|WTd{D_esTIqua5*}^ zdoqIe9e7A?hW^<|=t;*?io+UA*@#)n)En-)@-x>KX!|pa1A6)(a-w$#S?ouICWF;O z<-F#T$RkT@up-x6H{|+*D)Ud%+i!6J*<#Q6Z3Nf>4)GT2_cV(~z1Kr{I4!Rcc3tm{i_1U^% z-lI4k6i8}fCnnj)&^ep#zYq6l6bbL(>k=YLRj$B%RA1hJNeB7tXCHYdXhWoer7wi% zl|;|-zP(R2qHcYuopupzshhKWE10V(xxvSTNUW3AnFkEMs)ijk==)J843DS4?0EQcqEy;MhM!{l+Fzl_^(Uf^oHp;wB9l6=wWg;mLMVTbgkmq(4 z%QY6{EvOlaW@81P`NlPb5F#QIP`njb;XMx>bTDJ)T~RA?tE};alkhtVVI32YE!^%? zBMKRVz7QG}BZ2T{1jNFjfO`pW;=WVWNT0n6q5Z|?*Q)aGgd{oQvaVm~Eq09m+j%z> zWKtuJLc0*P_W0rM_z>Nrjo-9bMA^=~VIXWn9OVa2LU~}+WDNGg!{^LdbQ77`DKgi* za9rrko3!bO(-}?Pu)q|O)8*5bMWKwYM%@P3Vju&x4D{5A@W8{ruD+eYL5xKYl>9-- z2&b7$ay9B}$mxF*lW}-A`TY1BGOn!(J&Oy6<4R?*gWFH0e*XG{1Ox;TEEhY3OJ-v; zLA4#VXn|4|D4&G#lVq)Xx{ChESh%^rNApW>y@wmwd>19?SqGz%%chZjCE$zbwfxjH zi@Z>3Ccf<_g4hCQC+E&RKF-4W>X0C(_B6i?SGrp{4`AE9nJXpF}W*wTrb!z_jj z>kLkytg6hkiE@T_3>YBr0Pnk78TNzuTFjW~g*W3a^+QV~K3CMVt{wr}$xwLM%OHVX z_5MCyB=@d4&{!-$eD8r50-XeWz@jJ<>*?Rhxr|HjUBO$v0)Pc|7AT|p;E&02>vaU` zPQX?yM>eR>xWuOZiHZ>5`CVi>|*A#C! zM`17XPeOfy2Be}LAU=7iL+pFS*0=L8Em%#+GOl5|7+oiV&~eAeb*mBcV72^buhw*! zW;=6V(~AH{5;Zizd}Iy62*WgrIvPIrYfn!mJrp}cYr}4fLn~?&vN+h6G>v(9 z8^sHPe*KBua+QAL|7`9#ikQmycWSJm!OZvmF^~nKZ?2V!dM%FYSB<~cFr&Xj6s3*F zK{;jw|NT4;mmM}KGG;7K^nMA?{|_<)dn!j%_O~1W&Qt&IYVIJ; zRL5mn=M|y7TnJvOoEWk1_xjQp0lgS<5r1HdZTB-TvH&RjG8zzZ+e-rWSc#h*$q>4Y ziSuDFI<(RTvCg#4j4^cZ5>&6y1J=uYY@Mun8BW00+I$;q2^jOIAPw|t)acOA4w^uK z-S9B0KuM41U#M&=(7^JI>Yph)3>ev;R768bIJ6j8PLNJ~CYD;soZNpU{ z6}>xa8jRCy=_oHVH*l$itO>x0aM8BI$hlKXw*be+(RcmoE!Z*%h~c^v4t7T~Aof6Z zp_jpb&7=p{&Y(K#jh}1Qta5N9XSjd!Hk>lUH0I^aZ5@PNbckB*5WS%KG5;P<5X6U$ zBW%^9W0`pjdv+=KW@qX4~x;b4LOTQ&H!;S3tJ^Ezb zT;QZqRw7v!qVMzhF^I!J(4t$=A03$jL9x|I+!X}4ppg#aoAZTnHf3afl&8clHM-6{ z_MQOT%XYnZ5W@`#t?fE2T>tR^{G-f2!peUq9GxeUCjzk(tUb9TJLBUD0)90Fs_0=Y zj;#o+SxVAIi4iA8J_Zl`)Ex!JJJ&Zik%<^-;5E(TDnk(vEDzt-tI=W#;^}#`T(Lhr zuQWR9LZ48&inNPdxuZ-!k=5NpR5~mVNUmv37xJiLP^zecIDr;I{u?&Wp2!(Lg>X~m zD7^>EfxNL*G)J^AVU;-nz~M<&jUqvf00093k=!L{P)z`thQBTrQJ!ydEIsMylGNP$ zDCHfb;2=hK_2i?0001N{L7F5r2ra2Hm;^Wf{;E{~01i8sZi`LWiw4P#!hiL{TwHZC ziS#4{B4s+(t~(%kA^fn+fIMSp`lJZ~Va4<)3XHz>c5wTnsk{K_-C3rSW^=%gVI^i@ zp$DwxtcHU4E<7^Kf$Hyalf;k@#n+(ghU(dJUEdpPBMNy(zp(E)*Q<^4hjcA zqr_jWDRxR~_X(!5NDL8I9_gIb`m@1+lkTX0K=2@HI7YU?E1f}OuS?cka5fXKUBv23 zl97j>9#ex|6e!;HqY#qG+_h~whHT+O9hGztr(pul9LCp_-9>fJp0bu>eW7>*++MHDTfO3y;-w_KK zTj5OWhHAZ0V=5agc~nD<l{nph?_=;9byVARit9N-(c)0id@Dq0C@H zFXxTULerm|)lXOXvYaHy5yB^U!lm^MpW>*14dqOQ;AG51Sii{=Bv4d-(kp0rQfOVD%W{=o>tI@0m}&D2C=|Nq0`U-gz2@Y31+ zUR=joPs5Sk7n3lwQW9R}Pb>aeP&&(B^V9B^WA(Qp&%ftQ*P5lkPtlx$7^tY{qg07J zl|%m0#yR|mhn5_V;=_4hhIx);;(olT9H$)CGdsYOHlDp7hsQ>2nO9v&BR~niJkmXli@yNsALH|)UzK2TYF7g7?kxP{d!UkgJuBayV- zDUUDYOZt(kH&I#3P`ibm^V?*=8n?N2vZ1Mwnj$)OI}C2C1RtV|Y7QNDUS8h&Tt2Wc zZ~p6xxZAy9VdPZ~6LTCN#|NANL^dlwc1561+p*{OLI(`~gN<1&IW&UD*;kS1yGM)A z@)}t((M3~fsV^!>sD!+dC&zPe%Y%>OE@8G>n}gI0$u-Wi?RQ> zp(ycka=dyW2UBUM=_|TQgS>>`)(g}MDwzfxiA(DHg_mfD5FijGt#GY#6;|?{E;R62 z;7TQGek#V>f}AXR0?HgK>Gv$LMzn1Y+@k{gHJ*Es&I|4NXGZ}l(XW(|+(^PIOs{JP4+UVu@Zcsj@#u#2&cM{s zx)y@|b~H*vmZ^WEmATg+cS@PO(+NVBW)uB?b2cZZmv&R>2n>;Dk-i=Ly75lXGn-#} zjcM^R{V#vY8-EZXtz%XHf+X$KTVvZE&e8y2!P06|h(bymXe~719jg?gs$PxP9 zITin635aJ2^cNU=xv(fZZ!TmO+s-Zk$4q}wt(U^0K*#-eh4yb-iwo3?3Sr^dlW&XS zhlMbB^fb8!fu%Y_OjlZ-3UnRyK$7qo{!{@2G8m@Mc6l=@C5p-fxjqNCP&JFc3e*qT zWs`s!&)7rPV)A4vB?CCES?(9%gs0NsUzJSMENeR3>h6`tTi}jlD`#~D0Z7R1^`KX4 z_AS>|RigUMk^Q8Eg@txe0;HIa@#1O`h486Gwd^M-0Q%Z&SyOrNcyV~i+#hAW3v@`@ zwZGZ;*NAHFLAL~m^NVK&?bE9Et=1UVh@Ur)lr&5wHRKhOrL>uL;`=VHtr|Hrp}io@ zuHoQOreXAq?KD6vW!N)7d`yI{KJp6+ODve_J8-q*bxI>o{{l;0fjYnV>M(J~Qm;;Q z$sFi93TTsB%nGkvzeH(R;!H0dd0-BC#~Q*>8{u?W-w=GYrv#LnhOOvj2!J#tbPkZ< z3wVJjj=o$up6J}I$-Jqt#sGH|K3xquffLaC$LU*d?DSrYWdQZAkGwR;6GcFR41o3E zV*y1E99-SGyEft-zwzvq6dQ+g?ku|Bk7oigW1KMy*K#mTK$C3fG~#qohhYHOh>rUs zu1XI!w``d*D+>hPe!BJpJz~VveW{S0viMZvl=bwTB*(dzS7JQ)QyFwFZEjbq=VA)# z>epIOLF&^Y*hwXEkmqaHaCzsyH(QSd@yaZS>jHVN7mxCdDZ7Pqo}1N$$G)xP2aH@s zgrxz@AD)x+Kg?QzwOZKfEC#*en|p~7hTMbWcKRZ z+;x^|tN1o2U?%pDKwm!6U*;N+7{0n@={qk5Cu0k?+>Xtwn58&;Sn|Lra*D6@jG**j zaDICACi1!f$jaW(FQ<4?E#bqM4{k=VC2GQ`)T#y}(^NP;VEARx+Xz}&1fBzoMh)Aa z2zBRLv7gNmO!6xF0>)uJP;VD1yt9XD&1xl%p4kDDsb#T)wr&}JsuG1GwEV65hQa#3 z;>pYv?Hu|j!{6uUt8EuqaeH`DtmA7J!*QH6vGFU@R@OLt+f?nX!vU;z%Hn#_G_hOoeQ5ucaxXVd= zmbZ$5j>@LK`h$O5R#z&#(R8>2iLN;VlLo$853%biloul)>TobIJ6uXagE<~YzP)1Q zf0yt^_tR*qpWkqNSvfXCX_Tyl1_dTfZk|P<=Rh^ME#|}7F^8NS6aB6@7U?}>AE*q7 z2jUa;7NTO-fG=AdXA2PygZO>B%QNci>uSxMhHUbzdiB&UVAOrQ;+4l@GWSMm@9V4-z0H6qCY^*?rVp?4ZQfLbdl5zNdpi* z*#k9P?&wOMBBgAl(LVx%4Ubn(*6BOzxTt(TCE}soCNp-dacX;zLagJ~d(haM6=ykX z9xmAEsQqtcW7cRWJk|-?wM1!q(^eOQ*uC0R$re+2dRITJi#Qc4qE5e+p0;CB^xBMy z@+<}SlzP9GlhQHZsia)ZrCiEur{yTFM4^BA$1&J~sgI;pFQW)2j`O!|x?~RW+(w#( zU8ga03hlAy5&RJj*d9DsG;MV)GNrlhrlGuyJzLk5x6sH`h63u(gkDa$gxl{}S=h^4 z{x|1 zidj;e>*dhVSx?_yy8VPF}X5yVCmeE9-op<+Q9uM`!D*@8~o|? zF97K;+Jezpkj5?@HDDuSxso6pG}wreS4H8X5!x8AV5GbP6aJ+EJTcBV?vxX;O3*iI zpRueC?>^mzHdAV;7E<@>vf{g%lqzp_0+afbd{whwCd=>idvb3ZIStk+WE#vVOCz2o7^;Hdg8($Q9?rLh-Ss(e; zS9f8k`K_OAO2&K)NSb~er^^7IJ3?X!Bf>fR0v+WR^qCpr(e$7OPVnYd>y76k*j-ae zVdZJ?_5|28KhD(+Vywy6yC7-iF@~m;^ii^LpDv})c!+o%<9+cwG)N;dR@}bipQM$u zvsD@{BZG7o@z50QdgCuuQ>`OBQ6qXWfozbgDrPa?#+%u!4o1|=Q7S6k za9mz2PNw%H2>5&9l>VNm zL5bjpsEGk5bmc_n8B+y%A;$VmU@x^;j4XNx&4fBi3aUFSo-UcGtN@Hh-G)K(87DqUau zRAXM`$c56`krL@fUGdMULKHX+MMpgVTI;(lx_<9u-^GM*%arEBQfgL{cA8k%E)ir} z5pF6>fa2c6ZM?EygTgUqm9ZxMIDpmhKN$)3J+YAK*){Q_Ujv(7U1!!uk>lS(1-+pW}L7sO19Ew|+TL z@Rm`j7m0aPkea!Js%|ED-JymZq!jFBdbUGyu;_pRb%u%1fRYFN4RJl71|j|~_+(_| z+5G_#wA)x1`m85o1c4Rq#xz&Ae1e}#DveetJjx0RK{B%gseFO@{?P^uvi+ocoK&O$ z&dKsNi8Cx`Y|Q_MfI$yuB4aWenK`EdZB(^rGf)0NhqJ}M`mtsku* zP_%{DUvSvM@z7eBh&T$((UzstL^i7BMgXt1igLmlr~+`+}7R66=(xotDDP-s%Rm{4grf$iOS$$s!a359q20^bstBLnYN zSqC};RgTf7`LF9EZ%N^y6X~QT=d@Wcufb!HzPh)lf!75{ZJTVFsWW&{z<{LS11Hoo zAe=$zG`?m9tD%5}QA{i;oMiRiHj7)(yWq%Zdj1RnHv(b0)iFChONliUy&07I~wiBFuD%2#%VbiKa>SD(beY9N-M1OWMS*~}<^*_p@OJ?`M zoF{S>6Cu(h?&4N&HNqu&#vpLJ3G~9?0Zo@@mr#SbelsdPWGEeoG2t)aHc2=|*%H(z zz0PkKA^7iUU3gvu`yOWC`p{WSHkXyEN@VRme9W`6gmF%WB!EV&6_*V#%}HbbAnYt} zJln2LpH_Ep%Lx$M)})^yvfU^ppAMib2Au&}vn23^wMHZQ#T745SR|8fCeuaHB0UcP zoO-!P>4|VT${kCfD-4~GtiRX_F;n%QdgA@pSm z;)oi2zYFy?I@e2pxQnh)w zCf(|H+!DmT-|+90q28r{8TxtaG_<6re-8td;drsOKzO0j%5nH721gzz79LiU@{yjewXZj8xY zAMaY%0`K=t|6LtYa#4}PczMx^3m00oMgihT4NejoE6@Td4L z-4}`nd^Y&`ry_D>ys41?cG=Svpq<)Vsz5d=yipTlC1WqXd%+#ddV15yB-kPi32?;^ z8YMH9LVB$7PVkM48<~R1t@6G{p22*0-oEvxpb_8tCrN5#zQ_mxo;RvVQhqdmaX)wq zw#AI+HgRu39k=Tr0$L-!rL}Q<5=(hOfT9*W*CAHDNNBm-SWD&BAOBE{MJ0uQ{H~&B zjjY4CSbFaMYG^L~B_4V;jw+pOe?Fg_0D!|lNPQ9B*rs3d)?`22cCGQJazmKtCA0|d zJF2Fs!e+_R_N=~xy-tTVf~X-pXF1a#jg|o)oc|oGwSyInobx*}DS)UvY=Qan@j)E< z{prt9B>Ec^{i+QaL!)%kgVGXwuYFl6G{ua(w9qAK(mzRa2*-mF>BH@pmZ=S4jed~LbzU+53c58@ zy415POVD2ZuVg4p$<^w@qaEgBN!fD}1);D}DC*RbU>cLcuGK(cgXl~&YYcG;26h@X zvE5th>xd-fdF;T?@n-c$+b_seN007A}hLy2(gLbB1O zx{F?>4~)_N=f2`rs&lA^SWlaE!3OVF&i+j35Po+DERIG!jOK+LkbsaUGcs68f9onvn{phlN^QE{+%dnyCpI5J&@#S-suf$l+|WZ zPkE@y&Ksq9Fo20~Z}3vDd4uh+W~_+)5$PBOu(5AWmz*G#)Du=1YQ6k?`GNxMMs9_O z>XGuParOShc;!}qkLS$HVo_w7bG1gdc#_SL{ObNW-oXj=}- z!dVC%(6`FMrTzoBoMv z%tfw%ri_L_P3&J9#a-M!(bRlC%W8pbDJMG7K7czB#2(~P#i&PdUg`(V$f@~(O&WqI zKwtsurfzdwmU0cg*?rIKN8iB7%5gl}7H3@3hvrP^Ra6}Hf~Sn!8Jy(W>6@Jb#p^%8 zekE4jCI|=yL#1f0%;h{Hn*ixAzW-iu%sT090XGcuGc<;;-q9P*M~2?V2v7h1R_q7- z!fNVX53&V$9*su&RrG&d*y`J3886YP;#DSb5!*+y%v2D=5YEw29nXnC@A_nzA=asj zgI$XT_})xXeD03t{g*Tb4byVZ2;oL0L%l1_B_~%2h1IX?QkR%aMkxBYww5V!+xw0q z3fo*~u8AAQuP>y(dpiLzp!)8a;ZW6Fn2aGqNYjND99Q1;u62TBM?+1JZKqv;?7fHKC=o%ou%^Q$pw6qM4)TmDfy1gP)c>tT*tL~J++gI;Z+D?+GN`%* z355G#py-S9HupG5>1Jpgb+SR_#Pbi;%bmmw@<_j2;MTPH6UqO5w4JoK#}^vsNmTXT zWR(7FU}ELIi`|;&GMbtI<{zA~Lwk2zc&q)MJMFdzr+b`kPsv)8?ap8CY^mN<9 z=qB3}xhQrJ*=Fn`!CUbk4de}$bqm2*TAt3VDTVUE3;~v+WAa@=9-M(P+<6*_u8MhE|0u?Mh6Jew5*&tDLAIu!kR?clESynp32w}EuNdf?i@ojZQxe_VX z3g4%Ux`K`G!H^}M9b{QCJq)_jrRL_}@RP!iIsO5w?R-rHNBYy%oXh>K8_b|jdnr%p zCwy_ZWb>pG-Xzu%uuY3PY*p5{9JSBii!B4R+P<#Ha9b;pbqbhga5qHCBgR_Ai>@&O z+}ES!^DT0z{pmdekx_6i1i(lC@veLkxm&YE;bBnsw_4U*uJkQ!qO#N;Mo0ZY?D++q zq$9)mGONrG3ES9|{=a62k-?FK$dksM+zpAZ=x9$m9mH#k%Qub_^H0iJS)vOkZ?|tq zcLsVsGMy|y*FthjTj`!HLFbgo3koR!$4>F_Q!uZHxXcPS2%h4>C`{fh(i`%%{|T*r zqIFDez4|=zI^okhS9-+c-n&DEV?`gN=Dlbk%wK}kMAV(n65eUglbJN?jQz=X6cn_LrW~pB zST8>1ap#`%L!_(;&J9+zVeT>r4^|E4a7mLkrJdz_iSOvu2Lqxnwxu$YWlfltW;sZQ zmw_bX?IIohQqd0Y2YAlS>Ru=rV3yUsV38`jBK%=?Q%@FN3JW~iIQ+8=&6pjJkW?qe zsH9e}1%7j~QacpVpMV7wQ=3bhraR`tVuNx!E9v`0pNQDIx@WTT9Q~8@C4OeZ9W%O3k<}9}=>} zE^vfQNLPOOUYf5cMZ~aPym^;HbX{4IuW(Z+oH-hRCfHVvv~8P;`K>D^wPh4H?RBnH z2yC7;?1s8Twer(a1b+q~XRP>gW@FLOh(7S&hj%5ncF5nNgMAN${fS2Z>WffN{T0&@ zwSXXa9jcrZt~epk)-!sHQ+`!mpMHP|Ncj0CaC>+VyWd^%2|L7=#PhJXp2Z#mFG#O0 zRu`?g-{jEJSo7&0+=T>!dmL~vTHKt?%MGuKj~OZ(z5;|kZak!I1@>U}Q%3OHj8lV> zGOc~ z`aGPPRTDVy8(r^icjkw=BI>NqNlhP;Tg)DOxH19Y{%h1C&7O#1*639Mx_Yp)IV{=`x~47D}ZmX z`+R6un2SNZ3xxWy8+8SVGSiqq&MIwayTy}$d41{R*v zgBAx?iz%odN{!+Kccy|YrdJMeoDbh4C~{Lbmz8WAH~pae4A~O+ct%=|`%>f*@@tFo zud*bV=&h+-Ktv!SSZ#bPXxBW#cJKUx@1q~&lZPopS*zBz)6$MP=x+(4CH<*w)p>p40s&86-6qG+RjZYG4@ zv4&SF;jWj$hz4w#^Mk7N?hqiwpu)5n zbo0ibm$I=^OQ6k#O9>d50bnLTW5B!x;ITkL>};o%tKTR}r+NmcT^!?b_b?sK?;pt& zA-d7-`e~N9T`K}R)UTQ4T$Ez~5nTA|lPPONf{1VrEUJq*Wva~L5{%(BMKrh(I z{ZzNW!)%R>8%rL^nE$QonQMz7o0rp=Z`L30d~5qQf2-`;ib5jglovH4bGNUm?9eVT z`rB750)_X(8yupT^MTeD_P$z=D_tV`CcbL2aUN=b0JIe-=}whr=-YUz-Wm~zisa|d z8kB>yz6n)&R=|)zL7_R!^(VtwZprc85Sq|1d;Qx&18qWWR+1mUCNv^1u0OvO1IPeU zpKnkRE_e51fkY^67jPHMcvetaivxHysZ0&{pW#t+7gf9uIxS6=tL9zbkki6mSiZZQ z+0iCXjl+`K`UFY9hEhl81YKN@3cm#=6yib7!4);+x?KKRp349kkONlH!6rki`-XuJ zdjSGG#s>$xetS}&QJoe?dha~Zb5~_--l_W0?p3lTXS~G9uHFy8AA})KA>INM5(t9z zuV!);yB`n2v&a1m)GBVhcCO4_h|r*Tp_oOnIM__7j?ZRA8089|oR0?inGHjHxxL&M_3uMd{jj>DC6C06!#qsn)r-04C8 z+bZcBT?+jg?lU}K`4;kpZt|@8_n8JKFJMoOyX-9L7*Vb!pV)*XPfG6Jl{KhYBE9vg z4AA~B3_z~y;ZIzMHr;2w`?h2l>&R}Jem5KDGR2!02fJBHv8lUa4h*tY0>MW^x?$CR zY3_%xxq?f(yjMNp#&#xmv1FAp!!c_=@|O}+8<#yaUTvad)(Zytb$Es1c=BZfp+V&5 zlgYEmu&PfiWO$Y^_RS&9t2|(7ip%tQ18e{Q6ly`9LS&RgTr2+o09_^t)RQJPQ~LP5g3F*Me0cF zQZw?#@+VXP15GPfqSJT|A+80$fp>ePHF@{seZUBRXa-`3S%qvC77^jMy(kH_0q)7R z_()p{QA1KOO!HmK4t2grE<~oopPqZ$B{aT^nBtY^?Fmp33DqX~^mnDyc$4&nT1x2R88^H)^?ak0UE|A955sEj4j?fZ@2 zjf9i}Vim})<}7<15G^{w_9rVz8J${$E4WMmw+Pel`iQA^sP#Qd%G zR!!^)Pyu1Yr@F3lB^RI|Gw$n^UCOs(>@#nGjX>DUD?|0~atx$oxZtn_w zJh9bzaSD@GrYj${fvQofW%Q+OeBjk9QK0oJ3WS@aleX8y2rG;buIHIqsN;5U|4dH( zhAn>X+fpV4O>wT>O&vr?>biR`Sz7R_wE`%U4RnHe*f)(l>fOqnV9DH(>R!&r8%IMz z5^pBWjIj!r$>wQw8HX`p-~F5??f!IMRITo3+C;+C04L;Z#4o@al;rer>tc84&X?{= z6V_lIf^sMKR_I3n-;T);0IY2w))jFvDYSD*gp>jK)5I_8sV)YJ`NREI>mZ-ZiJ+7u zbVjKyEHRi{zsp`jfh4y${!Lk(XRE~S(=DhWw}RaQP8LEDh4>69q${fcGd6ar(a1ry zj}Ytf3`YouoO%xSvBu4=7hZXvO~pb01{FR5^E;R`^TyQqbNYA5lABCT|29!P+HlG$ zUDsgP%mxBU%rHAChCx)QrbL3T-Q3ApV0wGB$r(z5ZVVUl)pxhmE_W?iVGsk2he%^H zKtQnOt_QOeDX21 z#CkyGMwH9OST_)klwjoVnj9W=KJnLep@PDfndG;*otIVT@_P4#2t$GNcV9Y0(Ytif z?TC;$!@P;I9HKV!aK6HDij;TzxEv(0n58#OZp7eR8n>ZX!F3uN5=JNT@Ne3v&cDd9 zYK&!qDcC*~K7MF?=LUcdPAkR(^YI+FY%2 z7}z;G0XcnTD`mZ>a8H`UxrDWaCO@yQQ#gZ+mUx`Wqlr}|oJb>WjSdt1vUJdbcD6mj zKE^5j>W8UET^hD!y(H3fa1S)4ps^ZJC+VKdi9D4=_x|)XtUd`U9tL1-Ieop4Y|Pab zZqMRQ_pv8%ajkQU5aFVYala^GgcTh|exp|-jL87aMp=AJlK`EXn z+_TH8-)-6tE>p3)4|f;2*;;Iy6n?~kQr-oZm@Jv)vnL5Tu@p9A_VaM4kT$ClboW9d8??}cZaSHMVh2@kpW^?YxxH_M~i?CkB=r@D?6pahB0P+8%vuA$MLl$^L zEiTK$hKQxRW%>YjxujqzTn%C_0zxM7LzD9d?QMs4uPHCg!e`&!(rL4d7zQKzJY2iBzPBzZp@ z7>-~K1)Pyd8*zMmFc(+GXB=0SPegw>igqGY{xnl=X6j$~{W=vXz#heA6C_#S{H^FR znB3#Rm4)4#$^4Ro;XQO|x|DHC3-v!J3!Dm@miF`%kQnS;hah5|CHgQ0!$SMyD5 zP;a8(N>~3d32DVf@3PGP{2#PO3MG~g%5+(WB9#`See9+ftb~5Tzzy?*6Dbb#3A8a5 z^7a5p3YClWwa=}v_@n4TGsgKDzvW}!)uU5P_>O>PHdW~-aj)xxlJ9qvU4WKb$!jf| zc^W76vUdOdU#YV!`}U8bTriueoZc1mFb1B9HtFz1HKgd(@0c1wSoH+1kgKgREy;o*ygyxPJO6i-b z|HBI~W$l`H(A*;}gjPQrSV2bq!#q9bMK4FXd#LygZIt~PVGx2SJ+KWQQc1io!A+MN zIR&s11(%~b31F^uz24vzM!&=n`tK;6igpwqbTe!zbMYzR29i?B6pY8dGPTuX(%TFO zu(q95hbcmyfL>eIZ(jrDe52DG{Jf0C9$<`z$ZSfnWAYvN6KB~k)dt`tIC9cSs@oR^ zFR3^RuA=gMhR{6Zd8xUQfP1J1Cv><_x@@eV zegDUWefmb;joa&{BaS{}p$T#l6=R0YnjO^4ILXeZx22Xohbz#oY(%~XwUz&N8k`vi zY65G@y|;bDfr9Csh{V5hZ<$3=^26ku>WQjbZ)D9Z68Sl0=u%axwy|dyR2>M3=i%`Q zZgd4QiyJtd?MjZdcW#4eeyd&!MEg2-fCH;R9vtmlQW*_a)s;_>Ns+%nye#mG0e9m? zSM|uiCf`t*5WvmW-tFjH2fFDs6!#WbH!O$Z#r3)l;H=Fuzhfyjec6z%KkmOsGiYjq znf5dkZ`GZ>H=1qNjNOBxy$%*A>2qC#7G7U%h5yi0)Zfb`sw7FZ zb1DA4NlGw=K9*eK!iuCOhU_HQ>;iN!8w2&*p`g)4KC?>(#D04>Xul+=RWUEbTf8=o_htHU9;ReWlTAAgjoScf!rfbP{g zl7lNZaPvkI%7|L@&ZdC56I|Zqiabt`uFk&9YVd_Q)HMFQEbSAnh$(2FZH=DDO96y; zf?I_SO?>(6vU-h@ya~bMQLSs?>+_BH>~Nb1`!`gQbl;LXqLeoPR{01xsFzlJ5jKhy z_`$3HpZXgj^wG3LUzV8XNlZg)bABZ<0x+4jcKkvPTQdv~Rlmx#xE@wlZIhlLDW_5B zp{9DzPnr-`N0Hln-zE};e&#K^9lX)tX%%dBDaj#DAq>S$!+A+lZbsVCsYs^cm2!T zkx1i-lj)o!53_bPCJVLpTyY?d=&3Nb?bkICpym|NFXiyW4QT7KbT%Ch*2x-#Lv^AyZuY&gAG>Y=UjpTvE zD~fk&gnb^!#F2mofJK$kehuo%A{SU4VJqo$cDW?=$YV>&BE0<*vx<70j9g1g9#Gv0 zRNuFUh&=D|k-Z-zAWvrcM$BR^voV2UDLP*M$En3=^v7|T+T8I`)LuUtRoTMFTYfW-_O0ISW&GHKnTcJ3SLB-h3r zGqX3G{u*Bpe|$h|`8NWfE`l1;Uv&2J1?PLIYscXJicthH<=wA@Wr4S>Ad^)x9v_I%(4S~ceeG&h~+N(9f+ z0md~CS}i-{lw7&)Yj3U;^-&gFKQ9Ud7EcZvk1iQRWkapImHAjq^p#{U0sP|x z9YPnEAg`J3V|u*y>g5#{xN7e2z}uf3(tC>$1Kr>cZi}(JR}#UFJTi{WMg#T;Z{xEN z-u5L@`e4jS8#|$DN>FuETYxXChXPx9{%GG5AcCq_oy3%=0E+5g8m~g_e!6TCp^*b* z0J6^4{5h@3zAr6)8730UQtm^dm-24=w)iboOYH8=d@QUxF2)(2b4l|}4Ua!Yk1hj; z4FED!Gpj*S)Vm_EB|I5h-YSCnm4E$3LH3U_GHe%u=VzQMAwCn`HA#;rwA_fB$64UAbFOCh3ALV1$}!?|+$zb%suK#wt(6G@SGxZDFQE6YIKLLq{T-cZ}K* zdAI!(K|1gN#Dzo>RyF6CD?H5VD<4d~^DPPuDkfKZy|lJ(-&Z&e`lU)nLpX2QuAO86 z`#D%?)uI5G-`13_*=raFIT8LPlUR*bQ(bJBwHUopB+7Sp3d!OiuG z1%i;YB(ywg4c&ZKjJud&Z#TISD>VAU_*4=a1kQYLO*ytVy%G<&Ys<;!7p(@zW)$pH zJ(?m>$v+X)+tc7F;K+t>HY$B@)k6*bi=F(zAQB7DVE)JIA*Z?F)aj-tTb?14%2#Cq z=WnhI5RVy#hVyB~oqhNfiZxl>dpZl2*i9v2$w*67yFWEe`FVbKWRWIVD`i3@zN(gn z;a&9&88{DnQbmuGH2V%wL?q682j*8g^O_&QpD8w8I2(P+Ueg%^k>l})*u z%XCSc{+P=H=KCy0iEe^MQyf3j;)9NqX0S?30d28N7*S|~izCZQ*ZLTVLt~V7b}mRo z=1&LcJ?~Yb4(e7H8Y|c#+W_cekRf7|SbXt2^uEd|g)Gv)n$1(tS>Wh**Z zQAbcAQ;gOc$pcFOvYDryRp_RH@^OOc^Lw-WdA0r*s#PJxO7a#Af@O^UZp2?05CdQ7 ze0hIi=|QCHI`#GN&uun6)fFWOHb#s{aQ*Q)T9*cO0fVRU1g}izx=~fKHOuIBN$Kyal6vo{O9$rJ zax-Bw40Cd~Qy%>zWayj^*45kV7dDRl?toT>|bYTUd15h8zo7YRbgeE-a~ z-1|>Pm7Q*SnU_&Q14WP2bdQ*RZ7_5t<9kr4GzkyLbU=Dt+SAo`$?d0P3WYSEw%4-T z6oOU7kh$3&2mS*IEcqxyZhmzIX016&VKddy0vlR(S@0iI+nZmQ31TT1{u2SvEbi8|f+^5P}F#vTn@luGOW#3r3F5D6kfSXE*bM>GJ z$ONg~kcwGn{M1o1um|D^T+GJQXh+)zSU|+#HWc~lqy8npsQz%oPvl)ZohT$lwb*Cq zIE;aP*lYehQRpCKEKGaWZy!xsSt08B$?p;kkb~aj1OiM5h$AfZI7kmU#c+VY01|s# zW84r7Es1j=XB4zxa4Hj>X6(SNH=C@QJrLK+-@WVg%BEp+*h{>MBcFiP$d7=eH>Clq z>lgqoHpp0xHh#OJW;C-duBW^&?bT$baVfAE8*?k8OPO1I)`&CI6=sJaR4PJ&c!<2W zy2u9&000gH0iI!L5T5`5PmdjDQ&-}5L+%_R2jrih@Nb|)gz5El+y5EWoIJvG(b-}x zqZ?efWkF?sYN*g1o#5a8&$3$?ld=NIfB<)uuM(3h7yv{bMf~9$6dlhrtD5hoB4rE% zy42YeQ*ublj6$)Xj$NXcfDuoqdRY7Z>jZe)Zpp}>B(uD$&!J=2?R`y63QMnh4dNBJ zr8^1y>GI+qZ~UH`Z@ z^Bw=Y8?Ou3odH63c&_gErh=eDm|b}UYNM+}7`avL<)kSfqlq%+S`lVfAqeK!VDtOh znxS2`iId~JXJm3@*g~2{ef8~+`2A>PhdwLAw@=FCP;Jru&n=gS)lD zEPtY7H1-s|F-EF_oE4|yFHRDyWKI^RZ6CPgty?pQCx}69+UG8DpR{YSdqz!zpnX_< z6FDy7ue9lDf$SNi)uP#2%~iS&j*qKK@9}z3+a-R1o1%3M7k1~ez#D!d)X|!1UcZVm zu=E1cK<9_I`MjXv;_xTAKr+kR)~j%q)EG`T+JgLL!~V66Oas!{d_Eo>lNQ0vWa1b4 zqdAZ26a-4jmMK$Ym1U%;*_RDK8d2-WHwnk&U)2$gxG2?=o!0K9i|2|l2tQgE0NL3x zpd!tz>@ayox3zFBKh~U0VuLH8s!EZD;rsfk zJs6*sZ~(2b?VZEN1^q{Ac(I&SHMalTWa72jA0%s^~@-|=3Ya9iU0>lE`(i;)@^zjtvq>6{-=b6jwQ zw9%>KlL}K8?jGQj)SLRP_06UuueE?JA%XCE49xzqRxkmbZkM&)JWG&= zN7YG^y(uc5F%dkszdYi#sK6o#OAgfSooO@`vbD2dBu2BKhj7y34W7`6(b?xNz=KoT zBjSJ`!_IS9>yg(o@V7NNVx~hvdg~<5`4PhfD6K2ypnvSy%y>SJ$}{9Ly&t0T^3dY@F66MVB-REwgx5M`xTTEvhU>IE(|r?D3Zxhc9V(CFyxW(cvJqCwlm z)AsGyoc*XhWxWT%#v`3dvNI6sZa*ERcEu$%c`A-?kb|Mpi4oM(PoFEsyZd0E{)iRo zFRCHp!?lxzgBO`1D?q0e_Sy4U_EjzgZAE6~{&R-C(lU2rcy)`D0`@_$%p)&#Fk)L2 zguVUYDm(*TOZ^S|fuqBpyTd?S;4$>Ml`>I!3ZUZ@Dd;RorhJ$^#p$_y1SzAOMzej; zlX#x|OXQyla6JRm#W^UbnZk3nh_h1Az0#YKrn;Xnj?~$NG76iiQK^ig|QA<_)CYp+&YpZ=Q0zPqA zwTRPl)&A0(fZIZ{^v70yldoWWds-8i5oiRvJ=%-=Y#MgC1ppp=+9$Clu{4z{VVd^( z;zVWZz9*Qi^(ac9{0@ic0ezUy8RK?_$Ct(r?Dn2m)NJ;D>0Ra01-0p5CYxH~lXh=p z1EB7w=p*s={>`)Q2LuGc%Ej4}LOzkoekTbmC;2L_Oxp({48WW@-;N<3yx@Ao|ARKC30e-obsOcu z!*a;KkPWNyPd+u5-)=)ECDj|Z$HzwL_^Eg(?KORJ3v;(*E#!!m3@&2x+O6xpR&VSp zc5%C2;DSG{xMDc0&B5=G?%GQ|cPp^FdIXr5X4#S~6|gf*aRm@)Ukq1Pd_MD%Unvcy z%|Wea77V>AU#)dWDWCO2k|bF@DLmk3<*qAd*%F0s8!8v}dskfYl})R|rA>;vA`r}# zdl-Wy$W*d|?s9&~JHGIJoN=CdWVs~^k>wS8^Oetk1c3jO{l0U)Q+e-KeD+b$1JTWi zRaDV;`XTQk)%2ZY!j~SVcwFPq7-uKlkn8{CSUlmttRPU8Yx743|uZ~XcD?1 z(}v?|aStke8PFT>XOK5iBu^F%=`)MV1zxKAk9!+J0=59aTbb$>=`Wsi!`dEiO*J;$ zqZFZ%^%2RldvA00gKDm{nG!m1$g)nksqC@=A*D$6cdWe2qg9`i3QxH*8~;^8xo}N| zS1Wkr#OV;W^8j@`Ueid@UQG;5ZB+6@F=uj2z>?j6Wa?8rCFl#{Ft##8bR3$8ObfW( zZWMVHIoAaOLuiL;Bbr3_w6B)_X}NM9{&6O91$$6;h=P`t6a<33Y>Yk%*UGXdz)7(J zOC%-B2bCRlE{w_ntrZ*jKjB15aG|<_y7|5SPL?N!MUCQ@mNSw7(V=K~xH9Hlbe-ue z!8p~my5O!yy4-C1WuN2c$E`;+)f*IF08VVUKOBBBvwe#9z$nA6;Gbub@NoL1>h>&( z*S0s#X&Z!1{%u7XIFhv@zE0BX`*reCA|m;9vR7wHg51%lVp&@|=Ioxz`aq>kK~Bus z1AyE%R{R1Izg|J`QX;|M|6$S0^_e7bs+Q@^McT0x%_sdDFUX+`0LeDpl_lebE>qkO zG3c*K05smpLET-)+3yDejNNKb?Z+Zj6cUT`ECFxo=?djsTBO^LbSmnTi$3;>%F!<7 zjv=rM1OhUt&(IFok(CCSAAocio{7;&m2(WS*23zWw=g+& z&&+;8wJ5{^mI}*abOB>DSkPj;I})z77_UWoU!OKsIwP*K6NUq0BagHfbEIHNgDf%} zn|*U<--CTWku%Sk;Lr8a36bqnWmd5jzp_I%FG^goh-T{@>*;)+iB2z+MfGG-u^Q0%zBHkFMYh<0Xr*oft2hf=vlJe&DE!Mwgx@w)!o>*;awB z#pIIl-P-E4QrRR_72n<5-I8P4m4a7v$YU?M{2zZv1u3EQd})nTTW%lqvhJ(T;WVneCnF2yR8Akv%Beeq*YVX*+2D3E zMVM%J>;OiT5WrT*U2C3&2&RxV1npVi^3`H`b-SxgkZJ@Ns+Ri<`Xakh_5`5S_CfdqUV8|&qKzLP9JG_us(2bIc+Jv>*V(?SR7=4{g9th;6{FkHIK}LzxTMGsE=N zw^8JcmMuU401TS}o?~u8e*geapgBd$;*)Dt47VJVL@&7(lO8(bIRLT(0iH23C^deQ{kaLtaD$6l9vvsl;t$ug6|&>s^Np2a(hoxY>vOvQi@D%a4|Jkda zl2fikiT^GbMN`HlMD5kUX-_KytJ6CSgWT4inzXAf*{r+5mKbb|XcC;2d} zbM~6Ub^5IMJgJ+Gc@zDuhTN?Y!Qvn6`KZUzf3Mk)rhYE_S4~bPzd?mW)iR8xz~B7# zr|NapJI@lp|8-f90>2lSp22Cl_H7&4vuO}`TzzIT5WoEAXf*7JpA?sjwyKi(rTK9b zzs94g79;{Gy=U`lyY^s3fmB;_n1LA~9m(>cFmR^Uge`ZJYE?y)W84GZ(M${CppwVF z`TULYD4YI-!E#4N<9R4k-RS7DvBV4QKuJT?VsaSqCjXU8=uB1T5D1q%w4*a?yR4R} z#T58QHpN!0*@a2<73eIU)ul5hUr2E3cxZdfJ)S2hr{+tby7BpRrE>bLHD}RI2)SC-t$_wwA31ZK(-Zd>D3<4XM zA;95X&Y~P%jAW#!(omw~x}ca`nAMAmR)72%SnF-?B0WGO$pF2|q^Z$1)fpvZ9TJBw zuS{q20SJjmhZ5~p1qi);3&+BJPECs57M%W8wH{CMCGE{9N_x05k|HIkF|@htrZCbl zV-%fjTVcyQgyJHWV7;WtPShn@(9wlRe_IsE`imsCb zE2r-nL4ri$`wXM!VeR5=fT<0gtQ|LBy~p#qkvxkGP`RDN;~woo*<e2r=HTB5WPw^Q8AeNLY*e?L!#KzE))3%WBD0~U{pf-MVjGHmtFRhDg_H@PvwP(Dk751Sc#JYa|C9X~L{3UE7 zApzDb6f=N9>Ys?)-D74cbUIOmI~EvUe#jK(+6VQC#wz3aE1JDo`3K2NU^0EeILUtj z;I#<@d^Shww=%&dVu$Z(Des98mN>N-Yp5&@Hm%L%{S9Z&6bQuC9ft9}yUeN!3!%$SR>^+) zgFV!K*>|b%zw}RW_%K9yFt~kMK4}E2D*_ghSK%5HD%p1blF#?hsckxdR4%7VnmW7U z?cd@H7WvVKTbAOxGv{xtF9L{@b^sAgl7k>lxg2%V=)XLM2(Cwk3xg*8aW85!+iYgh z$H%G@R}!h}?<&uw?w&;B^;=z_jp%_$%A3+XTr|U!4T@^_a)UJvaJCJ%i`%Xef0o=> zTiPFlTTNW9pdZ)`^YVT98@jc1o8`oIw^Jy>TM8Pqz8}L~Jp#l}Xbu9oX70>a^~(i{ z3xI#h=m}O;$o9H@h&rKz3+JK{k;(y+TLDeP5SFIVmWwUG1yg64&u#h=GSTnHjWhNG ze1R%u)Z2%IPbK@g^!$TnHuD)t*?^YGas(GD+!b<-GNv!--d^kdAC+VJ?I^T@8*20_ zea{LxS6bF<=9T(;?0Blxb1JV_&JgpqojbrKp<3DE6sDTdgurwSpJ;$S5UoMwFxE~3=4|0u zs61&IY*;>o*rOBa&HIwtQI8G_UDG9kjq$;->Ulmcr}D?VSw3H5n~^skzm5GIwehf$ zQpFgo3O%BJBoDt?gT%Nf^e3W+%-w?!iCZ@+_6r}B1u%j;I(Xs%_4Asm_l{n9H;;#!qLo-ZRSpR-)0pj;5 zGBe$U|GLrGJNSS6E2W49fG~{h7xzPIvJR08R;mB_ugb> z?Fm5roDA-@rY60{D?A=xOF)zGY2mLJvnPiVzRVyXY(dBZngH<$EYJut95W}F#XtA`+ZA{>`-Z1jVYxJIQf#qc)h2i z&n86eDvyk(WlvJ42f<3HY2>j~ZVqq9^t?A{wDn75l3@G70bx}K1n-gqW(rJ_0`Ar= znS`kX@(hkRE^ydTBgQOaA+6~_Z(loGp$t65SdKdD7P91i8AL|M6*!U&9SNi^85#Fj zbD!CiQoNa9W#AIx(bXBWff0BT|D%hzY!s8u+u3S>szY4!i0wZ|$uhk5>fk~;WWLDN zHD(Fl!VJGBNS-YZdK%d3f%v!*Ny{h!J`IBkY>EGE=AOg){WhEs|Uyo7kcf=)ATTK)-LmU4BUp`wMk*p`FW%>uPpq7%4;RH(0rdZox#eTwa`5j9V(uIB`X);ch1f5=mz!jd@-G z_Sb}{7O|@s(Lr{DIl*5+E4xfy8~Yf{U7dgrZ!pvV304zNC08z4&BBHC`0CQbTqe&} zFa(^MC`djagzY^yL~vIdjz&QM04E+nnrJl$EvYh?1ULWws#O304o|%@n9H!P04Hyp zTgpZA3G;*04nT%XYyMUIH%?q%6o1N^lo6qcVdbMPfaiCFt;(Ea)MLGq+F{NafUxaS zpSbUw7TzYQHYRqa$GIn-A%9NgSrTi&FzW{=KrU6&f&^2MpkavDb%mD-5CYx;KJslS zOa?*BevI!gNM7q9t|a?+>iZD?X(f?f6h$9?tcS)_pd89{P&!bqpQPONPq~62boNf0q~O9M-iMae^1m zVygmf44g;l&m;iSellaGG}7I88EI3*A(Nbd{>`e{#Y+LMP5zf!`oHehT9z6}v2W-Q z_WgH1vB(Sd$FekS3cNo8J9CFZa4Wrha8M)?3a5rL5ak0EjLs|x z3kCi!`RZb}8tHB&#JD2?P zmmalBhGNutd-c@3h(cS)(@!^zfX`%ilC1as4>m7%)Y1PRNG9O%U$B1)E5zd#960sH z=3e0KJkN|WeTgE0>u?o`{VIv8>jehyL#hmys(7!tS8%rHl)=h?{g;i+l?F>Cu=MV7 zxg~bsWL{5glblSsDlOkG(#Ww$j~$aed37J2LW3wSEaL+>Ax5jcrND-hg(9PybE->l z85#FB&4hxt6d+5E4N@*usRvm0A5**df`*gEXoq6}QCCyp?_BiHDc2;k2Zv{{o()uh zK#uE`@NP&RC^f~;fDNoR-VbD8}2<`*}nECQuvaml#BKBIZ}m!V`s zwezB_^J4~fM4HNBk@KJEz8}d__s|e&l?$`ef#2gDay&E2$Cx3wS%S-vQzxL8#Gft) zq*sTC7dg#I9)FQ^x5@xHy9-z^B1qP19o?}9L5$+A6C!sU4Lq^X|Kyrtcgu;Jvpt#ut?DLo3KMgR_I1dh7e&bM zbgX<-#LHzXM}_stUNE<$i_GDyP~9mywR!-}4pMicl4|~BU4j*SHUGX`gZ10d9sTb` zl7YSamh*cCzcwFs0R;8M=pWP`({E2!rh=({HV&2#hkvki)s!#-!A{mqpdiTu@KtsA zr`(y=4v@rf4s@3v^aHl7cyq(0SZ7Z7(A>x}V7^A8!=&fz&jw^Y*V)A%?MHltG9$|! zJM{;ehBDew$uc!5ol0ys{XNlic~=NkX;AOt7CDO#1v~h)J_U53&3o4Z*SrB+fIo-8 z6zwe2Q?6q+^@IC1I4x0T325NA({^b?QSL{%3N#^&9my2^PcY@UGVQ`r3uuXk21`_*&K3*56P{x2r7_|0a;1$dNiS z^+cph;RXsxENW+aHrO#xD|~YrsPQ@^$gW+ODW$mBnNL94dgo&9s}gOuG^Z-+sTCCv z{8KbOHxqaQfGLD{?u-1&jf_$|Hqj&3LjYwnjw$EIkt%5wlAL&GK0pU7&1J0Q=Cijy zE`Lgs%^hX9z888yv+H``O(=00EUivFWj1k2B+>7RH(?`gqs~K#8qz2c+&O??x{JTz zg#?p80yr&$leEHXgB&yscrEukwU;|pwsbYPi_#oM`#V8L&%3X_-^sI z2AB90dkUS%zToY&{l2TXVp)Jc?Q=IGTfXb{%pMrLEuTsSBslw)r(CeI5+a_A+d9bl zcz~T8y-MZ3^pFq1|oDO@^m z&#;FyC7Iec^PGSvSv-3-#W{pOrS>ynx?$3$H(wXqYn6zQ3-=AY=RRhUr7Y{3Af;_~W7gDpLFq08i~1B{O`)(H_7J^?E-cV9;?wale)n zATsnz(}4n2fj=Cj{L(clLy470pqqUF>G&tc-T-jU;3b+Q+&O5$?$=d=ow>WaXY}K& zL0>#*H{lLJO+ruN@8%-o`F3%`ecf2#0t!2 zIK&dFO2NC7pY<-5Ei3r2B3*4T4s+(1Pn~o2<`4t^yTpLD}1Qg+ITv{7& zITJDLrC--t;`g&QN0Zaygi}AcPyeu*pNyJ&XUXZ#4KLuQcM>r6%s|B_o5W36b)sKt zJZ#db9huUh`ngH{U~j%RjnU8W+ar%HZ4Vs5+wGR!tS)j7$j|>takR5V5l8Q0mpV{> zI(86m=!TlAIr1OS0%|^rgKC7hm~-Kr+#gDdSdHUEH{*LRZ5vSKQbuFCPx(fIxDpbH z(Fp}ESU%KZWAkyfq~3GMTip64;*Q+VziW`aL&7)xoPDhWrouHVU#cK>e3x@Jn4;b~ zCi~J6`IDs=Z&GC)YKP(LAgnr_5YICr2w38XwdOK(=Uu+7s09?NWB5s4KoYnKhfOgq zZ<^wM%H;0OBQ+sm*(yc9NW`HH5K#6A?Ao_*ka@Wgg!V*$ulgG;iSysLm96mg#I;|` zs)(!QJA9A6gdX}y5PDsnf~krdlRmysvk5;sUdJc1GJ(_Rq5iCdGb|?nz$?Rvgh0ov z-2h=ejIJ-$JVWFZ6%%vCOK^JS!MyL}%^QN3%~z>AVE_#*8H#wF8|e{V-qhy?*f}%r zt<mWmeORNz+e^;7l9Jl*+TU zoe|1UfYW%&Cko<=tFD*ISz|(-@u1u>&{=b9=%BJnBaP%}^l%9Ka5^adAWJWXDBh}Q z$gWn}cyUnA_Srt=vVF)dm%Vh$Fh$3!y><;1w`_?`5DMqVzLn6;rjJ$Crcn5Qq!@AR zsoe0$A`(tlVz(%&Pz;{i(Os&3PsS7l;uXh8U<}LvYP5(mW!lVhh_6d}Lvz5K%GW;f zn{sN(lxC2AwHgFii1Yog#(RHFgFTZ17BHZEMela=%6ogDJvG z%UPo-&wl8&Wt>s>JZ#d&D9hkJd;+7myyh%D?tRyEl=isybP-*5=5@KNPY6wmD6G7m zpJvGU6r0T(xr7(U$ZSEK<|==$jrQGP^PP?JT7#IgKMv2uRkN($MI1@UAijk zWU9_%-{B;Zfku5Qdl8F;4oQC8z`D9XirRt3gIvQ@D-Ki~b6&;m zNtIM4OG(v}F~U38%{HMUD+M~HrfL$nC+3S&SIUA5c-6S_K&&l`eKD?i7e~+^h9~e8 zW6w}hlGaDJ;P?L#WWcX34ZDFrH#o=)bY!R72Uuno_ey}mAke^OpYrJt4*7d7A?A<= z^ZP5`%h|~lQ|t7MnU2?7#$vi@`9$@@A%|CgwkJ#TRjW$1VTUft@D+3^*&{W#&pG3p zq#r5U*agg85_||OmT)A3VzE?ZEhC36;JLYF-rM~2VT^k2<-+lgz)c<|G-Z*&$vj`l7bg?}z!E(@U094}Jl8 z*xD}LvB%tK5%t}&IRx4eWfRT1nR!-)6dDL*+0U}< zLRuIj-2jpaVoB?IKeL;|?VK>0-|h88QIhIZKBqg~do%qtIm|k*zcTA>6}4AeoBL+mK=Zb~uJlw!t_tk;%sqD&`K%$eiP; z$GW0*$!(u-3wre)NbxT&l=8MFt6bhsaUyms!1>4BduzKgBon8=-V83}xv%#BezoDW z!{NcLd}BXSCyYCa+LF~e9j%`!y(^}uifbg=U>}#p+DX#xuZlhFPjcwd`Pl*3-w61t z#oX~gd!+6wJS-ZTJyklsiE6nCh(KcB05fl!YT3)wamXMU8CGAp&71vrs-VFox`H{C zz5u7_(0_)9e}VI|BdEh`VvM^iGU&IpG7gH8e87V#ezt$`(Wb#b&`e0g$suIyS4MPN=)1)7>*d2}4wU8t!8@Oe9}8Wze~eyGq>jqKXv^bQZ9{lVV<*LNkS?=rYS zo+qExYv(_aJwW~$Efq+W6j2ae1`ZO6=XIRw;(d!^2Qgu4ek3a@3Ax#4qa`CVI)I8X117Z9@j1?-(K025yO|Y^ZBzajwM~ORpDRe1 z_Nv7)t0@zX#P!tH(T+wV6gvYGRDrbbIMuBu&oTdc(J$e zSp`T+F=jcC>+t>DutTvftok|sGZ_x*as(911`^~bHcw?loV(X6VRJDAq)Fhj3&uZ@ zrV*lLYn^K%{b{^)Pg_u=-1~#z5jsvE&+JilabDweGxSzq3s2lqeDx588M&N{vS-dl zkG-fLV1O$Kd#`>7gD#wMJcDTSwa4Ni<#uMJlahxp+wZI%b?1VgpHIN!)B@lvKFv*?2;(I znUyb%oQ>`r^U@8OSO{$9A4$K2r6U9&{B@M=Ce_2hua;+0xZCpj5Y(~~rt+hzg{L)) z!lg-wfXc)oG(Jt2tqzNE6P;dQQfK0;-+~3>6Ank~9w(?frLm{oYUgq7_sqKp+xlZj zgee?S} zUg(SS2$Hb+@4rScS?+p0cH%w%0ERPr#bA$=mwr9B0gV@&CI&_~GYjOQ=fr5u2>O^r z&qB%H6p?P?Iu-~ z3f063c)%C}Zw4HPvZ4j+VDxwK7{=>{Gi36q&9BM|^*WUoa-`1N`vb^d`Qc&Dslpbg)-x|Cl-V<6zM zXQ=w)v+B_54QpfD2RF3w^|V|_q%S?sAaMrZO~DX-EdDqHO^Jh(XN9?AmqK4lzSiQJ zOabyC4cIwpssO1bxWH&^sPLu0CDsNNl1*^h*nfPuQvf=(d?4WP8y>AcK%7Q^L*V5C zq|KEslZOR%67<=q(vOuocbHqCk=dHu{sZ)&hRa#2y+e{x`-+I`05s!eN zI%WAG!MG}kGqtk+b#h<6?4aQv;n&?44T)q8XaP7^xMwXDrEqjHSUT`WPPURG&-p%s z&9Dt{;i|s~QSYfe7Ch{~8B#jv-q&?bw5m-|chLi{(j;#6him>O=CY$IwrGKwi$>ZF z!{8YFIj3YdX?(c{>BpbEE^nOM3YF~{asQ7Pe$P*%TNlm}a=Bn@Fg}`>93a8ZC>PJz z6|WYwi$i+JPjC`$uPKB=>pW*{{Z^@Ge z+9F9^H%?Yf%w6M({A0<1v&EFrC(I(abL1ow!fZj8)lk#+p@bNX8Rc1Ke~^3y-~r#C zHB1U&L&dupvoy}nqHtx&cnR!8>;@;F!xMxzM6Fj&0azJHUwgJ~{yysHL}aP=hqH&w`oQ-Pt|PN~=8anv3gB!(*Oo9kU=8e#G(evX{=~mu zC1STl-aKE1`klWcZlO5REJPZ@B~y%lDl?yD+Z-NjgfvEVt!y?~Tw&@hvY;$}PJ_bo zC9C`zhCoZ~v%)CHmDwQ&_%sXMFHWETcL}KEPfPN-Y*Qv9n-Okl%UB6S=R2={(s-{T z6ECCsc*%uOrU3D#8I3E3l}$T;j>NVDVqbBVKNZIlZUmgvUAN`?)Hxb}{72YV-|A<9 zfiyk^qTJv9Wohk5xzlMHV1+Pk{<2B$4`Z#{Od?YUeap8T#C|v7mL4m|v!(-Qj(F2h zi>&xe=k5yvh`I0+?g)H~3MF|c?>C|v*B|fY;M#uJAZNDJH3WG<-T|*9P9*CW!`y<^ z^rD6b<-!Tqat{z{JoBsx`$M9#MF+-o>Cp(YK&q;Y#p^&St@0E7N7r{YJ{Jl~EBxLF z*R}U7l_ElqM`*d5zOr};0x^_7RCj9?^7@=R_u8jBs;f_BceeTlZcBiHxr37$qeHt! z>Z?V&(t86&(E~&*>Srs|>4%gtAQ7(fYT$Q(&qkwD2zkJ* z9D#$=Vybb}!S~X%%OUo{_%u@e;lX& z#pmXLJg$yTYTG?^zC4a~O4R*4$LI+!%Y%)dL2?Yuh4W5W(>v!aL>oa6mEKc8+m}N& zl(b@`G|rW=x92{$mG#l%QRHsdt8`Xr|7@-Vm|}GZO1Y(?)oN5^mX_5^Y?N}dj%f`M z-hT5)+osc|8k3>1mogMe`@ieC5YBJq#YfbK?x}pA^mQBkbQCr#@?CSek=oc_H`jIY zGtF3frJNt)gW&^>W##IFWh`R}y5X;9B_bnvCv=m72#NI62uzS%m;%vH3I@7=vu`%C zi4zdtBhNtb{I2i=t`kJIXReytwV#&JwV%T)-W-9bsSe@@jFCnJ%$PLHn&(Z%`FCpb zdLRIuBVX9-5_xsZg>tzc@!Xfz@)D`Arny-9ttT>9!d?K$aOU^$sSAJ z6AY$s9)4}ZgG{SvOm1)J%`#8ume%ZZZV4k1L|RGi=(Eno5NjCX#Ev3F-k zh8A^VHEScO3G>w7JNP~s^No2h;;#aG55pnKhc65fGJ<|B_9ACR{B#mCgzd9j1{1^| zVh4#^#+B&tHV4*?;O0PJ@B{e@<5kFgkgopK8fMUQD*3@Y*qS+<=?%>C^eOy^q|F() zXjQz(=bqLNcKwgzt=SEl%+;iIdbQp-uIb23sZ@I7)>#22Wof>$ia%RB6PBaGe z`Xi2;1%=LZ4S1DAv_weidDN`v7djLw6w<=%GN;@F(yZ#*`!cZIabBOg`?8+{%}utF z#T&Tq;trR)?Pml|^P?N(T$@UB;5;KBIf;vKgs`3+&R|ix936ZdLQSm>^eUk6z5X75 zM1!kgZiT)vRmIoC$P8FmtTRR@2v$rLG7P%$koF;%S>*%#w^K595wh2~Wx2-P{b5MR z&_$%M7!jM1bgp_P;M}|hwb@PHS^8Y9=?lCKr}aRybawXrnwp(cMk2+T%U1#?v{ioPY6#1$?$K-mcl;GPT4r$!u9ylA#-}5cKiEfxIFG^4;BcSuqjN4!$oKE>R=tr)p`LNe(C2))aEAU3l5E3QM;} z%2ric!5vrAy}E@z`vHK#So%LEm^QTvqH243Xoqr&1_d<}N>Xaoe^;drr2gv_HAT+> zc8vZyW1gLnR`ayH=dyOv+Qs_uD(nAZ?rIsc(A$O^E%k6Tf9i*DaW*~u;%a8V?@!^@ zua};z$LM@qOX@9p@WItal)yxIb+UO}9u6tVRFw4Np4M@P9#-6@8vi*lDA^7tBnn z4>tAi3WNrAsfFBuQ==$O%eb=G;x=;L_P^7F?=!|*pq~|jp`pAx{-b|crF4rxG%$;|{$(u$JK z9pa>yj8s(UW}6VoO(6hUnn$YrOwQ4Dj7m3XrXh$B`8fmVMG{=F&VJScQ=>fK4=HqD zMY2!cuk`9lDH6KFQP6_Ipik*@mT>vqNFm$JjMqjkeRHuC1CRNgJ~kgZW~X=5cpx8q zt>$<{9;MMW9IQ7Lx~=dPSRlKdsy>uM%DqrL%p$6c&FSLAS?$+JCmT8s{NO0u zz^Zci)BQw-G@07W{SHBJAHbj^xzj+iZlz;0^dXGji1KXoo`&L!v?oTfSoirkWk(JPQBLKu04Petx z&URoxLyAJ>n%P@thz)V>GS^=n8B$TM8p^>7?N^7=<0&YYs(MSTxB5^64i`O*83~0lpxmt9KXe>DssjM5&!%+V_ z+Vy9ArE6FJuDw+NRxPM_MP83P07qPz4qg5o@N-ymCa#W))Q5nu4i2}`I;k-%{^_j7 zlEeB1FpxOz^$q4F0|xPW&<%2{C_1ET z+P}sJ6fVmWNE>LqDi*CtVV%&NvH+P-2XZIht8&K@?ukFzX>{!j1NTqi|NQMS?vq4L z(Q^;0A&ke7-8aTM(Ja@Q2{HTNAbQ-PTeoZhoJO~b;y~uh6D)Ydoq8JVK)-$GezRO} z*JVNH!H;=b#WumtB3*(8q7j>Lt)%aQ=zlst#y$6~*ID0`&#cmNMCI?iDXGxs6Q>(Z zsFx}q5?VYrOkgN^0DOopoQpl{^SgGH@~W&?AYo6A_L!jw9>c}x*z=YKFR0X`>~sMB zl-7alI5+;oL%Z&}oxrEK9S~^Pk05H5CmX+}JK*=z2ZK@d#}sGhVzVV1{}fas3ud-U znN4ct6C6fL0AyW7(^^5)6^iZ}hJ_Ej{0or!y??P;S@l{5jN~75x^^l!Sl@U*w5bAH zA$<2H^1!)0OyNZ;XX(EI&(k~rXyx4?$Sms9VNO%N(PX<|Gfm`3_JRf%x00Q8E~Kl# zD;;&91DejLopD=`%%Y^Xtn0$17kY!!xeAqa#%*f0j+~TWTPEb@_(sa31rGz|y~$*^ z6Z{lM;bziqPXH_Jy-c|Gb?V;iAfLRdpGS88sAyfaFSpFz0)Bl9e?BI!>z81EtBT zXgqR-3wTtt7z>{8PXRYjEBflYjLe; zWLDX1AM)goeyyOzW#6hNLh%74K7~BT=IPC<=P1$7XY7DQDqnY%)YKxD zlvQRz4e9zGcCVMx0rPU5cpn(7)>(f{nP9_lnVO_&6?BvOwgdaz6OX)ZqYz9p-u0r! zzrB0l5xKJ7IhD8WQFM={7riFlc?%$*)*%RIBZ67+HM5P)y+`_l!rMfSj#R>0wKGTJ zxkk^QZH4THG3?G;d&jx+q7EPlNGbI%vA6+f|sFgdyLlAJm#0|F-qV+5&zqpiATaav|6} z@qd$AGq~DGNy=g2?f?JmZrG@C5Ks-R?HkKSjt;SG%Gb)JAP@|73&eQVS3@j2-7Wb? zlb>U=eB!@9Z|+NbP_osdnrN8bPezqPg=E|*2NM`VZ*I4miKxNZ>;wH%6t{A~ef&SA zNRqGG7+>rLuIG55ZvBKjqgRJboKFZni*@cm#E4c8ZaBqbA2*Qw?Dp-PaYdxc?t4(4 zARHlS!?_H|im>1Q31|-C@;KH%ML>v?#g#!--qTWvB_4tYI~{+2F5wm)7yrgR*`3JG z;8K*!iEQArxf_lVT!=6dF_EN<`gP1q>%88W3E4-@r87y(WvNw64I1nC(TV|MxFYzW z;Q#;?KS7>`WRyf)EB^ohT_y?ClQ<DH8k1E zwA1zw0ofR!@_9YT$|yl&x;4oV?4qvgO7Ra=-C<_t>w&qlb8UoB&j-JZ#7&{yimT`V zs746+Mj&My1G9S%*v9w86YLpS!1$Ix-N-76HU0E5j>5-vT#r#U3wdt2`ZcrG zM8Ow_t3KOu8a0e5q9u}`Na8~V00A8mUy}T4=pkB%*m#Kh7lS(Cw)$ap`Zz@aH!gP# zmFD=qpVkA#7*5awzfUErd1(+w&~|Slh#FrGB)#0xw-Jf5}2G{ zw=4QQ3G=r9@hCO?yiQ&zsOrHSLP>!rA^7mqb~Ua|uLU!s#36A3wXT0XD{mT48gP*G zX{bGzE(p0|W~HC%9yp9$BsID`0P9f2{w#^pynQHjc9W<>6(GlP%FEe zTy%Mp_XpmK=;Ip|dkQ`;Q$FaE&_bO@wu`vrK?lrLF@nJC7kps*vk#Gw+UmkWM<$9}ah6^B!jg#m1SZjzz>8!=Dp-oRD4*s)8j z$E|K9cd#gHSj>DrfVcd3o$@PtIE3Uk(|%ni1g)g`$Z8&JQrlO?Qi`7$I@oxQ`fk9| z=JfDgbh@LI!H!vx{n+6H7Xe{;8%|8QP{ubQ-U~H;Tln#w*W|w=X%ge!{O+wVGFdZ|eOAB6rO8Jtk(BCy`<}3zJo8GEP@64gj5NoQ3*d_f&EwvA}S+vHs z92lFAD-VFL#)8v=D6;R?Hoq!gWh(-n?CpaaJ!Rgd#qHMB$)U%D16nC_S^W*v))F}e zX)!PVnmhjm9pofZ@OB+IWF4xNaP0$k`F1wrAP<%>@bnD22Q#rQ`qusBs!ghWoMWT> zdhrxXm26<57jtrlz!>m?j)YR%%pE^*JUJW7c7C0>Nui^^BfAWUN4Rc^u`gNlnIF3J z^8KU!)guXVxf^L+8)L6@ARiEfiQb96)$0)Yf^{%-hgOK{9&yM813|p}Kq$vPhWHjr zDU}(R%BQBz@3_E{T-4DF`49f#atdBdo6&NJ!8UbRxp~g5-q;1+OJ9lPO0(_A#U=ZE zWuciJ@FpXPsfAv2n;zYkxC_@dsU)`t3{Z%44fP>)C)wMovdJa7j>$>C?ORkV^$6}CTFIO z_K3sMCuM?WV(QHvv`&00QqeB{Uf=$h^qNH2uWty z?IxZX-sdwwAHFyCNUd}vpPoUR;WpV!E6KHRE~V@2Twj94>yO+iF7{h0)p>QCDn;Ow zG)T>Z8+`xRz=~Kz4XFljZ-@BqHlH8@E5Hrf1oLa7(#~2^Y0;x%5Gbu4 zSK-o-!JZ=mdHn7~W)w&#cdfoYqwpyh&;3|qYT<1xBW2}0rsKZGn<%5Tt%jh^C_|YxzQYVrK#3s*2uosy2ied5` z?mZ2)T-$V*iN5-wQJ9qUmn~dGl83&}*{SP&KquBmFo_yhjUk~UK_<#uFc3*k+ zo)g0qD*FGyC|eV`+L*Z-@!{%&!tMu7+N7|lrT(EDma_d#o}lT+k;FK45T7ue=K4Ex zwiXWq3v*e{$y*KfwKdJR?NNbSgoeU00@IYJjH@Rh}zK zABF{hY7mA8jUL%qu}3-wRE+aD9zS|C2DmsEnY)kszTCB=LZdldUBA33kdN3fSeB9KeIriDe~eZIog% zg6XXafbv2iHxx~?;>=8hKzTuC20q`8E?NF((n-9i$(n zcw=`_x}(7o8`3P7Cg7V1S)A;5LjJ#a(`0XR|18)(JUhYg^7{|kfW|IlemfjGDrf>X znQtfYijFJDt|K64>pYfdMx$c)US5yG)gyU^Hteb-gI-5}zmn}Q(1{B(Bc5+m3b<9E)l7?`Wup9uE(g=d|c*kQ&<}%;# zW**Mh`IE}^PAB;ug(TVh&q67e=R^n0I<{o_)UJH5OjIf8XamHivPSjVJ#YR{2BEi} z2sRqyK%xHUlJxXv1yy#uuh5s^A4y`8$k5}%AlnoBnv)%eu@cJ1fIcO>X#klb%W-ex zw)L!v_Y>jC%84o|@|_%4tYS+IKx@0=%^Rr_%7nvF2*_0rBw~xvB=ES^Gn5bcIsG+z zNqldU)mRlfFLnjbUnC|SwfMxN5Lx{dasy^}CINWmKL>&TnG1vxrG~HvhCym)=(Vb+_@wU2Am`O88MUV}^Z# zi7y@6hy{SeR7!Rtuch_M%uJP7DJ#=6hbXttMJxI|EHreR%G>9#-adMG1#J;wXBfB^VG@GzH4I9y&40E4Nelui+~e{ z_FxgrF!AzzG!xLic-!K7RlwlsHzte>$sV`#K|r23Xlo#O%6;h~p#`}xw5mS#QaIS8 zN*S8-?w{4bfNIccKc;!1lUoz3lE%-X?aJPgBYE->-p6RN5CAV3I|PsDWKK%!!JRKd z(QC&Bu{-j@vXP5h+fP{=D_q-KW)A1J^@N4{VGCmZZ@-~@Rha*Sxq;NEc2L86aAgPIlmBSv_A)zga2C@+?3@lwEsj>`7p z9l}GEctWIB?lWO`YAZqV9v+Rgek_Ftc|P)rMmu}NudBK64lH(ecu-luk3VZ${%aoK zvoV?!r`K%Geyu8MSH6T@>Z>t+>mgBL4DdcV9Vu15H8hi~`WWH(3~DY+mx6z|EivI9 zfy|ZdpJ$rOSD0xneA$t2LyYC;JI#O-6@t;3f0+8Z1+kU}na50{bP-tqT=un0pJ*RO z%sJyq*(v6AmGNyiv4P5u;(_E${CV= zGuT#Ac*@*S-;woe`#9A7?k8wB82xCC@+#P{?)h`dhbBy*wNd(=#>x5@qhL~~lmZxu zPn}+*buH7KIsP7&V1m|gmeafMBG+8Ko>ij>>clQm00V7BP<5nnc3BVZKbr}^(upmM z^2o1{mlG&uu|mW>-G6dUpxvcudLvwM*I)WxHy9I+1Df6bp^u#6$#~?3m*>zE<<4nb zgoWiE_1L%YEI8-Yhl~p(-xK%#tUt7o>qJJNQOWJ0Uwh0?q^tgnm5A$6dv+od7i^Nyu8UOR0e(LTcA2k`d??(YO7_&gv3 z4QSsRAk3aIqBvagzfbkIizZjn#O>;vsL$v-uwggz){7W*uE|+S#s)vQTRnzGYx;_3 zW=@5wZw89GQXBt$1%<%Y4&)-EYGkDL0kRzwBzopc^3}sLW8b$xXgmV-yIKx|2Q69^ zth2(mx56J9Q=L&jWQdvovc4=E^nUBKKV#|skueadn5{xPno3w=64mX*%{UI;`GSQb?HIC@@klV+$ z!`!-cZ>BqE-<<9Jq$RC>S*jHClB)byP8Jj&$=$voKOGjG0s2B|La0TchfTEKpDfx> z?kK3SNOr=I=|ue8_ewlSdCzB@>Tl{A6AMHctI+_r=$9gfi=F0pvQa6XqkY;gupEiQ zj>}z>*39Qi>g4bz0~$2=u(}l9EZU>uWQ^`Ki6TP%{u$-LiaP6 z&a3dkTJH36_XU#k+(~4iUoCAza4YJm)v! zkJfXIw;;$L$wf#~AeVg1STUeDR;@xvc6=(sGg6eCl17kgRbWE{q%2V2N?EITY;u8A zr9^jpY7S|qA(?lrs!_oyOX5nTJU*1cSORM;J;J^Aind4Eey)$f+Dz7$om1+$5pAHK z(Q<{FLQR1b<*%O3^r+ zw1!3uT>{U44foHW-z`V2vG!s0Z=l%4hH2wLR?x}gYP@LYoxHSm;-U`_FSnfM=)82@ z0{Wj%Y$W+y3l1oPbsXle*ZX(^?V=SFOitCIoSB4TO2h45^JG6t89rVZ@+;Ey1s4ZT=wTv68;kD5&6Hy^RoU7Ub z;R8u2n%{q;$aKI}Jy|fBZ;`pox{*D}WjxAZ3_?*P@P5c&1wvA4YeB*7VCm)_sKL!# zF!&7N&>t#Q11?4t8blaW#=}SvP6l*EUDhFgamWY;F(f!PJUq)$7-7|+M6gGY$LwWV zom#4^2ujQri$RH*Dl!DG+f%|v$OLA$IU^vm?pOeacAT~ghWr~Gd@{|CTwju`ye=Mj zd@tGK&I2#C=ItoSZ_Q&aVPY5mFgUEcNNjS8n!fdaSTIl&IpaX%fdBvyYyqC7X%L?P z08ft{VD0c;)2<1)d0Y&Zmb;d1pJ5<0HR*5|$zALp+XTjufY<*63wP$7GIE(*deKHgItM(j;4&OkZzb~`<=nOwZKVwZ$cZnBHaZd*<)mIGF z4jvzo+RtSHv19^R;m z<0r{5=>F^WUr#+D33OM~F1cl!ukmTLHVNQcR-xgEtjbc!KA))1lScLL^si+TIaAnU zG=~~mc$zej@T{hR#E&gmZqmfGmt?74W>i%Pt1I=6aaO}->;Vc8F4(GVsxEQ4G()ZL zxUy$&Y_w>MB4)$^8tNpgI%TT}CZq*oC#tsJy)4j0Tn^GW1f=dA+&frkNX5_##cWYb zxF@|ALUa@XX4x3Yb*g;6d-cB9EN_5N#nmo2ZsDSLHY~b1)4m9p%WpvqIP=vCwbpFj z3WF}BO6|$68xn$4i7uy{MIA#rJVmh;Z(m3Ijm{cE-rsDI7v;@S-)d^rE6tt-`l^%BMH1+*FU-d;|z5UCM#2_HajErqmd} zH`4l>l1U|?ak!mTuQKeGDLHl0LXy7<>)uj}9-X&tN!Y|M*o(+c7I~Y-vaHjZJH_&O zVpWRhDvD4HSAGsm7plM($(x>Y71SC5wLHxR5`{<`UhOOi2aM0$#%m>BLhC-;FLvAR zC+1mOUXEVs!I@KG1DVdO?dSVtjInT%ZV0B|Dc_jxtzVG2Tboz`pNGChsWZZrEAK&N$hJ0$usK<}I4k(G+nn%5N;Jx)84(s!v z4Xhu5n0|_QZSrVTT@Bh%F4=9xfAt;OeHVP{U%o90+?Smq>M-Kw{kM=8j4m%q+{|KVsN)429N5o3Ut69vV`oae_^Vd+b~e&sWQOSUtBGKmUWvu zKk6VN{{R1&+Gv97r7Tm@B{MhNi|L5-bW+1+T^`q>|2phpX3-|R5gI|8fmdLTZA4E) zuxW{0F{Gbz)*Go)Y89s24`a313B&v-X_bGU4mOi4aAMWw2=4uppZ8LE+euSHGEJAf zA{szGw8udxKMp(@M(tC~_)TfU`baemHQx4Ughc?Rl8~;2mrNb7rAbG8mPD^sXN(Y{ zPQ@iOfi&kGEVb&<6w7R1!73B^K8@MEd@Mnh_ilI>K1L47n|sq?9)ubPA%=!=GR26$ zujR4(8Rmhy2W8)c+L%OuLUGxK^uXiXItgBi>dv;$u>7T+97Dh;Jr1E<`7*DE?QRx( z{r8TCdGdEx!3)QiFPxt}v-gUTVzUTk!G^x#TdV~l0f&C@2gwy(0d8g6U)Lcn8ZSW` zySTTXQNmkF zMkO_(c=&QVXScX$olYr{o*i`|lU^}WrEkyHfE)xFR?Akck2u)zX;Mjo*vG1pLLmvl|=D=Q2cQ zZy_3NEbVmXS4Cf>@XQiv9Vsga(eL@NI@ij=rDxZc4eQ%46DrO|rZ=ve@l~KPMHNrq zYTWvFIwgrB3xw2=|DC1VOngN)+Rk7(tUAQEN~4T6a`Ycj(1>ENasu)uT`gZSqS%RD{XE?RI=CD=C06B}R11B7p#wk$fR)D?S69(h zsC+&HpwZ9M&>)dl)I5`CJU|b{;%ukX2(TpQH|_7;wu^XV8+Nkh@aQ0GlUP}rAT!Xt zxfgU*osJF0->kK?36pgubS#E%y}PeP7ycqB)rDj^;QUgMg^1qFnzy^0p9}0?CyLEX z*5zw<<(d%Q0@DKXG#-bC(9n^We!A`WfAf#};1vc2#Ax3w{jpu%VQajUox>{q>2(>l z=0+J&`02>?{@t$cprNvGvC@@x+YO&MU}@?kwO+x>h)oy*~KsQrtu*EGa4mQZ^6 z9hay+!8JI5f+^vd(#4^Lr)FXxJIy7LvB=+K)OJnjw%{O@)yN8^kSVCQ4_Q(2lB)odcSNUE-AR$s z$Bi19{-fibQ|t<82kvmR+__I*IL9Kf>zV@h`A~Cf1x}VIiWp4!4N&K41#M_hl|PO4 z1^&1}=sUs`r6$}_{Nx9;A1%!LTOc$0j8^W>TmCb{=WonV1ETxuq-*+q5IyD|3xUHG za(vj!umXfAZqc=-*->dUEiSbeHS;f?%t_#4y+Xe4eXYV%)gT&khn{zlo~m?-8xpJlJsV@U3%j|c(GLE@(Ngi{#?kP1ssP(#q1iR zAiD~`Q-%~mhi!NO{a{ayW%&OCWLJg9$+3T>1JaB9N`s2B11t&3L|jxu+Y zs2z;=fQ^Px5!w2_FD-$TA91!+f!y%FiFqAXy~oXrI6I|~19fEz*rk!Q8zbc6#g-E` z|KlsRQ869I5dSQ(*PNCg>BLGq>+&VKUV5g1a9XnXvnw=rHD?pk)G1jfycF~f(>X@-;rDmPW){R48>C0oM& zQ-eQOhYybQzg%#KmSk)S5osIGsYyvrMxxFIQAfH7m4)B(Q|ERi>JAkQZl+RE5YSlv z{g$92uC*V-OoOYfTp<`s9QYnRd7>saItPErxasGC96Zbv5zhc1z3hI+WD#trhUoP* z_U;VxYv9TAN6fxRBxcM}&LRo3AtV)+Y2~aWAn7 zy^zpID-n@8B>#3m%9rz4DfIlANEt16s<;;zyhXQH-dCh$JHUw%%46&sQOmrq0(Ed` z^z4K3f*n(e7DSJVr@Gp?n#DAhkX!HI2$I1}vt+K?7N4c-&Z*?L5g>016l3#@zt0z0 zx09Kq?$nEe^UOw=-(E?Az3ATnr;M zwvxW+S#A8KLo+!wk5X|?#^>`4N@_$eC`n4L{A6vrq7dr^(O(^s9d z7|0;K>AZC@ex~v;Bs5_9At1`E2bRJAEpc0`KmZGYXo`|7$K%%4=^>^B&|s}#H4NBWXK!K_@=Y$ z0I7)i2?lVG0EXRtMorS?Mcull!)p_!^{dZm;+}`{FNVmDF(_(}))C2g!8Jnkcx>4e zc6Ip)=K_N%KOjt6V^`La(F+>@K!6fM48BU3ursvExuPF31`et{&UBqq2mlU&t4d11 zc;1->z>{JprDlZbE+m08gMf z;kiQ2W(n>D$IS@6J|S_b;DnK0#Cd&Fk))I{zH&qfMijGhVH$lTpuWN zC6zgpoKa2P5D9B?rypJjWCegtFH`c5}ASJ|;?pAkXMQ;b=CN~V7+EYKs3XZk%>FA z{|6d(__e%303CICBsRG8i$}Sg(-irRnXuZkByCW$SfvKaIZi*`gB-mi6w?~RGflQ6 zG1W5Xq{Le=n(BL4?DJnP%STfjbQnVY5w9k`ZoWHQR=)SSX$MIBZveATVvc;{YlaZe znX8QC#|4@HJeoFk{jD4Q;sd#$gs9St6zE9dFw6;X zj$`!eas%&bc8?5CAsB@=HDZqa&^x-;>CE|@hb)T3@B$F3pNbiXxKov97ox;4 zzr^4DuzT;I;M!niE8^TDjO`6Jp005F$Z@*(uF;C##AWy_JyDYnVKqVa%M;MF%(uh3 zxG``<74YuTGqj15GmED`ig&~VP?w>#kl*GIGwk}Y-6XD$>fp~;^P%p^G8SeFxb>4{ z-A>xG^eMU2&PnjUDXiaj+v#|dbjOqlQxGc7WEXmiPK8949t+02PKQZtpcQQln_Eh0 zqNU)#(guF8jur6*EHWj4If>QBrR)_ovN$m5Ob=Z%lMDR?T_QY|{$C_`H5U36LrD;y zgA0wGN4)thvLL6&THKMyV)Qd-@^ z>XfgqT3}=fj7X}Cq()^<`ck!WR^Q^QDdjbqhcU3JPL%;*diHzRg!Oioev=0qxhW7= zZq8Ph#4G`~!>KAbAs=;K3a3_(4SzR<%+@S( zMef@sxc`%mPcn#Jt5-^mBJF?jALbNRKwanYGKO09^- z+ValuHlIncUo=B`K<*;*&aOG1%qm}9251+rQW^kNCYekN{oiT8o4qv7Lcv1g-wTjM75Eq~?3b;|J21kkhpbM( zutLQ6{iU!EnYu38o8%j%4auwM@l8?$Fk9a4wCK*>nPvX zEN|udhmev73jC&~z2_Az`cDS*8a8XR)Uu@8@nr38TUUeb2xan#s|JgoN2ErpW>Izw zUnsVDum60b9>~dvWdOgQu;`E_XZIqDM-1rNd;VZu&{Ur^eNUEA6W4Zj8Et@t3(5o7pLP zoD^b8Tl$CyD|n)F11k#|Q-n36#{u4&XsH^q^Ce;7a)rGTdzWSRl&y8;z41>;X|jk| z=@6DkTq4n~AY-x3Ygg_*D_;ewV!p{~->j^70<~Go695#V)HBQDFYR!}&YrXJL2PpF z&19IpU;JKqcla}1UgG(>ds#`8h54coNUmZB`es`CHEeR)@-^nDyp9?*F zWc;gL4yJYvdtm2yN%ptn%}i!|wCOZ)Rz_FzKQ5EX9GBalzgV0bQyE-{L+Kwe8(J5eMWKgJN_3cxPQ0R zckybq>UJx-jkySG9bOY=yy#A6@E-#gLu*xIXm?#5F^J-t$>h!=%3=L9I8rsxGJYt< zadLumDBB59-L13mT%W6MDR{ZFf9RlUSxaJUV|oBXmVe*n?sx13{sVu^ZWV|>vnx)t zuU8l4H&HP(Kd>QONQFtcGy)XOH<)YSfp zBbGK@2(%DU=sBmmkzBC;D?4ap4L^7DC6AZ)2}3mk?-`xQSLZ1$t6=Bx;8I^AUe;dg z{0{|nNjqf)FVJSV3l;hgJg)0~e!prLXKh)slDOW}7^Df%Vl}f4)w7^Vu;E3L(( zYJx#u-}t{~{Q8%guzvh1X>l&K;Ry*2*lYF)QOEC%du#++LF$RiOtv>lQU79v{d1P9 zT^mDdVb4Qt85Zp&rMahnI&idNKIL4Ub#fSZC)`(Ym614jXW_m5=z}rt4e{WV7tWsQ zgSXO==!8uDe;FSqs-um;?7uJRyO-y-8H?I3afOe*zG)uN%Fb6WF1A`C@E7g0>`qZO zWp)eQ<7L!Foy16|_M)n>T%8wKe-dZsqIp#Ov^Af7QDCvy4Z4pc~Ull~jWP+j`^v(>UQ4ow(zs{%#wc_F{X$S%&O5u3YNQ-uf;tW?WKV7sGIxWoBmadlUT_8v-(7rYcLRijrR#%a`5c4wgTno|cKvpa9wF_Kaoc z&cCOIAo<_h^M{om>j&PyqtZNQ4}k*zS`N2$2%?!?1rr2m4RthJg`(1B`4RBdrsdzq zzd3$?`D}aUJHl{fkYz}pE=y0}fx9rksSZ%EPpMWVYs?ftlP!3;=jrV>2Ey`V@TWv# z1wy67YbUH4iNGc*lhDzS^jJ6XRHj?B2Sq_n#sE$&a&Z6sOMt9Q7Jd&lE)TBZJ(OWhGiK~-ja5CrVu2(j8e#l+4K*2%nO%F9l`cnKYQ%OYSRX_j$F5N+ztThNNsWO-Z zH~;>sRR91EKXGAP5Woe}R;5aU@aAz>9jQ0;RZmU-qkoQ&4foXJ7y{4e=D$u~iy4KZ3p?XqG zauOX;GD`9vX94QL#WGU;BJP2=e%$)o7wKoAM$avw)LFdicxyWU?N!Aex*9n+J7Nu^ zx9Nk}Go=DeC`1_ub?>hWjRO4nb(6$tmBat@AcJzjxMs;9bY6a1Iz*8)lGoQ=Q5w#*KgBGALywc4KI4 zZ=oazReVqXGKxFe7^z(}3urj?zv(B1&Xr-xPqy{q5KH;k87UQywc1?2?bhjT4vf10 ziJhtqZ?0W@wgswhZ6TzJUHIp8&!&TsWBTQZZ;}GfGiMr)wE4!*4e4QdCQ(EiMSwj} zME{1PpIlA~^TsMj2>YF3z^#L)AlT#UvLkb>D^3U@{&EV;WbaBUQGsRfRP@F6OS516 z%#SgWhKmdFFsC)3B?(N&ruC@yR&x7`TN6-;hh!k#q^<;I8ly*Y!b0fBRdQ2Beh(+&)*~Go2 zEG=Jq^xL(J8u_HQy--nX(w13H;+V$|w1-G>6OOrR-@c4r5M}N3x${l91D>t8BXD){ z<+u;QD34e~gZEy051+UI9f+HAGf?em4%ns#|bFe`%Rt_4?dIAd$>^k7-J(kM*mXCIdiuNLQ;` zRsZ}pgWj{8d<{M&M{7o47+ni4$Qn%Qr$^I>Kc$@rli37 zas?cS!hm=q!Qpxwr{SsyefN?igx>fMgt$$`r`fF$^&OdsXm)u?SF|@UNsOyVu2THZ zt|5Nd+v(6DzjeYC+$rNL{+GC4ZtE2BlIGvfuYEZe^CB>Mqq}we6=JZXilXL?C?5p4 zO_UOgN+g%qp3pLX%|^V3hEPe;Ne$K|y-~?f1SIAKP6C&P5Is$(!4sefx1g|+D#7g1 z3vtP~ELg2wg+o!*lgb|c+{?9B&VrYoJHTmTgsxu~+G8@=FILWiijj zbWY55z%Y2X$z&C;KRZ(1c!SuR9)58`N2L9q?ckLs>tdzQ-kcZU{yj5+@Jcbs!qCBk z70HKv#$3BDFV`6sM9NOtck%Ql#Vq^dWffv0SgR0 zupU_kW1~k)QpZYsjY)ntj&EbWT;CuNj(i|!y1ZCzS<~oXWi?0W_e6N1xb{Jlbgh%I zI|zuJeH~faWlQ6Wh5tcJ`fJt_^^ekhO9D^hHf$@T|#!%*dj4v0s!& zpIAzv0b;xb&i>6jA-y8K2h!OLsYIw1hEKNmnDgb+IcpZsbduswYMrI_r$~P2pfYJzwTOh&qTIX&90Q5(m#C5h0CYY?SwcJ$H%wRGJ4PE%e@+rs7y^AFHi7Y@U^ zJXhedCPNn)Qjv;?ECNhMpX6b_BH0zvOrlxeY@ui!13v0Hc3OzS3fX|KSZ7Pe|LlW_e3t5+?csV5SO(KS09#@Feq^Ay;`x&D105K4p5=+B31o}5wXEk&ZM>6F8>%j1I{u%whFufa23!YG}=E-hHy4TgCEpbtzA2es&dk zU)V!en<^=9)Z4l=REBnH zLBKE^xT26oQxKT9+rV(@;HwBR0|p$}Ez|;6n*a!RQ0*LJ7Y)Id<+jIq=G~LHYg!fv znjcpm8UJw_u;-dC%#j!nYH4wv1}I;-)4*2RH5{xzk97;x?=>)AYeRsgmE(-U9VkRT zxDT)FLS+p6QSdkezG2(ZQS0QF43X3ud-y?G=eO!_@Az0P8p6}CV#2qf)sC`PQIX+xsg{U-xSr6OcCn*Pd`+Hx7Kzl3@xA~=3VHB->$^R#^tN9LA(j$V+5Pi(xMUCZ6FQ|>>{t4 zVEdoZ%gbFmLQu=ShrSR5$px2g2UZm|!*JbnYQ4(*3vfY3Qj2`T-#@V5L6@ z09s30KT8W7dS9RBW2xvO=Fz@-T-a|mFIi6t{Ng(gjIG;phm4<~I3sMa16jeG>eQ?< zI6s2%vzZe=YZSY%ni#Ioi4qoL6l}K=fqgwj4e2RtUg?v4C|AGuR4f~;fg_5-s~(JG z#V3%WE7VpJYDoZ!-|4D;2Bd#EKYZhyoCF6&WkXL65XL5)C)A|cABVqlL#YM_lhYB{ zmfRs0Nc%S%CP$K=ZRZ(=q)yq<`?|b?V_D}4VH@*IR;-k=d4GmfK@6Wg#JxqFr-em~m zD-cq;7@$IzkKNu4d1F%X?~F^rRrxx?>61$460)>zMC9G29{0%q0Md*ZFGONGX4CyY zU1Vi(qNCBZ zjyc$JB?(c8m0h7N*cu^9zo-D9A$xLW!zg~=^1YhRrZ*_NcL;mM^;~w?Zz{4^Hb6|S zHX%oMSO?U@$RpqD?}~PQ$(XDyIw02`5dn7x0U~M1#C0z&h|x?zUp7#VVQI_|cfSV5 zY`$#sa~KRz+vC1HbMe+bO&qwJclf%u+rMA$f!n3jZf!rO1^9Lp>5v{fY0CftB1XMVH z>2_(hnQ&Up2UVaGUri-tI>@-PgcDN-qPGH=yecGEn2~&wsMy*u-`#5$1q}_(qa6<0 zC-XPTS&|VbcCxVUd#8b`>7YC@S?V=Z-MY;D%YhkV;;It;c zNm|$|As+eX{EN9oK&LQ{TIsu$;{)-u($q^Z~k1lti<>#O=*YylNUNx7$S?Od%>O|~)v9xxhaez>u(=s* zf*Zj(0f^**`}^^lGhAg}OuL463j{M5z;x)QNhOHW^JdcfZhihJkW40{Lg+klzJ0Qh z2=2VcktwqX%S-(q3Wc%~l97tLAG4UyFoT3z&&&2@SS|{QYrmwYHj+3+Qw86 zH>}+hP+_I>yNyJ0Iz{R@(n#)-edT~Yk&_TEOTGI4B!*?o$f?9v$EDf$5r&!+k5&JJ zep=iGbECF;PJ&9vkdG{PyyS2GKx+AM8R9w&*8Z+zy%tA!_}N4alXKb-9J}>mI)2-v zFL5NF2$-$?c>8mSTIkaB&`|1>dPkVl3p#4-a8$D^4Fb`<{ zV~ zPXn_^^taDgC2KD@({hwU`e zaV#N107ldL*CPDt9G#UsynCM;POLIux*|~{iCr%*U(=V$;JJGr>!+eUSJE1nxtwzF zhKcv~EOQ=05zg=#mWt0Iq`~D93!LI z9HQIax`i-88%E@}nddmaK(iH|3mT5FQ%H}a4g~FC0C|cQwI(gcc_Lqyy431wyr5D* zP~D2WddR~+K)QsQKMFFO?TKWYEtHZNRA?XXqv&nV?qfkWh@@(Sf}yMT&~*Ge2<6#+ zUAfFc*rp`V5{oFB{GK#UNY~oDerf`LMPml`%B1Y*rX+Dx7hzMu2=d>wV5y(KP@V+EITP;R zx*^I~8_XVeDIWc|gp}1)Rwb9qLC(5%*rq$qCe0hQ(UBV6U1k~{UY7+G7TH;SAaXgg zV>t}9szvor<09QKyUxnr4(}=}g-FLahJKU-+|D3TR^nd{u62ESG@nh3sORrBq|M7I z<#5bErrVCywMj` zgIH7wr3VVOU|t1#YMV~)Z?JKom&c?w?##JahsKfHY%;GT>Z=WORrqljr)=@V9Tp9j z4ikN+WHp)T*W1U})L{k{=1M-gRO1mra3b??lw~!~({C}M)8RHW609ZK*n{mgO%vq@ zLYom3iXYN9D1MBaV1{EBBTb}^YtwG$qpLI!U`Fx9kc~4G<@JO?SrGcW!y#F3GK=nw z6J9DH!vzxg=KI}D2H$U{EvM8|TiZe66yr{+ccznxbKWqz&UV%KSQ8o-z_n4)=^MRW z#W0Ml^uxx`mTfi|D`-qLz)79mK0!|%JSVkt64F}^vttL2c5UcA!&@sL3C256SL6&x zCqDi`k`*GWUIyHCs=ptBSDEW1;DJW);2L$R zSpc!Uqy!q3%=@OH8NP9BC?~fD=`IOMq5(KP3Q)Y7UUF@CRljN$82q%s$}5Vw$_<@b zDWq`u!g)@OoxOl#_!VAVfRj^;LTD06Omm<#d-B5p%wNjamDbHd$7&gV$1O%{RbPul zTWroAsv$7b)5BMUGIuj+majD@-@3<)NCQ=w%r?=mCz)U-E3{T9sa9;Wso zP4xUT$;Q_4;qH_cR-MW`IVIOIC`?}-EW#P5Wtd)|J@CUfv1ZgN?i;18KuLg#eHuN!kR~1!1o?kB0`AwxI{jW6Jf^v|^`FgSHTjmPkiv0an-HyakBgzI%#z zOQeJCB8E%PVU%Rpf%B1{DrkjM1 zEd$jq5{Txd@P#vIP)fGC7Ttt7vLwJ~ZKx)445gNanWf)#%A4+*6JZ<2E9e|}@o|yX zqOBqoF1Jjs7#<_uQHD#o7J%jVNOj6w`zyva6_|5nw5C;m%=ESHq-nz$oceKExxEt+ z6DpH<`Ia4HkRNOUwk3{YcQMEf%LBu(j@?`)9SO|K(rCoUcz(Nvd*sq6dWei0w3lR{ z3{(6Md0t>3lN#*IwcH%(Q^gtnzr-4i@G`2DW~>lMV#VG%mW0G9&Amn*(PC^HVBV2( zM`u+M3`&7r)n%fS!?=Hng)gV~0#1im#F*<#SSHsP?g#)fmB#TTq;YI!>e-x@@rVWPL zrC$~O*i)Oa6WSiyq-SSN4GuleH= z6Xkz38z&186oB|MRLyP=QuG|8^$i_OSTA}A-^I!W>g1u6ihR%Tebx8`08-DXg{%@= zRi}7;qL+y0Bch`J2X^lC-mGQTW4mKik;d!gdsDea_p;$RSYtT;Xkv-$)Rc!xhWt=R z>!jdi$f|m=`MWLYcy+fNT-Imt9^r{IW7J$0YjMjeHEdC&lbRGFHk2ky@WK_@6>&5V z_C(BA*tiUFGA}a-UYXh}`DIrlDQWM}WG+b}RejJDesi6EP*}zU7zU+n&F1s?&1H0i zoK8Ngh+W=v$kA-?Pso0?xNKwLmT1oA(S+j7Yq95@_A6)>rRXbIgt3W!Vxf7f$Y|Rb0LU{Y-qPKUzNE}upgbS*Nfc*8^UWL7$V8xmf(&N(^S6S|mWt-o`Ol-V4GohT z8ytjYJG5}a!s6!Q5%xs=2Q{TdDmc7{tlEUg&T!rA@M9}#EItuJQKaw&V37qe5-ClV zj6~R218qKPj8@qvBmfbuQ~uU?6Pct2I+D{9nDu%@;Y(P}14#*7czt*AIu+7cblQpL zu~8cE)1vgHR_`x(rzDSo4~n38zk!6nl-|D2XriRS29K78?}s4Hq_LRg7y;u#-5gGE zDPq8{LdlT@a2De8&K7H%mLj0&KB;xs|K8N4_h51=8&zIA7LX~GWcUm_&>rzhui;0N1`<{*sD5=HzfK!1x@nE%Z01Z!={Tg1dQaCH5HIkX4@6^>_Oq@P@j{GYZ ztD)ce{`MNhqo%M5_$mE=6Y!*>j^hQt4r()0IK={d?Z?agbUFXhPojE@d%eBSwA!o{ z4&?U+tcZrgjDfMpU9OdGXi}(fxRWuwBCm)J3OXR;aL;zMPUYpycc?hn`kIDg5%~{)ZA}Gwo^@P=seB> zlkj&n`%ogtio#@~2M<9SQNpt6OIIX^w?8*{$%yFa2pQZ;v;x8pf*Y2kpO1g3Uu8lr zEd5?*xG#P}?GXUak^p%?hQFYXvg&L!Uyk2qTWr#@=I;9m@tVZWu6z@505N4Pn0i4Y z1~cYzW-GQ~s6CW$iUQe?2)ZBmt*8ksyZCJx0gyrTk-w{?oUf>=A=Dmf;nldU^<1P4 z2pq@!M3&@kzvPph(U7hB40m)Zf1%{qxWo(fN!@Ee3Izj=_$liXqgqZD%aGW{C#TP8 zfJ15^vASSk*|-1KQ0%dI0RJysR@VX1#2~mRfJ$ArdKjt*GE9<0np>^m;fYLAGUAHe z>iC*=)YGm8XRU7j09Ie}>x_{VB0YC}gQN#=Uv`w1bloWU zV?}7*V=an&(op%5+nkP`%)uWNRiH5AI`pn1W!+Os66TYNE1#*#T?`2hSo5SnvHKp| zM?v_ccD80*DT^0}zyYUPE~rKW=yr$%6%@^fXwP3bXF5EKw}Uy7LtyP6yf%J!*f_0Dj3-1~cju{b}XC)4#WJ+kNK zn;6@I_K>@6fi46RJ;5_cT{70iSZAfcaYZFLFDHq!`=g?ERpCCF;=>2uc*Ap6N#CI# z|L4-7vGW*!zGifX=W_!I)qfq{vG_HPE2d~WcmUG>x|7VMftD~lUrkaK@3y7R0)uPk zuO0eYt*y&DJTF6V1`NrOuk3WA|v;r($%5ndmqNEj@Zo6EddMFOaI+wH_{F?yeqs@onfiNYM3xR zEXJ?ho8OuZKJK--cjmV~AiIH>X$Miuz2_rCVyBq;^*3r?eldZ$r8c)l%WLI%0^@X) z_s#-HGxkEopR^wCe8Unf`LK42Kzq*T_uOFyPH{wL{WR&XOBDsu6D}w?bmuZ znz38P(k3KtQofgtoKi%sKqsfjpqd+vt|L@O{qmlge~UVu&T8(qT1 zu8R4#nES_}eh79yM-dUy&@JRD$4QM;**j&agR&&aA2NYH`uzQ@Cf8!PnktVuZJdZz z9R<3<4yfIK3xyC+=U6}eVXjzz+~;L%!SU}FgOn;O;1D~m<^Ah8U1YD+r)e%y-go62 z$#w-f14=p0^M<$8Q2fnfq^4>__r$kKLbinc{#0pWu#(OLox55X3Wc|mq! zHR#_Fb2(@pab`J^w5J~@fyGvgnkrc?=15bO7jJsd3X%!&^B{Rp1B15svJp=tbs z%zWk4u%c8u^4r=2qHNoDMk zT5j>2om1#4sU_|~zl|ygQ8F!+suz8X3AiZ&%NVvZTUcERXW7;w_5@oD5%N8lS}q^^m??T>=Ou3n4Sxn{m{Q2)<&K{(`k)CEIlq zzEAH;zGV+T$2a?*Df`02=n%loQLQm#F&S^gg*na{UwK2E99GnjDicZ^FPenNIJP#t zbq_9Z9<`2}B9-enNGcsvKq;paB{1R&7$HOjyg9(*F?G^z@wrHUQ5jcKT{@- zp~S$15;Z1i(xTg>1)=zMysHurn{{Jdb8Yf~oK}TGaWu-tMwS**e1~FKit<}=Z@>NF zZm>Bvg+fr~0#>ZP93B}zpl|$E&Np(#VvQe)EA3ox%Fcs7&bOJ)M-AbUo-Hi$bty@| zViPAkrrdZf=_Ridhy+#ky^Rf@asU1&!?Im^i=>l%s#7kuB5j7N=1p0L-m+P&arMug zq0+Tfj4$3WK5}~`6e9GJyX4=yXxc$8c~f?nv#fR5;-M^a_a;Q9QNj?Uu_b#AG=kr8 z(iwFb984XQnoTRV4<@~YKV4~QWkUgb!3ICbI>|LT8TTPjb$-H_RRMp3+ZSXe{IE># zlulI=RQYm5mE?C#Iq-F*^Zw7Q=Gst=RD?P>g^UZ)ah4`_Gbc$J68J5ozl zRsL58Qx@IZ)Xez(2;cg8tZb7E(DAIy#<5iCa~z3)SMxqGICu^Rwn`kn_DUL_A6}?tHM2eJ9RXx!pxm0gGH9Mcm{jsr(xGuZ$jj7iT+z` zxNq&4Nl$c}omcpUl^t#ts_KN>;ZdnLu+XN%xH}kxCbxuPlpEYLU+QjH`c9j>GLM`B z(PJ;*u8lgHXtIZ(*N6BRnSw%e*XgekPlZQJ{XKyd@y)(Xpqo)qgG!&WQylR4J(JM& zGZGW{FO&%NXxNJnS8J{>68LfvZ_QrZV!j>-k%C-5BG^Z9y2ac|#w6f*W5gTyp@cmH zs`}Zl?XzIPS5l+BQ0wA8z1Tpc>+!!j2zCZJ7VAxWnK~jWFKNoQ!(ybhcJ+i>h#eZ) zqanK~T~uV3f0!9PdHF64;kyat4frcQ4%6m~%2Av$T#9&bUM%jd(z#oPb?{SWFy_S8> zSqE3gD!M#9Ae$~0wLwU{i1A(wo}!+p6q3};jYrzLJux#Z>ycGACfB;gIPjhmQc|?V z5`F^uR2)%uzP7eeyIi3E(%`XS{XOU5KxpM2Dx;KNSRc*!bDc|aY%2~d^iS-l&@S#I zI|DZGct35^ebQze=O&k|N>3=AIKc&T_qhiZTcErKNM0db2%XjGj+*R?+a;}>e_4ko zSyeF(41k5gbuWt=0rl6caS2jQK3_F^;xH8&5O#pwd3Rv;T0~s*XG?UIe3lf>+U4e4 zN9r%!xnmF9=DVL~S?cO{wvLLR5CKueTZEp#1@L5zX@^8JyKU(x)OXW`@!J%pg7QOs z#aH4~uxW-XsSEdS$Hu#fC#iHg$I@PT$=1jby~R-->LnvH zRKV*OmP0)EjPhm}+D0P;>Ot$=%+FzAXb*D8Pr04P{%nX!d?EC|h8Q7}(f!%6P)mg= zHcygi6dxy(f?zUcvkZmE!Z%=({h&C2{}L$?0xMWYe0UpCKdnFG2Rg!A7gKE5F%?G} z87tKY%mR>bN&LYrAL${xyGlI)1^AsH=Jb3FR=asw$PasE1Ah1L^$g>i!huWQ)a54; zlD!b(uAPOS#C>gptc|-i(38OOuw0UK<*V)B~dAggW$zRtG%Z^UsGCd$yZWB+U{(NS3Wt_5sUZBA_%G9~9P zNLGAy1%l`da4WR@VqJjJW!6y10UQy#HqPN=m)wJ<}S1ZKRo?-?n9@CNFOzqLI73&unJe7YP|o@2-kZZHr!Rcu!<3aG>P z;w2`mrtBk|R&cXoZ&gKC7%R;DkyHb6G~OLsxScuJ000mgL7vKFltf%B{{R48CJEG& zI3+~H#W_Y~ZwdCoLPuu~T>t??aJuP4^@R&D$V0!l00>n!d#=XGbpw7e8~%GgelLfB z)fqUC&A^lFSzqdIPNrm=gul%nSn!nEX9$9FfLX`@2&RpMh4^rQiJ1NspLkyJ-7!jKk&_rgIN z#YA*Yd|(74uDb&7-C{SLTrb_GPYo7sSMp67S9>c#dJeK|oN3G^*vUP-8N`yMvs7F! zL1zHsn7GHlJ)9LCZ}!l9KKgD%9!oT6PyRM29)pi7iO_lh=e&fNVjCl@>ta|we+HCc zSne!J?!C~4uRbl)(>@~p0R@IX`I(48!C^1({pX;>T;7dI{Zf@uOA`j*r2OyB94i#{ z(Y`%~94_Qro=UCrFcGmE((J)poS>znHM^@{!j3ElwXuZ7jvDn$-Ec}FeMNp^V$FYH z`3KJY<&csV_-R0mY;KnG!eFsdxaHQ2BQCgWC!&2>6M7(KaU+N(FnUP~Zp83+!VtJH z5t9nUy^yNClV|w$3&HQDdZIA+Pv4;#&^od;qpc>fYg#?vVB#sZ;<5pm`gJ+4+l*#I zGy1_mRIXk%Nl%+cZ^^FO0b^H7MO^ylI}tMdYb`SJqxrm}+Q%{=Be~l<``^sk@G2|# z7B7H0MfGRfu+HkdblL(R$RhWZ$3r_X3ZRM6yk7V%Fv{ZWMZgB670V(4&-qd1p0iVM zF9zr)<_DMtr1HRgZ;hVI;J-_vo-jZPKEe}ouiT_16-iS+^=gNn43Ho+8LFTFU#?YD z22(`#pnc^lpyzb3(L8W7ay|S%_d~2Dz~79V% zr>;MEGFj4>O{F4fbEXq<3NL1|9AB!5;SU_s^Wsk+(7G^J)13zlEl}5NlPZ@K&_Eqp z^?r7pG>YI^hz&lW?_N#vzh#VY@#b59(!0w`7n%2A^8nBGI*@Mtb5(~0lNz=MaI<|r z1&6xtjZcpuE!nQg1Y%cSW#X6ZH|0k>d!i2p^ozkQf71iW7uZhmyiK&JHo&Kr6FNth zl2~j9%u}Liq$^fwD`rj6Ga#-}q_(*mLhQ?+rY=wbd9;KdafhFRQVxB)4@QRl`MD4^ zV9$7psK~k8V7?Lf!K|gj7MX7j6Dw~FKTyc7$P3I>oi<744bxSqTuoswUv-raCWp;I z?>1`s#fbeXgZx%Q<0J^)9v{FKA1X5nspVcealz~11T09RGa^6~p{)T}&W|ZB`HE_^ z5T>9m{w@{iygFmuz|k{Z@|uVtZx*b^qZrSoR+x=U$a{Lr7N0GX-9FpPAfE0h%m- zU{D*DpvD|NgA|yb`BzJWOq3i|wdkQAv>45;4gXSrm3v*h!`ja!+VMB9*nbPXB1Z9o);=o=+ac4&wzX9gs=`EBXil zqLk0-8C0uT!K?OJbN%Wz)&WX}zhRo7bv_eD)P*Asb-Z5XP#ROA!T#UiF8!(=Hc}Sj zA`Xa)-B?PT-E3=KH zouYi-v$nQ~pmH#`BJ|!$D`qy;8}u6Q9W#xYt=fM>6Q?{>Q8eCurKC&l;7&P{7n z?ieXg|7>U8nwydd{=cch4E&>X*41{7lOup!{nLf<8}sX3JiPLOB~6;e(sk4^Lw4x$ z8i*SftUzsT0HKe+yJO5S(G4E2Hcn@^qYOHdE)36jCtx+cwg(S+(f`oN>*AkKm)kP0g9AWd7Z&_03GFCgf+=>IeP zU=Uc3wv2UO|Ks{Dg^-_#j$Fw%An3)B_WNFtO*Dkb-wlojm44s3UufDoI_8Vu$QrBZ zOY<`x!>YY!g2S_cJ@|Wx&F(R!!5d}}4dWPBhBh4)JwnHd5Pul)kWC-gNNlIe313L% zIT@+yu6{2ZIgi~i@`OwC1V%5~9&+jxK=A(2gQ2&^Eg znB(woN+WQut9pDChi|yUq%8IR1E;p7HdG12580YerHJGwG*ID#sxHJ#h8VL#pWi69`wSGdO1*=0{@N z|7U8oSF5s9y~`hZlt#i=m7+k95jkum;N6iDJG6W?+%>p9Q)8sLFSl6+Xa9mnb z7r=WV4LsBf`5U~thrF#sz>Jj4?8G~mp!j;rOdin5>uPCb4BxXZLD;5^BAWeD=y2(@ zL5FRy5uM2J5(SuKW0>1SKKUg?yHLUfn+QZHNeTcWcu@%-dLkS8{hvLtqcv-t3IHrU?8+h_ zQ(t2T-l+Yl!ibPg2O3=Q|D(`d5F-kh0r+KP^C#BZ0Rw%&$#EIZj*0h6RkBo~D z{y?rn-0KR+`L}U0Ml9)I@fBQOsZdR=i14uwRTlH2$$Pz{Jn|;6#b9HUlLHc5-e}owkysASf$iRos7QrWzh||8~|I zQoas@E%PLNfzH{=bJlg9;reim)?N$k7C6;K7azeD0^NImV%>c2;4za)f6{!^UiC+f z_*iTqpZjn`6yY4yQGy*kV&zTd9no5Zcjn9 zrWzAcE!8N#p)*y2P2>@6KfY1wESl+QWLd{&YG+q?q}gPy2AYcz`hr$UAPS)Dt8>Sr zeN{`x0tsY&Ag<0jpP=@@K}jx)ulxPS>rnV6#_B7{+9ZN7$ZyZXrp<@)p6`-aGtqYHiMBB(zq~i8hYy^VQas&;`q*PA1pH=R&eJ9**px}Y1NZw@ zj7)&RiUC$b?Vrd63XXSoF+CvaQ1sy!r~lUN5{(tZyg1mYlslhL4iyk7kBmRyG)aNniRDx@n!zN*dXf@Wy7SX5L-JnSDK$wrt7@ZtJD* z(N;cTu07aC8LI!m%0CFD00LO;g~PWVh8;Wvzp$RL{|HcgvF-7huekZFy4vNfl&hW| z?It<{QYh>zA&)4ECz8Qy8oG!|TdY3;_{-9FV7ATyaqkgQbkBa3%(8cimL+o@@uO7A z?jfc$GOC>XE7bl>$1jeiVzb$J$CCf1$%J35&e;mzTGHyx3&ikL!tougsCT5x5{lJA z3=&K%fTPX$U*d(n*zHdUGCFa;PI|M1djVKX`_YpA?as!%dC?jn1nvZ~OIzMDcZeS< zO$OZ2$}`KcnNk3}J^FC;$gWe<67mW-11&wX9!P=7iuB#xJ;wbm{wLn|#QvDf?qsnY zfLIN`t{~s*HmAMtYsJ7q>6a**k6^`V1LTNZ-OEnmcJ6)mO9&UpA6rO@978Rv1q$0A zWUBvTxxbT55XqS5*9=_Uz%wr|9^nliDxpDl#e*xF;V}n-;JHdbA>t-`}h(4~QJOa(OEd)gLz592WYo>WM2aizXF&;F)5yXYIpt z+0RelERxu4@ki^b;Fy3x09@Lf$r>6BB-r^T_EB2lWFb@DxJ3&>r>XGGCo~*WGnxj7 z#mlV$joY4dD)jhSWu&Xt^1ew<6iQNyzugz-lyJBiZ|tlci5d%XJjwHcBCM~!;CWhF z+Qywfbv8SzK{>8JoXaEgmwe|}3!3U0G;;r@OWyDOT5B{J40H%-arOW{u<>9jsv+}*~mV2MSNONLG z(er5SYEoBgO}%FOfs~)rGdWC2bUY4{BY>ZqLmv+f@&R~cb^?z$iDbY7uFhxxg@FJ7 z4~qew>1hz3002*q9I<|~)0r|FF`@e8P>;4$4w6-!=71b0q*I(XaU>)d;sA@_j8}B< z0mkJC1#dj(lIuOZw>4M_>cc|{Eb*bR;a=czcMlqpU*!heiCG2lR+Y3U9W=DHoP|%AxFI|60ZYnDu$84!vc65t3I*e zjmO1ibaAnf$k}0@>1kx`f~1ah@$TTZF@5ypVfPSy7300}!111|i z@XN&;P9%lbuRRS4ZsT=g@bzH2-lvusJ+T_Hldj;0Qy~U3jn)dcog=MEDvY&QrZ#8} z+U!>sUTo^>F0~+=uez$~WK(}X_@4ZGG(ctxi1-xUHppM`+Q*9~k(ML!sy7Sbn=s_E zO#PWm+Bo;Vs!0eQDa^bcz_kgJ;Ri4%%pRDbP36m8h{xqhwVEGpH~=B4n%^t^zOJ6U zg~4N-o#|Z+b4roM<7~2Mi*z0RF+1u?>3x3kJX{gwdM)|-kA$&1yp&LDd)^ei6GA+r zaQ3Q56p~%4;P}I!gB6!6yL)$eJv(&hu?UNQ?P@1Xv+M4?s$l-+&yi(78FZ1-9*gLi zJ&Mw1s(iRZlkJyeCm%+^T-A`YyI^Lfyt;M|6KC##o=7bJjxmdBxbPNrq3OSqj<0x7 zZW?4wv&a68(qFMJXL#|`Io)=_S4ysS*k_OCpyKxW5};6 zCW%>G?<7rw)=2z02cNn9?xIE*ar=|T2sQ%K4}eYS0(NIcbRf8CbeXXdaB3nDwsmKksG^?+kF|-~V7aoKo zM3k{3{zV8T(cr0U6drrUYe0u0j8c4<-mqEY%wiE z28HG=GN9kIK_S|GevY6wB13G&Wp zBq14!itY@IlPaUl@D!jX;qa7*E3fW^Em4FYdhi2l&y*^ZAn{_ExOU)Z(nzbcO`OC^ znnZ^?O?aFKn$rrB%Q$CFZV;?%Dpi1^rf25dU$;7yM28@IekfcVJ5P67z<#Sr*GU0E z<0k#fwW`SRv|rdv2aKdQ^Uj|a>Ro&H8;OAyj_$eNsVbs{B_joCQHw<)9it)fV_1e| z!D7?{xn&&Ev75gu0Eg*fDubD^TKpgW;N*xd?_U3>*xC;kEx9TTIuIEK+$Gr88H&|40q1Pe?FUM=#6%WtC% zJhUYRakY=v85_u&h8BRT$A|vlxkCM-3RNQ2uLr|Q@z=Lt3RR->8pPhD(|KIh^!0q< zZ9kcT{BS4r4j6scK0GE)T59y>4G7bCiKj&x1<3AB|F`zyu=t9Dyq%8{mFgirJZX0P znk<#VYUU6yOqTu!{JL+Je8jQkej$@H)cRktfCxqRud&?pnxCj@;0r*s-rTITw{27% zMxzC0A^E#evX(`a7d_OeYn^?zd?{0Z0~-ajBr!wiqlEa%6ax211Ne`WQRmKoYv8VA z#AYeMvb0Ex5ZzaXLs(JSD2|xtn|3SCsnY;|99E8aJZ71B7$yM@xaIESDrR)DxU6HQTtXVMEB1u>PtXd*_39FJ3Fp92U zFJ%je;x?HpPTT){R9*szV2^O@LvjeJ~xlBB6X_&8_pi^b%ET`yS;J9le4R8>D5W z!mdr#v^!x)z;G0fmsxt=#UXgt&_n&&taBYaAiBl}-b8q;hCuO}095eO-G#ld5cj?d z^u`+6Wg#;rA&S7la~}h8JEozvu%5Qkr{!})@%5vH=v%LYFcYsCb}Ca45P7}DkpCE~ zX(W1p3r^fM!6p>M(?VoO7h7UwW=7vzsh0DpH^;!((deFZ`86u4}{yhmizvc&%ZPH-g z^9*RgfdyzQG*&kBW#e7WIGhIF?8d@trT%tR-;446X5#6*?xD^#_h5apd6?aG*b6*| zsvbZUf9C2rgZR1#oq6q90;W<+{QbAhfww+8)$+=L5M|Jg2dRp}yzKg02p$Ucmypz9 ziYN+EgzF2+tJ%^jv*wmk9{zya>+9mNx>jKg8e1DkG>;BY~ zg>onzGCzE*yugH@p(*?FyiGPpbacIMUpP3Yvi3SoC=+YbHF+`|%~1CJk$gZFHH%hZ zU6S-tDsC%?3!Lkkq?JP$vUOK8DN?Poik>a3v#-S$@9tJOFWXh-;56ls_Z9UeVQ)Iy z*YJWh^YrD@5a0FM_f>t98~-*DFjFo#PFuL7N9{W(ACqSA#aeYY+=nk>Xa?p-qX&o# zmFTvf#SJo;xn$RDJDP%66s~vIl&ygZ3duoTZ*&*cMf7TZE@t9ABe*l7!ImXvqa!~= zY23dfFu`4f7)#coH5hCgii=`a!4dQ%;;j`eAEzvNuv4CCK89AHJ|Rb-__fa^-j+_}((o3f5>`;CP|LUE%6*Uy8xf6Gx1=3p!WoesNROp^0Z1)gI`g8{^?qojN3l zm+x0>L4*WTUblftyc{@*yy?Wd%3IWsLulAJvO^U5hRPDu=3f1&EF72vTMEED16 zbx@`>np)U)EvkaCiok=pZ*LUpTaSG@Mx`(Lw`q+}%Cax7@mrxtFKnwTHCtom3?}hp z6U>q)Ug(gdpv+D)?Ma=z_m%jrHN>Vs*4ql?44!EX9R{(1K7E@zd>O8zNB56@HONI1 z>p0F`#Du8507&Uf@H{YO`0`zE(1oY4F!Wjsl5}1l_0Uvy>atW?Uhf6mQi% z^fnJe!#*kCPCTX*>89R7Z8}H<`x5YVL;}|5a=%&I;v6*wAyLq1xSUKv`0se%k z#o<{~b!#Tgwkpl%S*%MUR^9`B+87yS&Q*H>^ZKd|q?P)A0PDQ0f;!l5G!mP0gmq(%Q7uE-m_$k`X_wY@yf z4Ejhi9NWieE42b_%7L#3f+eH$7bG}aZlK{OFKmkSL0+1XgX3V3%YzU87wu>qI{n%+wrEaHsHb+XQT=D9J2 zn9zE~s$eRG9Z{f@9-F_+wyt(4jGxKG6^D_8myjUE<-+QnuEhwlM;DZt_L#e8eHulAdW&m9UE7^~zr6-Oh=QGS3EaG&Q zP6XsNz;otU#FeIgOim$GSN~$d60?8-6~^f2UY_+TQ3*)-qusl-a&~2Au6Vpr^1g9~ zo%Q{)gzlr5OCKT0yu3L-h06rtT3=Cu6aX|8!E>Sf;#=nL&|;v#lndr z+-P<)jQ>j5QL0M+jdcK4j#B=@QCCiMzfB1?)m@Dv&ohp@o}`h=|B#AVOQ}l>&9Wmc zN{haHThIgv5YLy0mnSZo`N|+OOv_(Im_0HTNL_ySw|-GnUZ+!XObBJ&zFWbmZ@c6F z{!etV@z`gL(>_lI_7OP`uvL$HVh9M;u4Qn_7+;6TO`6z_ZTl-bLd^f-{#XDN@YVjb z#{w0A<-ze`XqZ8O01eAXw#uF|@h5;p(Ppkbe~r{icyw$)QZCUYB6*&SLQF7K(P()t zRr3Y9TkON4)+VlkChmFQi;hc=<4r71(c;ixGhjvaF?avoib-oMICu4!&7fnhSMemk}`Z%NH-`*eC)t! zRt-b0qS=EbBhEMlU)Sbp8h`@v1boI7kTnFnbuL9skbq^9smiDHUk8%x9#q2l-{LTR z??7dCS~3RbZS)-GH->)V+S1=J2Mg#z2c<&ka+=4l(|a~yRu9-%_9z7 zK;lU(GQSoBhEKJIq*zltG~HE5aa^$fHY~-)$%SzpOH@}$U-xiq{KrswB(p9yNFj6P zn)=Z8kjWS+6g@0lFqN+Z!^r}hd+|wQU^1(3{KXQWx<5-FZ3U1DpC3rf>?o8MLkFIPZ@3p(L*v!82+(i=2<=u)sFQ-dBAhwpR_Z&i0=)z~FUn zupj3+V5&MmZblKvzWq5$fYDYa_56UVchPgTg{1n}qPlYYk!a6$cgW5xkbxDZ%q zNF{wHMQi&;f1-%T0Jrnnul4j!fdZR&#olS^>Hi9>b)_CJYY6b@m;D&bw8RL7Xj%si zc1Ro&%R`71mCq>qsnvzg-uYI~3>e{gi4xF9Qb%*qXK6+od^9r_7_mASUNv&0`qgy# zCYLGD`qT|w{x>=PAq&y=hJ8|QCdH6ej+E~7=dO9Xn;kK9Lo=qz1e3e7i+wnlUJwy`m zsotQxXHCY{#;b z@w&+cTimGYF$pM~Iq7lQkHLtMN#oR*f1Tgg^}L{%JHb$b!02s#f+Gj8t6%U>XT@jr z$n)8FgKww_`<=s^tbwznH%)Yp0MlL>78@KD^!_yfNh4iUNp?fRoqTC3+OHZgy60VQ zAwMK>mtQFcE%tRdp&!&E>?*Ja@pkf0$IL5K;5f!Rb^$^k^o~ym4-_jAlfP}~|Dpjy zUd}(KiXgT6cz6^2rQjU2-yc+@7p$4}%X~!Q8fyXi(ZH+L(Ds_r{EA~>6leX2>Yd*T z%c+u#-$ByDZYNfDdHGNy+O|6Ae;3;s1Qpd`8787ZG@@tnRsvMrrtm|8QHNm|*I&^^CU=)Dx(%QA**rasdlI?I5nrI z`aut_W=isM_D0w1uZ(atEO;Q1`U^e0KO)24WAz1J`JEv4m2da! zru?58omf%Nt25egSJ0b`q}eEpXfZ*20&c9WUK^5`Ujq)0`RDHirG%0Qgk=(uf4VnT zEY#|P_?lte$=Q%5@`=0MdtiFobX->YY?YX2fe$VMrO|fW#^-l27u)phb;Te<1BcW9 zy|wad86*U5j2Lj{$58fjsI001LsL7MP22ra2Hm;^Wf{;E{~01i8wD&hV(dHw*cTLPGeNsJ;T zHU|ATgkJQ<8VpP;4wjc4*dxkGrZV^IQB|?qocSoAcYAO%05{g!jOQ851`>$1g1Hbd zY4NjI+i_u;Pb73E9ZEe=&&s|wk-2|0>J7&34gXWGh~$zcx>6cb6+jD%PY*M zHO-u*q1#(6BW7pAw3{Qwd@5cJ=zM6=ue>7Sv4j4Sv%_feXO7H=?WdF-gVXjLeNIF^ zPG&>j><<6qAYXVjAeSV|0fPpPieRXLpDlL{pJkscc98y4@?^PLcvWwlFxk|rauWzw zR51Pp_%^z(pT3jBVA|ka{Kn)hK;%;6^{Hq=^nlqEQ z{WKyKUx!@$g0P!p1#?4doeZMN`Emh|&5t3xeqQ@5o zdrc3)*}g577CT-NDQAtM1UQKc41v zU|B%T2t0TWIn|y7Q@ub!(7*uC=o6Fol`at%zFYNPCbQ{Usgtwjvq>Dy=?0{1d(?kq zUU@lm1~?Cv@g|IzQVJ&s>GF32Q|f7hv(9*8gb2hvtKAvGWEiuJ}0(LHbe!?`O9 zmFB}zT7UYIuhSkkm3MoWf?7qCix;#Z{dPnmweSiQK>KvTg zeI-=ljXpgb+SCQXnxxm3MXUl`H%GA3OGWKh)K|&=z;nkJl8kF+Vq+0|aBCG;DCM{U z>kT}n4WD1-t&5x}gcg&|jzAPpa*PBkRWTb}QX}55LZGn^L&ESR3$nrrJiOSRz3ILk z%7WLslSX(E6*jmsfLe)kQeKJ(7>M>F?j%FrX3i4;4hQ(o?mOE6f&wDYYH)R%( zeI}RS>{uzCN?95{g@T6tg>sX0tr{Ia2t`+tTX|ag{#@RCate`QT~)ylmoUeRdcpcIlpJ70>!pxm>vZip0n!KTKTH<{BNYs$KICrXVm+Ras+u z(4a<=z-O&830-Pzd73qHCYu)Lvm-0(R!dmOSSe71JB#68``PZr>3zAKWQFKp8wl?c zI@;RO`5=maDLkk&236qNJmRvRkXvmRboKc$z7o632zr6ILyR}i_NYo1**wRl?`U+A4+VI=F2>yWFl zwmp+M)0r_E3Ms=%E~6qScXLIq$;$Kpk~q)o?TVXG!#T!aqHMIA&tTkKOOLo?5uAM9 zKvE*W%HC{Be8%FRTXqh7ANeJ|O8Xlx?Vs%CIL~;p{FiGuPOdj?ajDw}8w&k{ed*|W z0Qvoqyoj*(cwmQpFxjj~v%NikIbpN7YB z`vPhMN#;hdCv?=x9xx>2q)a6xbti*yB;Y#dG%MT#BUAyWrPCu$E8gX(cX4d@#!iSs(a2_T#K)J2Js5Z@A&p|zEte{8$L9ff5KpWzZ0*6LVTx|H-1Qf$Dt!JsX4hdVv5d6a7pY_t`XD#i zMpo4}GUyxVI*m$dwvX&R-@NJ9nw>WJ3s}iHZzk@yYT%fr^gL>7i(<`F6!og>R5|Dt zo02fVr*F>Xfi2&B2YvB_uZd1R`m`i{3w*ADy_l3-2jJPf6xq7D3g>O;)tuW*ZGpr| zuzz!NF6>5&%O!JiTBbE_feVu}Qze%EtXbxqT!~}!fBZ@QfPd7SlLi{r@?{U!hnv)f z^n<09G{v|MJL_&E5E_BA$EYR$z*m{2=n_ioB?$|MbL<0JscCn86p|#TI|)!CIrip> z_C47KL(OY;^gr{O=vc&1>yYGMrZT;#1Ay>s1xX`ZenVdkc~WFadO!Lbu_K8GqwN43 zUA0t~9)o+B4F+wMUO(^*;AV;RQ(`so&Hhdp(ic zf{GBve|w`tKXgLg+?=8WI%dUtN(T_J!1QRfW}?~fZ?v%BRHZ4E7EOjt6UerEG5saJ zTRr<{XQe8^jMqlYiWDe)RyZLlX^u-TuHPev3s&3KI{PQNcdIGYgm#MOs>2<|wc&0BMTnb}mbjr#UwJ`G4 zJkm%g#M+NTW0Sy=4A_9#)94Q~&V2i<796b6kJaCP4)ukiL)5Vmk}Yl#Fr{2o?c&VJ z0`b35lS!+oYdvVrFi8@#^<&34pO-yX4q?QuwHp)um4mqkjvMmXl~i;E_HqVaP13>> zZYOf24}*h4S76SPOe`cv?AV2r`$0wESOw_DX0X-Q+({@&FLLF*39(&Q9Ss%RE5*9y zR$b#i6Q_%72-E1_AkJQ-=`xm$S4}h9ZVV54C^L@rAv4x4Wvu-&sHMp5UU(eHZjDuZ zB-}-mn|p(hn0L(QxzcA-UcH9|{uM9n=pNak1)IGQ0DAdUFyjDBxxS)A4)2 zveF)b7sgm>`{v&`LXyoV0df4!Ub0Rr(KBel>_6a2D{eYu<3zi30?fFY|9i*iP#8KKDZQW1azqk}=>@__|O zd38RRC98Ce)zy}!fC!+ORDc4ra%)83S?T)eK3F0K1_w#)uv=O^ph-m9&V(iA6wL#3 z%KgX(Wh`XwcSGvnK=7V3X^=hcm_+%e_K;qTtyX(50h3L6B6RMJcwE`6HOv;DXR+f> zw)L-O4sjd^g?>b}HKW`f=YG>i6Bbyv+xB*DiizytkqA8YkeeuKd0YK@Lek0 zJ)(7qx^SmfAhMnOSyhn+z?Yz8`^`4A7NfW*)77xbKUu@()Nq_-1mIr#W;5YZGF5lG z!ennaUS|o<*ChM7hvhXLb6d6Oid1?)^f<8_##ufB8TziF-L1taJvX4Z;WiiiFnD`q z!--%G=9wqBfBIg3n>3o{wlxjXYP%iK5Q}J}D3~Z^Z%;t(eG+=joqiLbh0)!w;j}hY zh<7$Pw=+M`$TCKYq9!4D!g+g;^#$-bDR}Jd6}i*ccYpf-u?qhxZKQ@w+OI)?VOTgQ zfOVXrD!t9qCE6!PV(fTmYOIq3Rv;f2z(m3gjf3q(#{xJ+qG|i75U1nz%N2IrY{utP zRbekiED6<7mZDW|+~z|N+O^K{gcV**>QCBK=tYryBH2h;s^v5Cu3NNxIyEYbh7Ju` z#BirajM4GADrX>v=4>@VBd5T&DN!6&=0$B04WAw$fo+P>rey=n8!GZcu-(x*EhT zDpJ3@dtdr8e0-ISkKl4wF5q;$7{^J=K{|}1*zz0OJbkhY;miR-5m5WZgVrx~v^;r9 zR&DNF^YxX$Av&uA+lVHZW8K$x{B$JBvXmE4yiHbQ>qL-Ay zZBE+v7Hw+F^fcby&}G$yNIk8!p-@(;3r)RWX%ZiJsBjMdtO`i5P-{&uRhD zh>G;}RF8kKmaMdb^bb7Q51Ll@dbTL$1(--Vv9KkdO9Ga-A>Y;nc0ZN0Xp>$+Nj9}* zGwrW_SK=R?bz!^56+U2{i%$VTW80~GCWlGq>l56xhPGeg2D0tuxr6np4bsut~eBE`X7;7i($aGCPna95o{O`PSQ#o_DunN zox$-pe^?5(SWcPouc!3@%30E>&a_iPaK#NbQEt(29b#Llacu~)4a75`? zSZ*LZ0+Uw7S8M49fT~Q;DtF3NtriS=aOxZskML(QfI_~;2+8H{NxOhD8k72j#_pc@ z>s)vGGM_ALcmz#ap!i@|BA6}&Q&=o|KAFI5Xqw&BffzCUHMEt;tdE_gpI%Mwq-h7> z;}3dQ0myzDK7fp0*q7D6^D(Y0%Q%BvN1QbX_7m6JGe3;(`F}rV*T$rIcYVd$Kp#kK zX?F>HXuzj4QN5K$ZObLkJ~^QD`~QqfMG5HgYP8vZ2RC6k#1#$vfcS&I{;yZa`_@#D zHk9Fes(ARNF59*en$Tz8K4M zPQJ(7(qgBa6TQzVpj$EZg7g44ZaOu#P8b{C^E8?LYpnJndS{yHR4TxBX2+I8{*4-I zX4jICw0`R(_@lUam`7LiVyn8bWh_@&bc_V$*3g*k!>c-#{x#s%F(?Y}6rfVyE= zlfaPJ?v?UMiJX61SqpH=8LbKsg_Xp19F>qbW0obD5_dfo-0C^l3hKd_9MEb?7dTVG zyr>K0+E>80KK@$20tuP{j3We63g3o7qC}rzH%feIhQ#7KeoXD9|3$7NHAf&q<$d^3 z>0l8;G(s_bz2kFT=E^wFC9*WY7~b^W`V5Uj2J_~IJd(ci!d|BoesGErSQ+Nr(A;8g z#=a}GL*Qm=qAFIaeP@OG)MLeww*8UjPGLHZLtDZ0SiUp+MesXT0S+a$wkZX)K<7Jw zuC>^WgEEFT&C|5%*d$)N6Sv+fzH-8K>;J}A)QwB&8L5DZnCz%^xW=f#5)S&ft_U(P zYf2eXlT>N|g^F~l^~Pi&lwj*{d?pz%AXjqszb0x0HE6x%ZiIA6hW|9$t+$h)tlK)n zwftr9d;y+hMhQB|C-QA-zh`PatJ+7OX-zJs?&8*gzoDgnAPvD;+fh$Zdu8ac_Gb*2Z&+36*SozD z5n$^w)&a5z^4F z4;|U0=U4v5#ZGZU>(pGja~?fud+x+wsvKN9nia9$`yZM^kt4vjLp?YB^;;2>FKht6-pHZ-Me5HPedpG;T98OF1w#@;D zd+XHscBPR<(OMkMeCh|SECW~jUUHBXZWInC=?Ks3;^Nnp@OkSXj1G@25kG~6vQ)!| z)pnxwZNF=rOYX8i{9vC};7fENy+QPQKdES_jtr}7Aj6_vQ0q+!s`|@!qQPhYh#Q>9 zT$?nMQ*M{7u&KyS1 z@10xDhZcCBva)hj_RO3UfXccs)M2LX>FUoNYIUV&QFjHSo(aMBDEDEh5Ufp!fb3qi z|HEm&z@zSx9QYh_+cLyR(v!o?oD;DpZy$B|7tsP~)^VA}r8Y4SVIT@0Y@W(6j>9|Z zdw;_L(}tl2uKo5A4h>=MVydmOG;Xofx=Yt1iC>o9y>sM7nYyr zKxh)dqk`FMfG^9oivs+YW#p$`VBtG}&}@<-9$nqjj3@u0lPy)wycf@D!8&F(;B&No zu7RdO(}R+?0tZ+fA}T3F=M#g}6#AM-AhHtE$>mSpNNfn7=b`4r@{NKgA|XtZhZ3D< z;0u5KXZW`=iEUH$YFf>zdur&qo_;69L5HtiG_%@#ux{QrdCIxHJC39v@u(5uey+!~ z4vkaJg9;HiqhOU(FbW*|-zj`|0_dw-tpjH*PHseCjx35*-?YD|^S}+25oJTy@xYa2 zywpV}?W;toEsbSqP%4Hb&&|&wn>>!JD41~9BdT{!mKAGymLxV=DTVo<#1it5fSM3^yU>*7#__d1qg|S8}On+ZcnYJ* zUT-Mz0V}V)njaLH3g;$3q|j+~T&!JDBMc_B*z?&6HbRUH4nE-O(D_bZ?kWBofte5+ zpRC)9;|S|dpyXZx@>EinJ8Vz#g!9M*y&aF(17wDO*;IB1tYAp>s1Q`S9-e4~=~-It z!CmI}c#*)6zQe-J1TvsIwk(oy%(Ej5b0(>VFJVK6xD&^s&FcuF__^iGC!MpPYmvsI z{gSDxCm3P8e7zPao;fqKB6qk}S^m2*1pL(VhGJ*L(zyGFgAEw51QTaeN&3RMcHRCH z#(FS9%TBi|b$8sLLSiGiA^ABI&^h`H!5nKC3a!|O-L!ukx8e?uMBbgj>vT0YQJ3fQ zp+Ah?qZ4P*(qHhR@~EO+%wnaEDGF{T*a`4)OdMfj9vr|cMl?lMd{k`j^3Dd+_A?Q% zLx+ZuDVAX>uYib;w2We`!|V_CH&F|pJjhxeu zzV9W9VQ0&pyd5at)HPY4A|hOG!A75sh5TGmKA9+M!#_|hqNpJ2)=hAGJzmBPK#;7dLX(Zp37Fi6Q>XKdhUypJRsz$WrHR(#Ta1raNjC1v@mV`U4f8 zwp(c+Kz(7U&;1r?LY*$AeGig+yCw^F9cRoo4F(#%FTe7h)Lbv-izm`^1L7Q-8rMy- zQJw?XICrSa&pEis()^Z#hfL#ZoWno#)NUc`EzUamy*vrUWWDLAj$_sxGtkRpJDk** zqST1Fb;X4v7Tr*Ihq zAO>d0Y-`>vdcY?XiW7^AAUH+aPSNE1pzz!b05-+={bQ9X7LQ!`%~XXVw3<%ns!M+o zmTHU8Dkc>FlL8RBHlb!eTv^=|&`yuB8|V=mjPHfP)wfJu-3k?*sjtsS^Bw}TQ2iuE zrSrMyIj39uek z>$Mdfp&Sw#@(HR|$W2nnR20yDv_Ali$|0CQg)g17UPi1XqGD>SZ&jK;cKvyMUR(Ui z6>IgaBvO^u&JA+k2}&L*)p4HESTPleCF8*PHQxGrp=dKm3avmU(-11ik)Zm%>m`Bk zN{!MSwHg33@7hX5)-y84z!iwRBSk<+Cd(#c`ca>(0vKbJ-_=Jh{q%4cwevbHIOlg) z9>Q^+$4&*-GbgCMR>!~jV(nTLqVUm(T6G-XM|A)T*Wbu2r5|+G8rM$6GHvl8BUbg> z8SA3GN@WSA>gcIvjwU;5R7p8IH{FA?Hq8F=49=#v>}S}`EsZqFXOR>O&ub6jep2!L zi%{y)7PRXR$MHb>k|+XoJ6SU#f?y3j$ynWAKc`fi#}p!;W+%3#{CPkRk3LSj?jJD(WCAzWQ_IK z6IIFz>3R0N>|Xw|;E;d87Qn&?2D%79rM;ae*41d+s2nmxz|Y<$SZkVv0LQ)zPD1*c z_S^qbxz0A;C(Ay{M&7ULmye2cG)}K#^}WnC!)&C-Ov!p8X5Z*GH|iy;rU>;ql}uf= zqj$mW4eaBjiW3sYLLGMtHK2=?23kOQm7Et+(4|GxhsC{ifF4Dc=8k7|0E@PY2jNS zUH#`Aqs@H7mq{<NuyY z0W;eyaHElj#xjle=D6H@O-nbdRe~>!4At)p$3dmkvOg*z3j89d z@OO-&5H=dVz%8}dpdVS4v6a_uc=CN#1ESjxT5)&%jXm!8;OZ;Yvt8GNu+n4a(|TaA zM>ZwFvQ!o(kk-$7I%eQI5Y>^DIzH-=Jt?nsP|{&W!pRIUuR9#nO$rQp-fM{dLUzbm z553C?V;n)VY$3+I2S#X(NtaQqbrr5Jw1~VL(D8Ro&8!lf{xCDEm^FO|tEyx5ausF1O!2Vm>M8yUEJ zBsP*R6^G`@2d(H6a)~v^5^w`3qSVHX8da=>~V=%eF zE*0}H^-Xc~aIH4PP;VWU8)e)8I^+0(g`%t=Eg&BMyJev-zIHO1RJ@iQ^9a~jXVFH) z8`fwh>r;rv-gb!_lg+$GFP16JbB%)8eWIS|4F3(c<#Wxdw9BO@PsqNc{^dPHMKs<( z5bF=0zF2Dcmyu&*4N>l|GiL4U_-A%}*lGutY2Lg}FiA@`J2;3* z&`rTT%6C*vT}i6S9dB`)} zCaSg0Ldv%<#VQuCx&3O8CU4qF$f&=jj3FH}3t`5U(_grWO*3@gWpGU+=14BgX~9-6 z%Y{*`S{6dO>az=*bLnC3v;F5W-oxg$b4rgac78=saClFuKhFMkOGm0J5RXSHZ6;=x zbkDnEACxwtsT-;MQ#Ve2&D~vJ4j(hV;I&Q*QhG;)hfv;!e&lW;I5HbGT@l~sxZb5&4DzNe@%1QUd z#|rw%+Sog++blJ!_Wjs-c#wj%ty=10(H|$O83S%hcsGBDO1&M%4MX7bv?Oi#5=V#+ z!(DOP+@_aT3BXHQz_C6iMSfQ%XRbm(mNyS)sc0^{$W3%iQ%dIdf>H4!C~~svj+NkT zwold(kNT~Vuhbz??(6^pDU9x_AnV&bg6x1@(WE-O2|p1utJgl#d3QPKJjEBnp98#$LP0SN(-_ls!xWqxR` zjg@+cf*vn|B|mO#C}(C->3m}NIucm^ka#M64c_2*%yb9O#1K#A_R?&nY6FZ)RRY_L zgVl8wRcsLog#Q{4^}lSX3}YfWu4x&OC=!k){~ z@Bnm$d@6|K@nS@!_Ri^lbA7yD`+#^6&7`8DHl92E6_r6cBW)ZCY?Jx%GduNP48uD7 zvT$g)?0{p+9PXrKut+olEj2?$Q5$BlVW^ean~33R?f^#mj-4%o$l6jveiH}1sR+Kb zWrj5HKg0|O`2QS455Btf)sNfGI)~x?pORIa*nfa2|E%HE3&5P2kQ1(bF>RpxZMR@i$s7M|1TV81(vajMj2V422siUuAwbo8rD+ zW=<=)^C}q*Rbyg7EPWO!5co|fUHw9Uk|d+rFC@G6*OAiOt_P+i<>B2pEf)oK19p-j zoOrbye8MQui5IDlpbVZ>zo)xwQ#*}3+cR_qrzmE7@Y^<++K=!rEAe6IMdkU`_Q*ik?}YY`gJP4fxKgxk)Jkyo4S(IkB#3>S#~3$FF6=Jo z6<~?vHBCxpVe!l;jFkfka5cAA_eYzL+ZDYl@8A^x-YF#;#EJ@7GQ4Nbu7NLDqx;LEBC4OY3NeLY-R^ISFYxlAI8j#~8PiXec%9ASR&%FG{Wj^JS` z9SKY%&8_ZAGe?s=aPeSQu*{Q|2CAv%lKoWRYx|}kCoifvCKDsdv`auUzfFEalQW3r z(MIVJVa!&z5FN`gcbvng(>q!LDg{o@T$a2rB}>F+tI7iCdlU&3REf&9{GRFB?gS!I zQy{C7u*0mx-D+^Dm4(_9O&M)XFN5qQT7D4QRV$R2Y{Bk*1x9Gjhzs%q7MK)Y){|qY9kZ9m zNQM-gG3(dT9fL+q>p{ZRKPxhowTz7t@FqXOYQ+_LPOjsYd7_00f1;!v8NI6m3alHF zDaAPa{slfUTzGz89ANSf{INibs-{Q(oQNZp4+eWD447YVj^%3i1GSjhCWQrhBjX1( z1FMp@!J#OMxN!8Sz#9AI-K5nD7TQnyb$-PiFF4n9s84ElRffh>186@ZuPM&oMgfx2 zy%&bDX6zCFKBb`#T-w}h$aWC*h(Ll{A1abyDKmA=pT@0T_~ZIeTz&0@(Tst)tGbye z#`(unHB~MCFaCZ`lHUiAEj2`ZcNUi@Qi2^Jl5moDQk{;*_|V=@-kPUFQLy?e5GmHa z^;H%(+c28Shdm`mD2gLlfsRa67xOQpz-OWJs3NESyaXlzmEiT6(h58^|D4>GMG-=y z)q07`tBc}Y*d7iFSL^<{dJGT+>25oJ-`HCDBJ4M7sh2Wu?nE4sd5xT^p2z||W|p^? zgS*=iJ%m$PWYIGqzEi&(`bDjGhdOPN_V(F+TAzp{&Sc0r&XEzYYZt2H6{{J>H>eI% z2R0^dq>%+=vCj7VIq6|+3$glU$QxS658YDC3zmEWeH&IJDP$kkD!Z0N$}fkZ$p0in z-R6dP-2X+4dmC^&v&e(w4NQV!EpzX@)MPMfR|qr#<)3s7vwgK(TM&Z15`48aNowQn-&qmsYtQ227+EbM14_*&hOp& z581*OzB)^TMQw~i1p8Doxdj+C0?WvwK$fH9DT=rH^4KQ?@%j|swyI{PEVWBI#-26WqX!3mr?`S z>x-b)?M?3Z#*YEj{- zaR#)j=e8fZ%fDZ1+dO9P6aYz57#_R35o|~p({d*d$KK3Fl~O1vz{?SD5c=~l#e?Ha z!vS{a6~my~^OOvoKee)c>}(&mRzcho|N6&>>e*g*<+!=xzahF~Vz_1UO&Q(5@n!+T zyH|a8VY!Dyr&5rnC58?PVj|CSI#WzxRs}p$HccjG)(}Ng8#GYmoA)j47^IF+XUe1( zo%YW2FE64VhQ6c|Usia4vM8MTmCOrgk1i*AC+rXlE?TXifl|p{3%B1zIy9D~}Z4FFm-emm=IMmI`4eUnl-( z3lzcK3b@%uAISs|-tId+M<-cW*9wO zgh#*mkOff>wDkKa8T)ES9r+~16-4qw!Krc}te{ahSjHN<=lFPmi0jU%2FJFgQ${ZT zZw{`aC;**PI>rZsf1_LYrqSdD@%O9vK9bgdA!3vPf5oTOfM|K-qa@cfCN=qk^$9g$ zEf}%9#l2X?Ix%-=?$XUv2^Azewle^2n+(tPZ0jkzt#03f?Q>hFiVUFBjHkbJC)ZBD z-e*2Ir$Qp@&@UnCxz|nnvn8eL<=&F9>i^ZVFp!a<-DEj8idTJul77hv6g+B(qhH#z7%sa&v*n3#iG$f4VRu;}il9`0i2cSZ zCGxVs03%tUV*4_NF$GqN?N$5mPEzb+RT;aUSJgzHe1k~zO5=H4>H%>(z5dE@1@P#w zOioc)Z=N@E#n3UHE5VE78T~1vRA-A?N1}qr6tnTLKK5U+Dk|kV<~gW?wv!3|_w-aD zXIn!@9M$<)@|IA5=D}4Y@yQ|^#w#FOF2vu<$V0;kWn&g!NRLx~%&6K<(t3$H@s6PBbhIxctjg^{Iv(O#e5kSF)Y76im;IirH5@NK4QyWLq1(zdzd`cJ5GQ+GKF3a;GbQ zygS3-m%uyB;%#V(O(8bxIUpBwhRMM2fh|3yd3o7&5DD^%OU!tFe!i|>C;llCH!um^ znI0-3dQQWd`xYaN!zzfdyL&_^v^>4IK`5NFfr-1;B#cqSIm?C$UMI^=h$RS5IMe76 zYRQ`o8L=tSu|gt>o^XtP{2+KZF%%@$jLK1MoM3~&e5yS)F{Z+AzF`z0>l*xy8j_Su zro?ucoBL29E(^j14p@S&AJ!*Lo!O76l90vgW!#pnJq!Ki<>Gbu|Jpzw@m(C`vkav3 zFj>_pg@p9ocX1J~J~Dr9kEqC0hu`vEvG4yO4hV6^G3|s$TI*U6{sT5O%oz0pQ+ON(THIocuhTKY zSfc8HdKL&SOJU5P{zMj1#-cITm|nwNv9vzP61TW-~Ticy~JrK3}g!+ zOI8my@(JU&%RqR=@ZMEUr2kXVAKw8~Ds-ur(3Z11OB>iKs!v|vBn@1t?}-Cd=#m)n zimPQLZQ`3``mmAX=Jr%^bVwJCjf9c8S1#-|mnM{rs9ndKyLPCzf76Nr;>^Uz?Fg!< z>P@W4xlxATkfigdwMG`6G9sLm6zjn=y4?NEU@%V5Hmr{u#)C_c!ROLKSnHq>3Qe72 z@!tvs(TpmvK_mvOO)|ecu_G}s{^s@QdF0P^nDpX@Mh@NOT2vW!xZur>CLXzW4G+xb zg{1_DulKtKzqm|os_MjlHkZzXeS`gzGzJjGtnp`=H)t1l%DBY__PEhd3W+L@!f&Tv zc9@U%>rd46;^AMGF%#!UzoU4HK`$E+BT*Y;+jx)))@ zJI}1fqomdX&H_D40xxbn;6gAh>zS+Rh2ArYr#onrWgg5+)!N0;MCh>sWjGF6N0;dN z1xW8qtCjharl|q;)p^>M<%r-Og@vCa@>+@5$)sWnXJ&CDhd{5~akcph6gpM+7_#f z-j+=)Z+M%tji&XSCPQmx?4?p*cEA7vIO;t`!Bxm;!KlrNdN!~qXC~SX%L?P08ft{ zW>Z(|N_#U;0?($) zQ2Jk8FXnw+>OdVif(f+{`1S^{WTuiQ zq+jq#=IwxNPyo4ba=HH!hlNO|z+x>4D6v~Puz?GKB*&~N3$}8h@rKuT-=F0*NYV#s z%LVO)6PxJ`Rm?WWn0pz3OsHkB!X&CXjD7~vucuhzVg`fKaQ!S&;RO$imioQ@q~ozU z%5&qm`9@c{3!iI?!ZGKGBU434^QQD&H%W|(JN)a%8ODjSPPeGa=fg!#lj9h*>*zs! zMOVi>WHGsb_@yi!%U?0)QvBwu{qmxEN0#P)?vvf9 z41;1xtff`HLga1mdO7T9`PTdv@mmgyL#m&E@A6LpZ^^lmqKu(@d(RZ&;&eA+5+JXs z%+Hs!*rwe4%v%AKW`s!WDyx=u>%o3z-Ol@!ONCLaI0PyOo&~rgBA7)=a}R#mZyake z^?xCcd%^lh*|1ufL>mq#S>d-0o}jCB!#I#opCN`46KeOc#!|=?aqG=tyQ-h1+}G7g zK1^pY+R;k z6c~%MIh8lW=taUsJ&n5K&_}h%Pa1Lh#1-;fW>9n(5A#c1Tja{bIoHq5M2$P)DPee$ zX!!eWl>Z$*I3`3{wOtP6)okb~jL zUAmh0at(<*q9DXZbZB&$l{2Ot#7OLE_uR2IB!b49TSPJ+XFBJME+tmyW}i6$SBcf2 zxNdGCG|+=#v1sZB4Op;^>ZCHvAjI_es5QHPvpgCmXR5 zfOzWbd_g=$_WtU)%KK``<x;LGcwGll`LJ6nS zZ^%X@KOX8nfnL_pCC44fX$$T~=MS6;BCNCVA=|YDZjO&^aZWXOMgbLwrpgw&YmU^L z_Y57xZ!EVnVri_?4-EjXRNZY@d2@9j_^Jjf;L0Q`&jnFSfT(DSD!w?Icgbk`jf z{x%e&BMJjB&T_`&;6{(HPeVE-oRsu4*I(rdAPhFD%wXFW5$Y7@&rW}OC+dvChKPG8 z=&4B$v;*)mMZDRq8l66;q9Rpc0f=Qb+y(pr^`Vx!y~d6dBJ4&h-{ka+gk;fW zeg^#skhO2R_9pogo|Nf}UrBaWlT zK+KNt{0r3>tR|pRwfZhgmZnbQPY~$WTAi<(i70xS4#6Ri3FUWS0W5?D4{N?*>>zFB zK*=E>S<^NxjM)k;32R4=u`#St4K;r$={mMVzFV z5F2JnAlAGz(k&I%?k#sHl-gT+^>YuXujDV0KS>RSvjgOz8$k01J0_%wd8Iu((_|7^ zwX8CvNf(5wm5oXIhXTl>l^71N?BL$CYv|eGm8xXW*)4>7t5c)G1HiaDj%OsZV%cx4 z4&md8Xk6O%XW%n~c`oPZ$wnJMDZ7_@F8WJsF2>)T4Vv`p!LXmG}JR%6K<~s zAXvYqjQ9z8hcXMO(<=@Uoh0?ggos>830d<+nSZ$u^m!FR?!Z?Y9QXav&dI|3*{u^x zxBtDjfobjCTU6ebXKA61>_~4Xs8mo3#VD^ zR((xrN;=$j8B+7WVnz70WV{rHZ<#dG)Zm9wee#0OwHzAce@g$jJ9%Wt`Btg+muXeR zp?1ec?sI`7`nXg0f?2Q#+Jhv$8wJ~lA+Dfp!I5^Q=Ax9!w+Rkol24G|E{|^?+?N8r zGFu3#I#EDQghYrWwa_E`#-JP6C4{=EUEvHN6)m=JS|k0YopCpV>CPl=uzlJoxkimR z1~l|G_b^*PhFYyY1&CiZL{YIY5CwGC?GM04;ZLW{nJ z(l13C_F|Z9)npFA+mchEw;?#OS~aj}4hLuGw){$D9v)bqiqg<#GEp9oWe&*Z23L!+ zhiKBJK+ezZF)~f^et+B_kxv}5Wl{*Ru=pMC^{U_)z+eZBz>CaKKfQuNB8Jf^gQpy{ z{#8?>D?_mMLT@`SV5xel4qpS29Iu5JI>Gd}^f@g3hQauDOaefX#GESdUlgUXD`1vC z$v0_kjVuyQx zn_va^pr-kW687Qj1&P=9gQa$s%F0|3ZOu>x4WWwND zNdf_iipsLEsG~+M;hX}6Do0kgYH(%G8Qep1F=%x9SazqIt%6(V_sa^Dk41;-@ZsUz zTQ_5S_b`tvuQ!*!@fp1h+-?88*lQRQF5yCFQ|keQt10`^%+3xf23bEQfdykeK%F$Z zu!xeD8Uinu*DDaABbkZ;)6YPV++fY1v@|={B4j#fe+*4K$@9D_!b?2(@cERI;w5ti zxfsOieDlElK^EbvT?R{Pey>2Q&51pe76rtGk?2Cq_p!nD*gyWHcjIQ+6@#C5H|xJY z9?o1h_iO{5wD6*O5H^!l4n70S>G4-~(kFr~3y=QA+|MofHbKe7qd>*P7CmwF_eZR< zz*17rs|$NXe7*TG2E1!~`$IY$hnNssAOrl%J1L8bWC=LS8kV>@mF7KkQsZxZ4)67C zf4xg{tM#vhHOvPlX}b!OHE<(0~S++nJhop0X$4R8qP6``Kjof4#eQovN(PlRRPF5Dth_U7| z`K1KM_N5vQDDbY6W1WD3Ak+A|dI%~b(GLE800WubZFpjRi`Z_y$@P-3Q3Z%YH!FTZ z6!-%kF>o*3UX4JaStDP)>Skt)f zB>Xx@9TS))Rd30!D$S3EUQMvJqHL{JzuA66I?0lvGHfAq&lywTx=F+Xz27=O_%aGu zJ|E9{@dPQJdK1{3KOvPPn|T6s^4YG$>&qnG`DPO)@*(ZFD?AZ~vh=Y3jq~k`CH!Xf zj63pG;x_cATE=~ujLpidb7o7&C~6;E4hdtlW2U+sP+Xr;u(trptaJsQE3^Dja2r6< zsrL$yx~}sl<)8opc?3ukAm*opTUW!J^W>68`dTo>Q-b?|W2O@nyhAi6W@Gb1`C zvJS5y000cg0iQ2!LVo}NPoOzO5rfU0O$AuCU9Rn;J~GeOd=Ua1!X^tiHhSe3li&lI zDU@?+Za7^4rMW##*8QL zzl)qGc}9W~@vO%*RN1oLYkK#-OH&NqjXr9#Q7Vb5Uq4zG>?YaP)Azjeb7XL26wO78 z*8O48_Pwlb+GVOQE*{!d7fHo(d%igh=B?VAXu#ip{UT%e$4jGk?2*Z^!isr0;K1u4 z@e_P*UU!a4#!j^~9#Ik!x@iVgXbN4KT%@&@3PysV>dftMI}#$g8@oDa_RC*85>~ou z&hR-Q_rbQ!`HK3R+Q!yv=g}AG*+y zlwdIQ5Sb6qXuqhN&96%bw6Pc`g4PoZbwTcBuOG+Q#(%f0$9h(|>xlKhpwPt6XQb2o zQ7l#Q;=AywVKah|%cZ5+`R#)jsYu7dLdTW#$~UYxiwZnN&j-ZIL4*1Qi1WNuMqvIN z{>Nc*V6@bR6NpsNWc?X>RCAtlm>YRYE>knM_LN)rZ5@E=7Ni&U_LqBIumNOm{rKcs zd}(g?bFqH!xJ~+y%JOKdU{6sROI4LA>K7xOVaZ0&tUp!a>qaYQF+U-u6TU9$^Aa}d zD=eaXe5e;PEb+INonH_#47`Fqf7#0XNW7Y|WODS(!~d<6GH}_h({DoJGgTNy zI&qt`7&-_#&T59J^~|6)JAXXE@R_1Wt3@RQ-iUh~qH;)8SqtNN9Z~jSu`!r1;!j_+ z_TSk5+sd&IP|XZM%O|nj!#1;|gx|!O*U{&7ANmCM3&q$h!UlJ=CU_-B&?mFkv!!XT zo$k*3kb`6vVM;VlleJTKhDn6lK&bgr^V_;LTDxM)BZ^?pLyz?C6WK?@k+t=H zf1LRCdd%hi9m0ZIH{~_iDS)4so|_G}ls^Q!j+cc3gXv+o!&k%VF?`g#Bv}PEW&p9o z8@-Rva8rVH8QO7=iGqipcC+T-vD3P#f04j+u6+46aTyVC5`Lw<2AdgGX+PQ!S_Ch4 z%O}jSE5AA^dV{9SU3RH-!t66RLE2d8b+b0`=scfCJX;Huw2;Srkl~;0%#|SP>3bYm zRyg&E78^2lgf$Ue8~2O~FtDUxATz+v3`AJSO_;#Cwwg*HH zB;c$v$c5HqrB!&2o~wb9Sdwbk$O>5PJ~%;?I~Z!HERuZcnBJNuC%^A5w+!rUR6FcZ z*&{p3KEo@WRLHo3s-mphoJ`$@pcPW>Zqm$Auxxfd`FmCxH7q_?woy#+tFjW0qA~>+ zPwSm2xQ1O6ZKJ3;jH)C|_+8LdE)a)J<1`P8n>xBFVioX|TtRJhxK`FVVj1s$IACB)Zfczn?4MR_j*jDfrRVx$+V@D^ z(AXQpZ>c`ox}s#4z%>~F=AcV{H(rOfE-DF z&`DaiOjW=LXBa(ni5#-m>#(!pt$I88{Ad*n82eC$>eZ4K>&)Wz(gqI2%0lEN@_WCh zNCkozfToOK{V*{cv4#IH(S8HAabp>X8juPdE1;B)n8eP*i}TG-+~5v_?sA0e_+5Dg zVa_VFzF&026;2Q6rRm1kYBP&!h^i@Qp6H$H+Pwhugjra$H+o;o23DIw+Uk=C;Lo(4EgEjWQ~C@R zD%{5Gn}RSU_(9S!fp=bG{y7hr>mx<20>iS`?sbs=W}fO5(@{wRr{Ujj3QW66en}%xMN!C(~*b_GH2UeRrZ0uGas7)ikZn(P^YV ztnR6~s=SiVPz42FYp;44F{)vq5=2Bght4WV$!uI%XF0Kg* zrX8b0yca!)oA=sI-$g5agA>a@4JJsC>xaSTi1l$<`(f!T5Ld#pB)d1YTg?AF57$#Nv;f6=0`Y zqaaQCAv(Lar%kJEEk<=PrIiH?pv=X>HzGTB4h2l@vq=>BDwk&L^R&6se;&VM4AzNS zcMdf?Si90Ep$>bi(?61s9imFaVGoPI-g>-$nlW81z#!}x$ zHHmTx3e}G{lkYBaXw>ZqWyw>n*NA3Jc+dWvNE3Ws8Cn$cM6*|2z+ntHhAf|O4lug9 zmwQ=kiqWA`#!R$?85umyV~We4QY_=nlQfc0BBdxuTh3HP!rXxJ_Hvd_NFPx3ZV0~; z5Cqe%<46yT35tN-gik)wfIV8g9VV(_JV&yWq3N4?>K%MlF93o%x#|JA!?Z=pTvCCL z3};Prc4tkIks4jpVp*`j(YxoK7T^LR!Umck`w;Zh-tP6~Nt+7!3aDs59?}I>z#Z%K zHp(Sp|Vm-zk7!SQSfm;s2Yf#?}3*bB^eO;$1B>c&`PwsclsB4?ZT=*{%Y`p zVhvniwT81$a1sMNud%JI*0~p5W#a{d^zHIYK8=>uQ^5hD)k|au6L&E;D>Y!fXKa2> z{E_Ygi;gEuv8VIe zjNZMUFJ~MnW*fJdl>)%8qZ(}2_8YTG$>;L*z9FGDERi~rMd=1;RvXa`c)Qiep}_jm z%`09j;no8WjqKD}0%XJ+zQCa`OtCwjw#MMkfuW!d8bBJ(A6u2+^owbpT0Ap3CPMCh z-?p&YR14M5$#c<>D;%6R@u=gt*DsceVJR$nx| z-&~^%M+sC>ORj1X8LuNWOMKaI=*N-7F__naeb%*0a^p0Q$xe z#(TB>Qi_D-oe6$c*C}<-D~Uv=Cqwl*ps)(v`#`$CSycpDcdyFt2DhkWE_(@cTl8A( zyA_!8p63`EqOE{JUi{^^@&O2()HX>&!)z!ShAwaLQJYMuRNB=5SNJ0_xHX~LW%U_s!9~N6cZ||w8Tr4{v z);L4|^rF%T7%InW&IFHwhqH2&CD^VT{iz+?pdw6ytC0&S&=zAhts@!h%Lz@ii7p)q z%$#iHFe?6#w_|Ns@EO!Z!FG3xYjY~S(Y|Xni?7f1zs6*WDmQpJX6>baFH>q2e_iIx zN-jH%=boaW5qT8o&GpvoN}iTuaHX?E{>o+Yl{HfnPx;7}PVXJgz_hJoG+a;=NNc&f z5#5hYG8ta=!pLtVcO}8du$*;+{koeSfvYE?QW=Yx$~a@PAP0DO8+u;kbz?8}Tt}}JPzzctO}3Q5{?jZ(Bbb-wyDSULbpKLa1VyXwQAHsY zJTBB64O#USYm%;y_@Q#dQ{LpQnzF=Z(EY2_B<13#>4^4#by{!?r_>m|&nvQdPiR{C zl&s)&vy?FO7`wnmnUPe%_0ov(ObxEm<}y*D%Y2*r?0P20wEXmzVM9DT%xo&vorZ?kTGA0#HlGV@j+YDi+Xze1}YGr~ENw+{uy<{h0)_ft&vbQwf@F zCEuH~M}I7I%i~%b0i5ys$Ewuu=3Dkmg6HDEKAw`!+7JNi@r1dDj-kqwt1>{ACj!LxmeCtf27gO+h~q$oi2<1*u#nmsoKpucd!$8m=;ZQQOHc=ffNmYV&c+Cr_toGHci8JNw=R_XK53U&&Ei2a_z~Ki3mq)&AhHrToHh z>&sZPR);QJw6j|7r8YQS!-oSjK&Wd_W}oCw^U&IO4;$SrVr!7a4MDY@WG6+*){U58 zbNiE}cF6}64xRe+D=YzqAQI#x3v&)yfnkP9pW0%RkBGH<2EdCmp=Fh;@+gW)4sQU# z#lGrL+MgS%QCF?+C6D^tQ2dK&mvR=F!_FDh(gigrP{S{ne=1zDYM zD|ChsWBFDg4HiwLo{o~nz3!fHy<~Y0q^5R8aT1?|A&dbrAqX17NOPfopwm8mCLdyx zBTNm;yYD2vT2!|wT<&L9Fm(xD1pk2~KadBD$y@O|*Ht}iU|bzE6T0op_Lw>)VczL4c--VtM)DX0{aE-vzr zdQW8ZUJz@JeV-5F@gkmkcy9;v8Nsq{_t8OIBT)_z1BEjLmiteShmQjjw+{U9_$PSF zlw*3Wm?;T^Y&8@tdsjE~f#|q7myed9ewynpnAI-8o#M=1zg!l}q`~@IEH8bWzR8hj zBzY6S_<)|XgnuKLEr(Lf_ddB$-Dd(+=YgZH)OdaqJ@dtl|Hp>HNlJnp9nv=jh^&T! zk{m19Rmi?+nZK=!b8Q>n{C;&P$))MODlg@2Y}D(idgR7~SYY>!;_1}*}H z!z&2?l=uhRI z@D;JQS~vCOCAO(Z)ARs?S081x!6J5_UW3B?T}i7|ex$iu4qqT(aJwJcaOn6jBsQ0t>$HTW3E|)=wyzrgYZ^dlQ6ZM-^ zZ#%(7o#z4nKo1;gQx&5)J?|oSts^BTD^vU?ykTpwqOh>FDz-I}XKP+1%*-<1YPN|3KB;0KqcG|^F|#A^ zY~TdrB8Fb+;(;B69It=?K#%x%dEMNaOL!iT01vi7%ujz8NUC{BgNk{9x--g*R({;N zrIuNwP}CgHvLh;h_+o`{;-Z3jP+U2d1k(6_MIZPKG(Mrxj?6tDO%UcXoxSwJuhbB# z)_Wh@bklSDue%5~F*H;gV41msKjmYb0(-W4%~c(CJlKv>wL7`)wU3b4mx33v|LvFD z@n5fsM?5AK%uG4W&{73?n}Z=n9vpuLiAjY*aYanXD0TkS3=Lvw{c{^f2LmfO_XjDi z#|Fk0kjyiC*@Dv1BA*OpxjaR|L&(RPGcf>x-DPD#GEl^g1M<2y{Ji!vSg z0$W;GUX*OBj?*rxX?RaT_OR}>cD6G9P{c4VlE1eevVNo8kim+`z{dOY)2 zCO$w|703LO=mx|CILlf{37MeGBzNGk7KxuAdM9~H0sTMJ?|q4P#|9nKAMcktDY=@p z1tGhDBCOqi{l-J_U85cb$pi#8RtarCe_gK+q)_x9dd(lXr5z1aH!+QD%?)76{jMCK z5FURRFGrGTX8>fy^~b7`b6Gh1t5<`Tk=OfsOrwrPPwU8Mqf&%3Ya&94$2@!fcs1jm zeUe+Hpl^ATOC2)N4$&>FX)ez(0kqZb=gUV`iKJCKo2!shZh z?*z2h5#G`MW)Fm&DZ|n#xO8rvNY^uXtLa@AIu97n$XBEheX!$%g(}TDsdlHiEyceT z$N}>=KD91y)@&MM`me6Eay>!uOwO*>WS3SeBy)wlZ00fmGitop(L{bE?TjUhj)$i- zzvw47h}Ma$=%7&Vm}Vs~xdi@pmGx}5-0q*f;=5fNR|1IBaB=Ad?Pw{p4PZv#_VMh?*u=&e=A~Iwk zA6?I}o{qAnC_yST(nsVGYsM0}iJH;MTU>~KHO1jHBVRFbsC}PlG|7hAvIPxK6p@{x zmXnldHQnH>NU<#9_OLcnj|8v*_!wK{BJUomZ6iB*Jr)q=Tkm2EM_bbWoOlzxMYRcK zdqu44jKC&6E0y3e#vm^75s&PjQ`&Eag<@@H+~o`#Ud;XEB-`%s6VqktWl_A$G_o~H z6b(oEpii$zoa8H7NsG~ew-oplsTn25ryXUrmz#Umk~Co&ZBJmo+OA>lnMciYy=4IV z%(Ii_V0~J;FlyRiJY=ff^NF* zEYckIV7tZp=x&fFS^esTNtafHaFhjOPP*0a8_Vc_WszO1IOy?dhJP-a@Ro(eWcpx0S!jWevEgz+TXva~^1j%-`#LuD_1pmCHs4U% z3l?_;7xRJX43HMHlbHu5SO0mr67<#6agoq$waaaP6LG7?JP$^qek}Lo(QH1SnT_SZ zRMaT}op#W2_OOreyy3T?ENn(M&a_MV|sK2NSfnrNA? z1UjXQK_vhAzSRcr!+|%Qs6uA~gY8&la?B+}QqUcb_x)=EG=?arW(XW<=Ra+|vz|)D z(U8;4L+8N+u$hK@&#*bAb-$>B8E*Z=X;!k2*Y|nVx`F5`w0^tL52^y2EZC1ZKa%esEbsfP#x@BjQTfS& z?vIIVxLgXxcm9O4P`&@%YOaf9nnF)XSoJ?vPEg$PQWuSc$ow@A8$>@JEw#^3o*?K^ zfS^`@nj=hx&Q@smTkHHqUo*h#y+&rhlBkY+n2kOPh3{v6pS5YFhh8Pc{^;2UCFaPw z&AX_L@(gryYFsRMcxr9(Y=t6no+qWaxsQ8KzJLFK^5cM8}AlL1KMkZjdt!F{QPw92v{!qJ`!5@_e!JPp&EVuFhj~ zH-TEQ&FbLlvaKej=-K>`AAlJTYvdehnv0V}8+3*MLE@|1r54?Itbn>!(>t9vy25^* zJ?rCvQav-i;{IVV#zHhx{&J4;vWwu#uyeu60hqw~8qSso_uEcpwHavG3zHn4X66^O z1r8v_8VFrt$mxCX;bdGcZ_4s+JofQ+CE4tw%|MSwfB1n<{y@UBG0j24UZU+sIA}3A z|Mn|q#du&A$POwS40UH_M@}+c?wm#;>Q2zawLexk%4#-A(eMqq#V*U3FcwJ)3kJbL z_Qg(Oqy0v7zh>;yGT<~-_Zh+E%7q*{>I7xcTcjg@3VLT*0xVn#SB`k>CQ-?_U`F7Q zOC=Jkxx7IhyGp3;4>FvuxLnu>rDzV8T&{b$0J?pGJl^hgxk!qvWHV>irM&a(p;+jA z!{+mqB`Ky1!0QXgo3Z6rnsU6zfN|56oA%~oba(kvccMOT?iBReglo{xUBw>m!1V4$ zaC^MT%q*4<>4WhztM3%7KsA(viF$eM~5|`CIjT6qnxpk$1$-JUSHhIP)WbG?9Rk%GAV4s_ zI~_Ro%1jbR@mJdcM9K}(!n>%BdAxW?2(HWB7$w~Z znU9!g_9o^$Zz!_syLuz`Jaa8JrXWe(R2a$@`61gD0CH)!_4lt}-AeYJ{voAyKHNMFA!?2f!V!XS-fP80KbY^v##dPFw3von%;{2*BW&2%m2YYo;6-x;*z=w-J#LS{YvQ7b zi+D79DCTvbnz&nhbj=WlQ7rVQD^EYI3iKe%AucLmXdDeSVA$NVGO2SPv^e|o-piy~ z*C7~2Sp*HwCTy>vw>*9ic=k8QH^RPhvU`R7fdX~xHa88Udm)0kMQhxDs9Y8wq(JPy z;01lmc5C}Vi!_twi(X-n^M(Zc6Bj&D)2t=p+8M~x1j25lLjy(I2aR(hjeK3PZ0(Pn z#3;;?ULXfysLzfn%EGLFXdO~jm zb3Xdy`G1t1fdR(_y`)b5K+=24J%m5?!h(?qsNNId2)cctvLYV~rk=mAx~Z7h%2vzX zE47nv;%FN;J6R=#2+&$!X240$gnZM`2H|$#`F`pWAJhu@i|bn`;h|N<72~IkKRuni9INf+^U(yM zqm$C_oD)5s!x^JlrOgkv=BepM&&$BtkZ0mj*^)66$6FI8Qwqolc{mcdzJBVjB5(hP z>PZ2HOUJBDP-@s#N1HcwBMN&tdMCUKR;Kd0SUJD=ar86@f9zfP@U?JI_`q{+Pjzzq zIS3*;4xU(V+5Gn*|-D5}qD zAB^|r;oh#54`$qqDHHySEAV)_s;V% z)dcdYm7-@}X0ozAz z{S&ao8ma*nfV$-U7N>A-5*J^fNa~Rr1@0Q7k`ZPtHrm_lvu>m-F12IZMwn!c9=?QM z+LA~>V+!1rOdU3F2n%!8S_T}=Tpp;Zn<&!8%_Em*}p9`9H@3X!Z$ z2y#i0)Al|dqs~5}Bl2`-Ax60a&TbvAlf z3<-j9&-&g^Q^PmAM$SZ}aEF?X2k#8J;NVOnf6Gy{ylY96Y;8<&dfUAiy5yi_3+@{! zjB+Xm?)IfJVx}f5d1-#qAVk$&hhAd+;VepF1Agc)a~5Wd7Wh^_vU13&5sj z(PQxu@Lv{(yDK47Z+xij)H-0<%-l0roIrWYb4|_&J-IU)4x9 z0ck(VI!cAJ-oQ6Pmost|{=G^Sxa~4B!237c35cqXWlTp<5RfO-R<^2l`A!pHgLD39995iI6 zcvTV6HUGz>rTzu$Kr{Y4K@s(uqhB$1f9K#`lNSt4+tt*VBK|Zk6(6XF-A86NrFsyp z%nx-1-pby@oi@t7G1@MEG{td{Yw=|^%F?mxwcZW*@{PIq`@LFy0B<$d$OJ>GpOLk7 zdT0SXzJ{2k?4wWRl3&+R8L^_4mLNhd_M3T`^}bt-tA+=ao69%%iwOt!wfH^XqtM&{ zrdKrA5FT_4DlWZlblmtzIoKnZnP<>GA^{BdQXiZfPs(iM7t7(60 zy;}SD@a8V&Kr|lf?IjTeaNlCmx~ph<^1Tcr)a~z$NF@)}UOZ1GW&;2PKbUv>pNWtz zI7zqWTtGP4W?bh&cp^fmMVAq{rhy-ICyuBzIHF#1{R!{&T&gR&-c;}9U!{Hm0Fs$d@b$V=Gt zikTfbZGC}FHW~n&Oa#D>qm2jTUE!Eh2*GS{d@u8^(Vy|8W8+eI`R)5*#eA0l=QLnP z1^aog>qbci_j~1{IlQm6#>pz5IKCWZZlgH`rd*ShNqY)ugcUv8{_nFcg5n?H%Q)6a z9tc02^M5&sn`EWDJiRM(DXMQO-AngR0VyETKX3QIpDSH^+}&V)`XXfkaDJYNpoati zR&s`UpjAae*vk4+5Gj6 z^@QQ4anjapcbU^^?WH9$tIR4QKM;e&9S=ri!CkMl(aG~A;R$D`6kNvlh z)X^~>c(dtA{!UiUkDXTefg_=qXcJIQh75>@!5a30B$eHlk}8ZT>T3~MoF#A(x}jPr zpF_+Y*J+>km$%a_d+lpWBs!rzEX`S%F&=uRJrc|RX{H${a)Lc20qr?jZC3h~eslM| zsbMT`Xx%fzu$d+FqA*K=CnAu-TSBN)OfvyWE9iATS4U7fqjY%@#p}XCDBzj{MoGL~ zA2Hs`{6pJCz;03X(3BI|?F?;sLNy&1wrnSR=|)(!U4Q~m5z0=&y>V-SGS`M3{Z?WN zd|srFu7!R8GI+|m%&a*p1Tcc`b(!tg)5AaAvmzo(@p5YR;Xw2?Hlx+vn=bCY`JBce za(t9GC|Yar%rxrn*P{qpI>^Q{$L*JrT`^jw3f|?>j{923K%43Hj+%SW1g14{fH);G z1DSZb13C4C4z!IRh#qmgmYkMDN+roAJsrnnaNJ`40JXhvc$TQ~mXL9zLrK*iMjSBQ zAWt)swuV8T&iaycpTj<)Rk?}qg^|E_R#{x`j`%c>hyZA|aprpZA2XygmlOl<;6F>B zL3P+-_eYOhJsd4+y?-49g(JbrwMUwQnOxkhbn+YdcmhUkHcPNm5^N0@(jm%=6 z88AwHqK+NtS*>FyVe7RZDXE!c)v1eBf5-`8swD-GNw{i>$sUqU%Yw^|gkzSI9lU>` zh)y~Q54>rpm0dwHEdf|j*n(e~$zdQ653fIL@m(~bV>1lFL)^(qMH}O>2w%NE=|^re z{SIAufbSa*DAc)tdC@uc{tqT8L8DzBqyQtiMU$5{s?Yfu?KplHOjt43rDIdao2Hyg zvfF8b^aqd(Tk1HlaR1lG%}E8N-FxHvyB1Q|BfzU2PkB>@wZLF2G&I+8fF!e7L;D+A z-^Nloiy*vuQ12`Chb~LwwnaXs8V^lI?EnbYJSFAYqh-T;RB#7`a!Ja$d_pi#sx>&a zd+y&LKq*=wD+a2_RWAXQzomOI7IGY2d97+JlzCOXbQ(necUF+z3=ZO~W(EQ$%I>)4 z7UlkB8#d^BV;21KVEQ(yP_z%7C1!VB%lDa1R$vHKe&Ebx5;r-fN)K8M44zIs$n{#$ z&HQ9eFt7@_pkKm#tRPEt%H}Mv<#@CjFwdg9tZoF6r@RyAb*;+sR$A8_xzesh!O%WF ziWM|(LzpSh7gb)om|6uo9j*g(Bva!_FpxNmr|%*+7vp1mn7*;wdI+|&K2M%b4@NR# z2ND7?9e>o8QVbxvbPor|5x3)hj(xHnrKIVHG_hL0Gs1<{jPp+B)l(ZAQ6?;_VnP7{D z_^KKaJLfnU$}`Kk7yUA*rB;3QFU|T*b#wwQIJUp>aX<0az$?3j@ z0heTyps=jPF6AUgr)HQ9yD)Pxuo^@2X z6O9~vE<+0w-NcoB`$Lx@?2GKWAezzO)xoexd(~c6*i+O(t3+b=1|QB2p1RwymQC;k zymmW-4=SKZxzcI4Gnaeq^XS5xnYogTmkI@IpdJ9|1Rpki&zchLP%oOh3ZowEjd+0Y zrHHK{;Q$T@T{;1M2PBN#ZnAi{LCQ}}BLlla(VMtu%l0e_Mi2~!rG5?w&FtuFGUpe{ z$fN&8%;=mV^~Vmt_^I6)L0RI5=wQ-JhcL<+-@o0w+qJ^4+*yT#*#q-Yf81jhI+y=hF-aKfV<;iE4S;}6I7tO2rAu_$ z5@QonTj@^wM=*C$a(6?u*A+16w0qnQc@MJM5NUfA%)&3sA5(r+1a6glaXoQA>h5r1 zI5`!*IC%JE_=%nKMX#iz8o$$Q3YS7Ix8s5>K?b~cwIFP?-6gVU+rX|dVK-^d&TM^Z zW8M~Z>tw!Ep5SsiXOhnMwo3MeHij@>nFQ7Xz_YrIC`#xqdR+)jb^F=ot>A{9`^ljB z=1bv?f$7zYT*&h_KGQv@$&PH=je*`BH~ETx_fr~hp36r?`f0iI&BB*wqw{$>+Pmw z9PB~!7Z;O+mkWOD`R==y>h;^ENIhi5T#h5Fitna#BQ3MRlh??%*t|Zf`L^lze-{={ z`j616=iRlV2;r%ATc~PdRLKcYJd9` z)x2ZVmvbBPKdGHd1|K`gS&}?XCe5_GkuZzkg2=D~OzJ4U5F`&OTB=Ph{VcxAX}lp; z90!@UE{|vanGcw z==Kc{C$cZESL0@Q00*+&$?|d!65f7TEtY_5T3Dxl7dH5lL!s!Lg$&<)F?lx> zj}`IAf6FO1pG6w)4dXmJXN1(jJ|*i`a(mwCz!B4UuCO7u^S~*Ub)opq-Tn;+(li0} zpz)Ac^}l|_rZYRG&>+Z^o;4_!b)nW3L0-D{odJ5~c*x$v5@u!aM5UshWE1?l5Qi>r z?i0gp$E>+&$wUU1Wl)7Nh@{YvaATOW1u{ES;3O1QTzmFhbMjSmmp2YZ-R+l5q=VXYV~SfZzE!_d501r>w}?agCAL~w2je`HX{|tQsLv~JLYLSCD3~s zeA&MT0T%^IkbR^6vsNe%q>Kj{>N$A*ofqJ_6(6i*$qMhELBwJq>np0x;Y~~f>3`^h;wdIsAKsY&S`lu@R@O5=M&a>rod%c_M^^3 z*x<_{hDUtj&JZLyl?Hs(F9qip(3~Fu+ME`DJFrK#PfB#)8{|O2l>M|>YgB?I%|*DF z*+WW%Y9NBbd)!Li^L6K<{fO({zAbuBrVU?|r7)|WjudU$_Y(Hlon@o4Iu3K0qU^eH zxgNFKl{eD|N%Y<8{z0doGvBl~zXu@ZnP}-VAq6VRP-0?JOeu=++baN(z01}eGL<%$ zmAoMhHvK-V2>M>GI)>))=5Og{LXKJ9E*w|FuR<8Dr4tcCjgV$8+Z#ix&1lqKq;UNO zn#3Qx=z&u?G^oQ+;IB}wlp|I|J&+j3GgQUB04sx_q4`!{Pv37#w?-JQg%RHX)Epo3_@LIi{ioBbkPNEWE;PYmESKeya9K8iZ&V< zU+y7cnmQ$t-6DFM>O6VYuG^Fu%mZ zc@x&C!cfh}!=UAg0$KROKvH zWgfmtbS!O(*+1;QZIX#x1V%ryK*j{*e2Rb=bNopG<5uYYLg#VxXpK9gi0quOn+Xn+ ztN$X$D_z~{99{he*kUul>x!Zj7^cvEvxs;40I}b=fHb+_ld6Regx>xp%5b9Yj_YCc zxA@p^@}V5I$*pd@mpzg@Pqjb#_>@$Ds;#k)7g0Q6&c8+^I<%HE=bHO(XP5jjO$HE% zG@6c9tR~9dBN3pv8wwx(>7Vxv|SKaO=@}4d16leBdPyvvuS* zblO5id9w&u+pWRYX-X#?&z^ISq?$4ZmGz^BuLa1HoB}K}KDbcj)4_ENRq7pvcEw;? zp3U`3$e9B6a>My)l*NnMn5E1A0B)fKQQ-h856`%a4HJO~?fOp3#g{$ugU9QcjNN~9 z1Ng_PSLK;|odR8Gv<-N&R@7O(SBI?VNJ7vjHwM!LJu=teoyo```B%KDRiOz>VIx22 zipEG;zR&~}6D$siry-;;2LJ#PVnLr$WRyf)EB^ohT_y?ClQ<7;F0mrQTGp!wX zlhUbG-JwepxghZS*5KIy0c&NeywH4j=3g7?DhlPd-=O|K4F>l~8iWnG;+y|z6vRwF z7MN2d1^d=h;t5!5_BcjtyKL)q;7*UQ@>D%Y$laPZO{}|fIU`-X299@UayRAu!=vQ{ zNwbUPB{SW?AOHThpI@v^^QcD=XW$PfR*YIG}kx zwQkngmcjZlvO7=LFfD!eCM`u1mdy6)fMjerAOKcR9p9${tg(QP-mGx;@$mYOuE8-~byN6qkq-K`tx+Pj z%^ZnZP|2<7aubT)1sABA%^7jXJ%OW~bY(O%c_TAQN&an3_zelo2N0ps55VV$)2oyH zi51_7Irm2srM9S4jQsqTUE0u3D}1(_eJCX6Q&C)wi4-$g%zOs?KeKMkL{|M~Kn57A zZkRY={uhz_2xpo7i{G>H=z>BWz9V}K6besHK}og*8fD}=$#1^FcKnON_*UkSh8Ff* zza_OkLuPP}&c4rQt<)VZKD?fxlZkw2U%E0H7ACk-#7tm=*`R)G6b7-bJvt%G_b1?t zh`KcnFo=!hejcAk7(~Z_o_qFU1%DO{EBvfcgHT6#;3?BiwQ2UVB$Y15M>na9j?GkJ ze;P7vA(GeqLm>avdBWNho;04#zye!>J;TAyWrvtMM2`s#W6-n z^zAwo68id7@kL@RB6T9uCAqNf$!84*FNtEy=gNmM$&zAQM#Z&9 zA*pSwb;q(L+?4!3r$?xR5~GHg3W;aq#R8+0IrG?X5udt)Mf!*((iTWW8q!=bAzPew zU&hq!wD*A}o1DcX+ybQ7h0i9<*(xVMc~)LknZSrUMCD;pfvKVyqgQm%tX@&969rMOWFIGKJIOHORz>3jx~p7qp#z!{$yGd zvTkb#Mjy$U#}CE+u*}}#^n3x$Oao7%c2}+2_9>bFp1mku@N>f8`IonJiO=*_pKC35 zB$%j~I!l@0EurDMliz>?F3}b7HPbf3eprs_)7F=B3V#WXYw3Tp$_3OFOL(0$TLb@u z_ayDnAu4ni6S_%!@H7PC1cDWN4T!<$!$dgOuSA#C%&iX>bH;r9z?BqMM)axO-jVvY zHI}AiGPZtkSmD54mk%(ERTFM6T-AupC_b)ShAE_9PghM=%cMiM2c$jJ2Wo7_nhbC_ z;1i3ei#gy#Q%2Wmiq`k$A1=2-hom%FgE)(dSDaushY%qW8e)oTg0zZ9)=@_q7tJm5 z@Y+-4$wsBi)SQakDA^q&?_QP~P_VxTFisWoCj}ThGs$FsBCs)I*A~RtkHs&{w;V*^ zb?aZV>5f9&a$X(T(ydgE$OIz@>zFZ2MZwy*9$ghyGC157ba)4f=a*GTU}M^pWm1wt zf+6F8gmGPPnSWHNrqowh0q$g=aav5Yz&-fK;r%&6o&J#+@C*k~jY#uzI?)gAWP}^o z#I-s}faT+d3JC@>8QX>I&$Yey4_mEke8(x~U~O;Fy#6zjn zh&FfQbwOU>Mp2v*5lx1fa(A#LO}Rkfqu29a(R&oyah2S!1K0Rct_UZe+Y;|)po9a) z)f5sNy3B?Bn_YKJW`}psvO5Eirs-sQ8UMQmm{-*6evP2|{iHOWoSk&M_3F+Gb?q*dw{>jO0)^E0*piWAL zWamFYPGDpM)Qv6??7QrI9|YjRmPF3=Lh5|&5Od0GI*p5hOym(g0PpaHa#3-tD@$~; zweP|%^$qDs-w=&KTdE!vjbau8)G-a8OmV9JiFBp_=u;DP5k>y&N%HvC{q>&;2q5Da zl(dlwzxlJ$C_J(?Sc$myP2o0W1{!|pp(9zXfQS)TtE}mLWsXGj=1&00M3 zh&=%&Nhc$nG?yi%QX4C7Xh4)5xLaX$$a#M`>PZuG@9hq*D5bO!x~$b)n0gmk+9#&G zMU+g}E=N#rPI1XS@965MGy-7272SW38)j!lcFVN|oLw?RlGql0Yx*3EXy0E38_x z73C*O;C-0$EOsbrPmOu|f5VNZ{?2nVw(BOU^e>)d(nuMTh3xDBXhfQIpU~qreYy>5 z%1}*LGSYG_1a=I-lJ$@K$OC({WuBHKiO>VP%7Xm=umUU~79)*oq}tMCF4sHZVX#;a zpn2c3-Lym?27|r!^PfuCqI6~-@S@2>!^8DmpJ%oNX$zJ}QzZNw*t%UxpQiC5g#%+H z35dcbF*~ntCNQvB!y#TiXp9BrRNU$+W{a;37e$H(eekm}!`hZ`;ddk5?Ui5{Q1Leu zH3^@rY>7S-LMPz^u|y$5XzXBAkqdP4Yjm$kh;+W$8IJ2D>Gq6h+#lZiO^?^w*5MAE zc!c35&=F7H4BtkGBTdPx=)zFn{}l^wh%IR?%{XrD@R#6*;%5CraO9ia&j}R&A4?9h z#946J|KA>)`4KUa_=_PfBXvdmDKX9QwpVy06!R%v? zQlG5KAM`f1$UCM3Qo=W3z}!!t9$#Y1lZBsFQ}V;aOhulPmu2!0&ZlZ+Jwnjn#5wVt z7V5F~PlVHz<@f}8-m&;6U#p+N9K=|;l`QjN%gwv98)b69UhvMfrz`0Eei1nW`=nv3 zgt|B*88KimYrHe{-Qc0~9Uca{hWkzhy!#0TGxLdQ3u*$|FY-%kY3#+Vh8%pgB|^mZ+% zn@wQUtOg@tW%hK~*x;k>{dV==iV`+hjn$)>$uHkm+@&5!4pu7qstPr^!y4uWI2XvM z+mV}$oj+wuFQ@t~#v}!r(z5v#miQ896<;@!X5F1HMydNs5?w;*CSVS1{I640IO5?V z9ZWfAKmV8X`zDZMF=UTjsKwePL)6h+d!RTpTN?0;Fq^qWMrt5}Y96(E?NzI2Y#65N zlTfqr8zZE#YAsk{Ntzvzo`?QsZR}yeV?rBa(M&_|sJt9R0NKNC^Oyd-WN9Zc=p#W}$w40zjTPxo1xb=DC!-=yLt-fR#<+>Qf3>KNJRDDUnLybx76D z26O4_fLf^kgJ8_47Nq%||M~nqvBzTi3b{1bN5OG&9TkmyVk-?9S8c4P7WEdLApe5Z=>?=XKeL23JV64voL@Zo;8InuSk<7}j2LI=HB*KNc=Yt*5|?ot7}2dmc= zK}YavzZ<@j&L^KV?sX`kngaf8KvNZ?Xp-aKDQaGM8$5xwWqpB9vXitX@Ru9jzf%0A z!aZ4T3*3Th0;f2yceerxld&)q03yBzCdB|;K%>9?8!ONTQkR%!Cv$7;;*yK4!}Kyj zxAh*#1shU)Ci4%^SZ(y1(BKJhwbFB|ZcP9@uiUy%N1QT4_eF|?38$?d;p_98_xlg> z+g+E-Z3q=Ud?oc2^hO(BFyBwTL~hKiYL78azf~!Grn#yNAqvUvKc!bqNs*BiKs;E`h<+WP7Eg#g;QZ!2Ho*y)=3#8}*LUfOa z^Yn(whxJO%db||1mSL0RSVdFj_69u!iQbwv%=ROYwq_Khn-3t7uA~gc;)KW2Zq+b`x$Wx<2a6h$Dbh&VA2D3Z`sxCZJFrDfM1-8||oj5WD;IdL|2GP*IdeAAlXi zaP{cizi`20$4D9TV}Eh$Lo1|g)p6sy*;e0s7W33h_89b@Ubt>LRh*4oMBU|<-ak_g zBoQa7qb1?^X{vJ@_#Tih_$QtamC(e0QePF`!gt4r%>^fYhw0=0q{H7=t@{9&&KD`D zu@?LnbrnKSym_M!$-B^0)l_+sxqYiuJCs{S;?ZnRo|$z2Cj(q$q__No;`osn2^_`w zB0p`%F-R z&CR_WG`bTsJSPvyV@DhVXfk`cstXn}Qw20TT+~2EeX)p70}IB9cRt;uo)_h=NT+1) zXHf+o53w*nS&gC>B?|^hAk*C{=e(HnhU(kR6stN=y@l?MleCQ?xb%t#oiHWd0Ub!=+OhL8IdsSt8W2I?c96ES*PH3@x;x*y9tJckT;H>>lQ7ELq zwf-0sNJfCc&DFx?jxXC6ZB2LC^;Ta(mNZUYrX4kuwEeKI9~%REGI$!~JEJ`8S0$dW zgEfsb^@0)2CpSv$-z_%LtLE6mq8!ec>Lh(p%gxKXy11iArgw>PhkG|kVWyd-8QqdX zmn;9ADBvZBCBS#rwXEg8`GW5(A~~VP^=8t?ZL1b!&q=jq)y>L)01PID>7ucAot4{a zQbdvu>n6`4wgA9W6+J5n7}n8AW@TZl8)|Ji*kI%01iSx(kvY`MTP}%#2moKnxwj1I z000ev0iSVc5T5`5aabw?xt&Ogg!o^L2wkk#9DSFat4@FI#d$H1oDAup0NsXSq5wo5CtvcSQFaW?FK^QcXoFfEZc>HMa8qlG zzoN?3=Tuw^d4LagBvG%C?y2qb$v{erv|5IPr-s|M~xd56L zfae(6~MOdA`Xp)bCS}NlU*X*89 z-VVRTtU2k7$2WE;@p3i}o~Acf{_##})srY7X3*J+2GXZ=s^&x=r!z4*wHuDtE3Th@ zzDVpNmhX$3ld?aCVdvPs%*uCg{YT3g0_?1iZfqSD5JXO!07Z%0`Vm4ox`B1k&}3+E z-2`oJAKpRckgDq?^muOwCBAyOZUuz$8hWjo9NP26;3H>9uYL|`F4V3Xw~fFeQueJ) zYGFJ7Mc4_1vTcrvaWt|#I9T|^WeYC`5RX5Ao#l3zb^M5ZxwAgwxZt?t+K-b z&mc{v(=1m$)Vhxm0^@M~tDpuHEGhxIP8lhD zBpk0f}=M8H(b7`uDc!B#0UZ=2SbCc{r98Lzr831nclPVOb=c{JYeo+itcLm$ZN$ z5Mc^v(7@#FeGx{1dvE#t0Ddb}*Zn^I2R`VjM!e@OsI|9LH3?ey4r773%F59@Q#p50 z3~$s~90%@3*cW-(=*v1#fsx_Xe-*1R+@^s|+7lF#zeJOnn=W30X$Zx=Ut z6PGL@cKr?zcw9X{2XbUH-o7Vt{A4J_>Uroq_y~-7BcZHVnWx-gs35;zZ(CTvk#u!Q zi?}BMMw}jgl_jd#H#(w>7}&<2NPwwsIh~El6qa(X<-@RUc zVX~-)d2`F0H8M+|6kaR$yd}m_wIH9&x5fgv4)n8`pX(qX5uA8HtY=g8nrr;1a$F7% z?4p?l{n9=$dABgn<2UQoVVW)vofxTI=99}=M=3(*wS{6r2Lo=q1C7;omy_NEfTMx^ zfE!oi>`8XnlIsYBDqI*~NOdE|y@uuZeU@t4!QjuQ*dr$2v_TezOZ%a5m*=h*7>vPT z1i<906&(&avjuFm!R;fWVKtHvV30xwbk9jqTjM$`4I6Tt`)G)mc0mh@HsuNb7958% z{PJdyp;$|X!-wbImjKs8ndCYfIJ?|AQAO1 z*jWFp^U%}oiiHI;rAm=u4Mw>FSg1Ua<8MMDQ0!=f!=>lLOT^N49F}j9E5|2v^BL5X zwgwYNiGD@W>P*~wM3<>Xzo87r=y^rAMw6MuJikj!bOi?0*Xlw2GLO~#KD~5L4R1R0 zI-JM2Q*U$MO~Id#H%hUUYqbSW_PKY2ty5s7`95$B&RamND2xuYZusVHnt1RCDMNgW$tR=7Kij|=?K;p1 z7y>Q-{RzwGm~No>W2?>-uPj$MD2wra%6>FUM!^~aHnB`)Cv9fv^Q#=qm>Qf>Z4y|1 zkT#YpA3QMV{cB9ofN1k``hWtxR-7Qz(YpVK_{0HOWM=({S27W_K%zl^Xf7Kt8424N zGjAG>`$L{7#=)_td>uH77u+sfsu9d<8E_{|Rpt)J+st-C3W+#N04U6GtbtG_Pi0-~ zG$p+7_QGT%i1MJgH(a>MSgEHjZg#MA=?ZnfY9jdwXqf{V_7qOQVOwgirW3%kiLB~c z5Y*wKK$w?E&&eptP+QNqgsiO+Sgc=?)z(G2Yy?fi!(~gl_JTMj>irsPDXeA`y5hyK z4EFjKO7TN!Sva0BFkp{%oI8jzSlB*8=0MHSCZ6zG<9;!syXa4IfcW!dD5~)mV5s|M zD=S-jUO@$n@xd45V_WCUde#RXiQV&1^^?zLG`Z&f5GcA>Y$#V;>_>T*X5xO}WIa7b zJ`!SmJ(?Lt#3OjM`B$us143EdF zdQ~vT1}kT@EcW&~n(&_YVRuSANRT8(v67`RTFHfq$jhB@=KLcZD7sPdO(`2f)s?C} zPb<+#;$Ij!z*aK*+7u!5yF2M7Vg66I-jA9lio%Un2R^6EEHhS|Zpi&!A)+slcrYIU zV9!ju)6w{0arUWka1Twd@*?F7t8W^IBoxU;tg^iziTtObmx=qZDzP zX(LKUlpL)>UvRQio+x&d16`Amy2k&lz0Giflf()%Y+ZRzI0edYYbG^B^NdPmsSI~wMu4Z&p0r=XVs$An80b^UoL4TthUyco zV|;L&A|f21ZS343C(%eZtvx?OShVW1*8panI9ibWUtBwx>2mIBr2)g=DZs$Yde%70 zq_!ZMw0(kcNV#g*^0P6gClIi~(io?QZBjWk=(gUI99ZB0yy4iWQWbTumkfZ zwZu0>@77RhLhdzG=&%!VeEO90TAb#r*v{>PQ>- z0sCm!_tmrRC8YVS9&DN+!}8N*5=|Nc=h7_IRt`4zy%8D$u35s|2|JYLI${Eo(ZNYq z0dkDZSde!S)CUJloLVXxk&rJs$N(ale)8AF%^JRipIBP%lsq9gzm??vAz8)19n+|k zLmKWY+`vbdf{h<-&KTo1+tD))!2xF@nM01NQW>rK?0RzsI;B0MK?$l2 zE48*q`2W1jq#xHDod}k7+tRZ3#o9ebD5)=0=9;>ISLy>CB1g8;FC7WJl1ggxwU*0m zjdD{^V(&{OQ*YC>j(Gm%ZU;j`twj$sEqKX77r+DW4G&LM4^>~jpk`70WeF&Sj3dc( zii4X{HsbX`nheou!n^9!1D*Rjee+G-SPuAxw!U|}wDJBB)zvYRGv*>~2PUzr zNs;XE4F;2PS-n%JP9K7H!!1X#Vzj@d^yB77^&Z=!s>x z+GykG70Oz$PZ9|x$`C>YEpUCf9Lw$Z6Fx= zNQi`HJV-Z@LDnr?ZRM}^qQQb(t1O%z>gt=}!YM#Zj=m+gas+ z1<-CCZUDhUKM|j(RF$Y()~|*`B|Cw+XaT8>0@`=$@`mF1 z$1J1tT3P{C(8S5e)0H3G031aC0RE<*-`s;74npqwC!&x;Ei!yww;0%{|J1Y42wt~q z$Xr#@443nuOUM(u^$6H@s8@5nL~k+wQ7k3`Wo&OB z(#Yb5l-}~p;NcXZ)K+@B3}*9kzQy7J57h5Tdz&shl&|7#YTYTYjHu0{Khlbq9|y z3A;WU#JgG~ZPm;0$c9?DcEmefp*>p>DKg^t*Fu1@yn5Bq?7xe1+bV7pcp#v^errDm z%ibaqyE8w?GD5fD%?0!$c}|=!#erk;Zp$&{`@S-?rK$px4DtMlR{zD4kBw?eVE7Li z%sIxi5JwX@ms2++8kqyQSX{PgKsC+n-3Nm!iJw;IL(goCt_L#otk18axa;C#E#CL| za)i{s$BwatKL1BAvGr>QyoPwg-mjdIhFLODQt`987Tnz%H@-pXZt+e^PE8*wgW|}z ztQOvv<$si~1s?G%;q^OcC)oG{M^a%Xg8)Ll+~;3~UDy?QyyXP=(LZD6GMYuNk-c{u z=CpP#Aj3gU(kH`j%to>-9}6_P9Y*akL;r_?&sm}T?C!q314ZdiVWrCH^_BwVik~S_ zWmIpl?agqKt`a#CdkP5KbSyNKvk0O{uJ3HaMF`1pve4{(5#`R6>04G(XJc+lpK27H zk=aq8?3cWiZ4o_;`i!*zb169inD~$4f~`w}`sQ*PohJ^*M$MQxt@KArK@}9cwm3x; z8)$z+CFR!lHe5t@d?e6F*xa3f$tn;8a)WFu|C8th*|~Nq?4nkeCY826&Z4h~+_0xx zS{i{62f0Gs{lSfEB#_}V+~~8;DPgu@K3$zQWpK!+9x|oP#KYs~^wk{_qt^TgH{PvS z8k^~3QY7*0d36obZmG>nY_fMn$9qcdMbkY;rswWL4&9KvN(3mJ2w=_Mr2Qi#5HnEM zR*jhp~C z=^7+RG=p5VPGB2O#FzJ)ara8h%o%7GMRDk2{_T&{fzgf1_uQ65*IVuKK2c&0z4r(= z^$XB7YIV2|Hg{Pcf1?$9l(&8<%WdUESk)%pRL`EAWC?Fy=7+o?_`Dp#>)pA{$&vK4N(=rgMuF zvi`jFRm+j)Ub)l{=ya)<(|GsszM_p;{)-9K<)Kb*{F)XVYRVmw`+CmQqtsjUQQ8?y z3jadtP{<-{=_zH)f&c@xA+Ynp-cQUszIYeVQ(HShC=943smhSbK`lYRcqR5R4;LpcH};V9h+3fKDI6~pX~br}VD7?A;nt-#lb zX_#Dt1YHQ$`SUa|y|0|X%iwKS>PvKm7k#9E9i#l{0^i%lVtPTf+Zg=wD!DVr1pF}K z9`hy%&PR4$r541vr_Db34Uys3^l2S(A#kL%p$gL6$?$)FleHqq!>F?*u>NLlXmy85 z{(Zj^x`~8&?8af^HiXo|F9DqC^e8+s86%@;RT&Wcr}Sn#9=N2hlb5gttn`heWNQ~ITy8IqkA`NB6J9uJ8P3T=uOb6zfkG^JEC@?K!Qgy zCO_cmNN#8w7P7IcAvc}Zddl&iz$-}5t{aWh(piZ_p#*Gj)`yR*>%$^B8%-83?s^Hk zQSp%^jmHUr?OROazjF@L00f%@?A)jJ-ym59SY)VsrV2P!{c6fi_(OA&lG47yae)k& zogO514NGjtgp}`q1DTC40LCxp>+@qqczkxAHYdEI)P}Wfv>jqEpDhRc<4%o7F$N2O z-Sqc=%qG|+c52ejj}c6px)AtiY=Sin|KF`L{tKAWbek~E>wR#YD5N2cIjpst|C{ z{Pt&UWU7D$ifpN2hkJfx1qx3*?^S~ua^)jGv+4T~U3xke?2G<)`PTbp&3Sa}^7xeS zlxVex>S#9)9o{hHa{2t!wU@&Y$<}97wSKxceactqD8c>36oENpIsSXEc5NIndII{h z&&Y6JYljHVBzfsC9nuu0HF}b@&8Xb_PmU0By^b-_2M@YQN?J5Q~?Z&=`dnT$!Q zm~}IyTxh>ytBrBy^l{Kwj!6wx$J#qH`_o-=p@v5mHH%|56iQ4tPdZsyf_f!z9D&g6 z2=jRd6D5?yiV8W}E3C{tDFOL)?z#UoaW*Mhe%!%)gX_PnWuj9%)4f}rBON= zl1H}>sm%mX7}?-SFh^Ye*-GaL%SO|zSDK7dPz{o$&8<#Fo6^{iL+hVu)Ugb8P#uJW zdHvppGUifjYozPiHNQGT7nqDoJmhgVxwP7y-y#5WV6Crp%CxR6{nFz<-}wEDm|#NR z4^8(e&{?*a-A(xjOYTDp;sQ*z?B7`+&w#QE%B>9o$iHvFdIIX2xbTX|&+nbT90+4n zvZjRtMu0C;YOy~Ftp-6>b-=5KpHElev#t|(;B)0)8i1AGITd_8)wy=!vZeCweqX)5 zu9+-F?IXD5o0zGrg4PwT5(kSCoo!x9yk#-GuQRxw94W~OS!CGN9Zrv`zwg`FDfC+v zHGu$By$NK(q5K(?Ddj5jVEl)za(%SoiHAf9XJeZdsv?Azs_5YylXNk}D6hO91 zC2A6cb&=~RkjLF0{LF{kn^TURD~oMH4kjYm=?#-nEtd18{#zbL(KKuQE`Ip`-Qcyy z;)4uxNvK`#a~uJRIr^|=c}jGAnc|g5+)ZpzH$5pKrUKkYT#@!0NU3AbBxvE$n-=Na z!+Y(A08o!U7ZZgIaEb&(Pa(5p0DM~tW?dhEJ4j)l@8j|E{&TQN?no$Hf+?$K#`-&f zPA0Zs-)B;D+Cp*BlM&Z@6&r;ACAN6nCj9GW1xW%sz+taxiB=WP-W>Jtb|KrV^(84G zHPYos5vec!5E|vXvre8FoVNZ~X@GnW)zaWxy^iQ32_zUgm zuh~ZhlP4Z~V=i)vucbikuGcPigMNSb8|6A{tQWE=-ag1=WUd|OA#w8OqpfmmYWT8w zCb46`(J=wPczrCN`<>EW3BrLr)1Vc_gzIgmz*GC8#bkH2Y14B^19)WVl&|+Rx_{^v z03N%y;=kbN+jj`Yf0`*kn{s)cJjSYim8T1A3w>vd8ys~>?*2*?b|aPp^pJ{*+6T(0 zetl#0O2mA~U12Zr>93xKIqg_~h;o6T9(TGI1I!$6nE2j8Cy36x*1M!fw)s{ml?8Xk z@F)S%i$w@Zq5*&rSL%VG#;OmZg9Eje3&KglGWR7HE&4J~(DkPHj_!uUcT{6cd=#-q zwjEaIt0Gzq5tK2b=S|S}yp3S@!+2tZf2r3KQZpEupXaFTVb+jrZYlp6@dhl;OGsVn zyIGd#5JP}&Lq=}DJ2sD>UN#;X-oxgmV*Lig))DQp`4FOsqj*ywnvM)3g`OO-VV;Um z;j$#AE?$di?<>;m8ZnYkbsm1pvBI-^8>{qb&;Cw*2V1|Q?+^f@ zxOugqq@44Q#Cu>%^<5}EeW0P9OT|6V+Y?{3jDwm>p)1vxbj;Qj!ceBkftToMQEN9*rmyv7TsF?75#ifB?ec zcGn+KOc0mhBDY%;mQp%%Zx3Cq|By`^Cqgy|FUZSk`q)-_kpbnGBeZt>M4`EF8i`*U z_js}13UMrwTz+#xi;Y-&cj}w~5mbABuN8+8HXi3l$IF0^jPsIsr-Jw)N{3I`o#!K#e4^@flC;00 z)A&@cFthmylEsFFd~09w1xLt+1u8+38F5k*6%b%Alu97;d}6BKQhB(d(FVukf||l- z=^%QiV%&UQh&cUS$1>D}E|Q<>OsdgbV&gu%fd6L!?9-7_MDB%E@eTw~n_e%gRjo>@ z46Y$8Ud@S-Q7*zZrt%k}vxB0PDa!TJTkFaCgad+x8E1gKCeWz~NS&}DnHJf1cqLpH zD>e&vihVjnf29>H`Tl!E5JvRPh^3bUPrz^JAn zq1laPf@;;{`e}KedM69ap!+~;0@ZqOIpv)5HWD10gs!J9f5a$kRLye1Ci?)JJBYn7 zEB$xB#r5V9>lOFYg>Xx_sO?`&pu{k!aR*t^3sn{o(e<0gb)Z(Qzc!dRG7e(H>)td-#b&&#T2oDX=b3a;&{7BT#zB z8}>BLO};#qXc)|;#FEjy*UZeb3w<;$bLQTFqZLZq(lMHx+M>e9)*hD?x97^w8NMQE zOHC)h;>@UG`|Fa@TgMD;m7(E^OcXp(Q8xDy0Am*srQF&}BZ9Z~)(~VgK3x$1EgOu@ z_jmMF?W~LUUsir@XRW+I)IDj(1A zG2TUN?0S_@+QG7`%@%&*q@s)>hMtG=Xcx)U+k23}Zsy<2F3ho=SXHETd(MyoiDicN z`_HGC5M31ix zJISW3R4|4ZQEb|P>yeV_;>mt_**%Ev#C*_~R4|gi6 zyxtNj#bdQK7RnB0-2HopM1(VG?t126El=CiGfS-qRWA-bGigh_BFsFDE;#TeiIKX0 z1KRLr>VU)k6(6^fZaCsjrK6QqgnIx(WL=+prj6xfo0!1L<91}G>GsTef~nD5I+8d7 z?g{q#{~CwWP48>q5J7-4k`w9_q2l!v;4!uAiS_I)u&&xZ@s&N+DDk<@wOvI}NIdBP z%*eHAZYIQD{`r8C<$X<;aMw$=9+z%NkJVHR8+dJrb!L9)S|N;fFvhTs`qBL$Te9aY z4%K_=T5y5bnm+Ixu_LWVI<@aD`J5r;$|CF~+KNjUCl3QvUk!$JZNeg| z=3;gu{?j?5WICs_c|$^S{Gsj2l~|T!h*ib-)0%%lVP)P&Dta(c6h+K}6AiN1lHi?8 zHF|Y`(^p-X^w zX!Llh3+sHdb``*`+@9zTIkCA?`|{S7#!^7W4&#gmM4rDyo6fAYoRZ=iN7+wo;}h7P zd#;+nT!|oA9%5|EUZv%(gBldnv;<>zkaa^D40bTwAy=Ii9lAfIXo!^4Q|XXh+e3tu zR$povmqaJ*v*K7~rU|1GP%#W{7AyeftvF%fbEgrz2%>te`LOAU`swO&X-{Pr5F2@6 zG(%97XjOsbk72Am{=VY1Qvz^n=L>X~YEFr!-F3U&r`r6u~|iH5eiyMe33S*83|8 z?F-w$0Kf}?R0Z7thH|-XCUIyjw&=kT?1i^bz6UoBxT8Ju9F>2C(z;)S0ckWJpZANt z+dR#H@Mae1S$D?dzCf z2#W$>&}PR=GI8eNPOod_~q7*5TWM7c5~^4e<1H zCi~N5*ABIUD3BJKC>E+|3(FFZeCcGSWeeAJe&M|`QrlCA|A+W4??xyekXP0Ij z%!xu3X%F1l5%|w;Ywyve znA+H3>+};t3IWiz5ji^TuTCDAq?GaWDX8GyMG13x`hz)4#)+`%oz>V6gNpBgO;h?e)#h{s#OE)hhF{cM z1oVMXI1jTBiI$YC3&R?Yg_LACDbULmS$4CP;%9opad#ePv}SMCn>SK;b36pEOkBaL zZ3#5}dW6C4aZ3Ay5J9t(;t`#=Vc1GS>Oo$C92> z?@l+PkeR>0OJT8&RyoA859P;45X&+Tq2M>r)vB{HdWjt-=U(jcrY~Ss`<54%kG50F zlY2-;x(Oa^Kz3pn(~Q3CP)s(2+ZZL;>?X*yx_VcXA>DY^*Ay%+Wvw8Njiy=mJf<)f z29X1KIZC9{FjPvcJVB6&``UNPnR@a-njle395{$OUjFjx~~&0wC){u9od48rah|hO1GG%&egI!>Yh8%j%>80O7{~$rl0}PhF$vr zVVrEc{b|F{9ZZ)uge(V<73W#6V6&e^*Q^LyLXcfhr?CF4Aatt$F!SAVunen0yA$c{ zin-X4Ik1PF@L4YDXakF3sy9$xKnYLf=ZI6wKf~+;NYm;f{QmutVHg06)zw6)`O=}g z0nda|-BughO#sy?<3VxOui~fOqFm|<@C6dlK(rU!nL&f*+**~uA#dFg%J8vI_)CI% z^YQCPdO8is@D#gs();c~b75 zsas=g7IegTLjRlu_ud5 zB*7NjNVn@Px{m#Tj6%pmo(kY&zN>U_yTNXTlITzVVP9V;V8 z;=SfS=`EyAcfI&$*}TxljeQ1M~j-vom)eVl1ck#QYQ^l@#e?xz!gFHX%3#@GtI}N+OM1EbH_H8_yO6&mOyA z)GzJT8}AD0g$W4voJYt!LH>IGej+(4%kn|hSLYz3vg zVICfd2C!4EY0s&DDhD&k4F!9mE|JH&?>0xviWSxJqDT1+lyu1wRNuVA0t{pdbI8u= z-XJa9!Ad#GWt$dTfjJ(yw=oD|QM6oTJ4pqb3I1%t)>yu4L$8bHLf`Z-2~57xUqIiY zZAV=S9#5fA&x>}R%FqwUkvnw&Sq+6vr+5pkI0-Yx1!gxiJbg~i$?-ZIl=on^|8DML z9GtRx1Q;==4^=(Y6|sD!_C3z4DZZNJrIOShQFGej+X8gv`;Xw%Hed|l^v%r8!0szE zS=QR8E|X@f+QrZCjqT5pUs}^Fn;XJR3Xe*i8>hhz+D5S@Y5I1ib00ZuXmXmQ)MWUz zm&%ztn?&ubSQby3f1`1!pt(Xd%lD~*F9L&!11BT~O)dQ~{Ve+x%d%)b9h4e9%JSVj znVqI^KT~qyOMVm^i@YB58yP)rXGk*56=JS~Ke)t2TD&l2dB;K{laYUbbm-zlmWT`( zT??@ZP&|Pe1Tc=!T)hJ zXHgL2o5QwlMf)WFKD%rxSU3g(XB7squv<_~B zB|OtAuO4gJeeY4w^?6~M#F09EGc((!R&dvbrVKmimEYYC@qF$R!O-?W{7OxDHwghlaGV<`s_2Ge*L$wRs1@5sMftz zO@u@GWdGJ@dcDqcqm>^vxcLO;9DYAH=g1L=0*LN|J-Ib~5eo^!U zXPV60j{?K|S`TD~bxKvLDu@dN2S@KhNu{gSSMmO8C(6~6yn@U5r+r9MYGL#-W&?#g za)_>S-!Lc9><5`ugz1ozsch>oxdlN(;a<3YNVpb!Il_;GSLdZ5pyUbNk5@Fn+NhJM zMLFK@j%mDaJX{XX>Sqi3z-dss{@~(^+YP6a`t{^@%vX=R{nqp4p3@}tf__v8!#ah& zxH_?pitda&2>w$VU*>&Ttl;N_jnkZ{}yOt8( zGGILuic4qQ9eZTv(V80aL7smfJSVnkGDadI+DfEHxvjzwBHaEUcNEgiPS6CFY zF+@BOf9|MN$Ay$I2GX-!_=@bMtCBG2UAodDtdwg9adHCNU}`3_v{7D_;8uB#Ge5U# zJdkL*@oA7R`lg-)PitipE3d79`oPFI@S55ScT#-^_u;G33#BTA3xg%O6P+lAO5Cao zgXa&5f`~bEubR}SIXTEx88>+hG#wsfJnI?lUgt0jk20{j^0CYYP=_SaUHd9_Z``%! z)=%Nj8fOwDw%hfedU8;Xg)x7=C+Ii17O0R~FRamO1$bad76gS@$sxb`cXXgeukY3U z5a-AFyKy~xQ9WADEEV@=^2djq{L>KDZMcEZslM{+;+7Q=0}jdO>s2{_&S#z^5oU!m zEzdvEpjHxI`}9z{y(~T$)E;RY{Z>p{8cJ)ej4>}pjR%$4LS@2UoC`74Fj(e+g4eR| zbiNaqUb5{6@7auI-;f5yNU?FuEFGdVaA(z2jW?arZL6l|`(kV|KVOfOOdzfBcLaca z*Y*2o&jXyaM2X3A{y$0!qTEVAQHmsC&JH7%c3 zC#)-lk(?x!d8MbC#yFI2J)|@gxa6H@3BhqM}5Quq z25wFxF?c8U%+PXZuVThN3bpM<=@D;?h3VyF)DNCoSj`z_qgTR1+DH(&0E$=uyk{i` z_TEQcOo_E+WcuQHKLd?^ij2|_}9~^d6QH?Rm^TUw7P=qdGz%kSk@J%yJaf-dd znsQOsxJM4HI43%9kXqml6=5~5_uD`O(48o{l1BhTc5pestYd~*asrw-DfPN2r_bx< zFx6_CS!+No(k8<*rc7ac*Dy!N)guS}8}O9gY3V7bSBW`yjVkr0TWF4(f1a7%rKvYZ z76*PdZV&ysx6oM!vhF!oLdqY+z4hzG`(MJH++EeF+`zxJDb2cTtS`@F zaE)NkNKTHco^ilY2B@j)47QLO8Xwj)I1QaKBNr#Q#+n<{{dx^}d3Cxnn8f!P_~-5U z$(N76oElORS_iArBSZqZP+*D^rFZ(Bs61WCS{ZU4$jJLQBQMl`Q)czLF#a7pNaE;7 zxTQ-Ie(a6hygf`wrC#a>YclgXVOwNbt&yD}Vcb8aI>GqED0&561sb$mcuQQu)_aKM zz;#`X1s`I@?iTwcd?QTzC4^O*Mvy^9c?KiM^Aq&6FkWBo+6>!nWaF*N*F&l{JeDd!w4J_Niw+*{1fNarI!Jaqu|BbvG9I;qTCfP zjL`CJWly52$BqI30&R`kR-lx2l~lS=3K4XI_q4=kPRuxl(}zK{AaSoZ9bSO|01UZ7 zpO$2lL|iNX003PhY;`2g3Aj-)PEoFh!h%qck=etSKmbtOF1l1`_kJ4sYv41|l=xG783Q-f1;=r$(ACR;0ibIf`vxFtfCckfq+o6GfWkF+NM?*^ zjyHm}_Eyj6x#0sp&qL3urMwJwvCAdGu83h_2u;1{lvL+na@8J$5h5H`uw6uZITknRJa7b4TBzjOm{qZdud~DlXJPz}1$y?`S5M|6lOUDG>u-$_f z94#Bq@Za|*YUdkYP7Mz>1kjC03Ll}kTork*@NUx8H=RrYj0R67sMFy{>*RBJ8+SLk z+$J3UO*jE#&iD}##KHe>89MXeX3d@>L1*+x(W$?QUw5;(-OSrU1u)90m1lpdWV3P* zKBVq3?DfW_T-8IHNk=pcNelDdW==!nU-Fb^1_^4<*_v2FylBS4-%r{04aF^v9 z!A=lCEGk-xsBI@GvUsgjf{6U6fS4fS%h?BN+=xJc(V2}LInhlO{2Ur&+gAj+!U3yJ zb>o_RS8L#4V;5iYRGK11yCCI`d#1o1XB2>li84QtAR(OAvm{m=KGcmq6D#KYpfydZ zKyo@iX2rM-b)3zhU#C72Ss!va?mGfPzw~Z8RscEHG^jg3dJDO6)Wsv0R>k`bYC5wW z@WWEL2AvKFqObomj@yCn@L(IhyMfXM1}C$20WS8;N_l-b#P4(`L(5)a!NTrz5?Q}} z&eX5&!JZ26Q7XbyqUM)fZ5q`A+vCk>dx!TU^oCTZ!(-+?k(JAMBgZnUf0@~inMo`3 z&tk4*J7l1^6l%&UfS=Vf=c-vriQk(dSFG$*(-d-jLAvz>508L%XjyqgDt*`()Ob83zg6bS9>42*|;7+6PBe z=xBE>edr%J-LF(43y)opp10yx;y7_XkPIy{pg``zA$-eUt)uPVJPSbtT;n8y*=W8V7NQB6R8Mk;?MR*vNq%nyvHb1wLE2>a)0 zf{Bf1T(4m@$(?y2jRP~m#E63IxWlQWJgUPjfp1#~OUh@Bx!K~_CSf%DYKWO=?%7QI zE;+HVH0&-D4IeNZSo8oF=m1ixHJyOM;(=@9>zFL=)Bf`YVBuTkTtcF@`i))64h;x6 z^tL4Y2C_~SYp?>%H^3Y;Kx~5CZtwg6P(ZK0jdSxb(6i5e42jPpE;ib)9^Z?Qw`mzF z&b&t_?Kk&n)xMMy2tE0N(;A>$IErPol-q2-&5m&CN*5lD#2mbY>ZL8$+0;y4Rm5v8HxyX*blpqZh#aNFCx(M@I)zc4{ByfvV>yuL(pbLbdT z4D*{%X~nLWv;cb%A1BG_N~4c;uJklT>;K+mk;==>7UfF3-kPDdWCtnhG>i&~$?RxY z^V`;$VNn>{1kw7&GdTZn_s{E~=m7PJQhKV`^PsINFT$F)H+32yer8r)*$vW+Wb~0D zMuR7eS;KHTk56RmLxRoJ_d@-6(x`xx9Ur@mrOlICFbH3R<7V zk?yqL>wZzoGh{QQ`n6+PC4E2zFk(#*sAyn)YafkAM8M4``#>PGR$WYc)v6iMQBGRJ zgnAgqxo~dr$ z8sYo4lZ#VgYwnC3i20{hwU%IMgS8whio+~O6NQ^acri`&kTkJjN;Gw}Emt%+qx3BO z9jT%RoV_aQ<-2f)9;mBTO!@WTJ(G_33xp99Xhg zlp_9{zA2i|TTULgC`A#+AKp`%faY;Ye#*z0-uJTih5)G+-9tO z?&Ct=wupvyZxOvQB_EX7&wqg-L;n?W1=UXOVZapp5&yrckg8OG@5+8o zA85z_h53nI;dL&i;40%1>vgs!+IyG4nnD_sO`Va9r?LX{;2nkm*p$Y&ieMx({Yf)N zUIc*xz`&?Dq4GfMya>0l1eHcA?ZFM1vBph&GasLebPxO9QF%z!JX{a*o3?dxxVXzB z|0xl!CQHmu2KVO6Fc)wsL}nJ<_TCV++D%_WopMH9g@-`rc6f#-jrY?lzSA*4NOZ4vp%VGE<`3N)`?ZD`Fq4UI=4T8DH{hAqBJ!1aMx;O zh3UCgKfmaQrjoG=buY_;w^iNEHJpmTYDY+{#hqG@by_Fs?~DsaooP#YUKS8rEYz&| zJRDm~pZjBlvM@}&b(Kuauv%~J#*)!r`YM>wPV^4K-XKja^84a%VK7%v{MgR&(Y*SS zr^fn~TXVu{0-X+IH`%{G!pi&xsQ@d4x=>qM7$7s2paBq}+9fQgbOA3FT`sJWocw-a zA%+;LEhNoiYZ2(TPV@L2Qw#mcFGP?_#}4lvRuO{N@*EqMmPPZWaaBi?bzimO755So z(7G1x4awPKGVA4gk*oAfB#NdKEQi1NKAqB%OvF!)?HrP_g4t8W^sgh>h``}eH zWQmXBcbL&pcVh+WBcO^Pa;&K*UxckbwMeT|6qw)FGZc$N>NVC}#`Tc6r_TNzAnI?>(K7 zzfeYJUv|TeevJE)U+3d0Omd+1O@CJ-%gNSX1wwzRJ^pA#zyJUWTmhf8X%L?P08ft` zv3|1Af|@MxY{*D&97VfDp&#DL1I;3wUMRgoAmQ2_K{iCeA|aOU3Tmq z>y?nah3$K0tO;E-WidPuBmc%W$rhX7BL)XQk28ZvG(~k<4|z2t0p(2TF#qlxokU=< zt0J5776?9L;FCj`Hf~+L(Dsm?oU(}mI%KMLlku>+6yA9vnqTp)MnSYbTM{14WF(+E z9`6}ro`pryi-8#$l!eDAJ?TTZD;6g<^IY#?HpX_{;u<>_+y zbqUqq>M|$uv}Ra|z;Qz+Y-L`4QA;Y?e#YeB%090Kjy&8SPb(1ElhZr&QKl=a^ITgY z7H!p*wW!x8rGl%-b~}fr5QY%{84VJ<`q=)kr+!9UQkap{%f`1e1O^CXW}ecb0ug$9 zRGjxoB7ZC4PE)b2F+Uha2?$Hi7a3rSjBW;b)>wyRgqj~ zud98Fy3!^4hq7YgDD~cr z{P{Jv6Vdf-CgQDod5TbT0YxQ^bD0^AXS^a1%31J#RG6F2Sb&=7x*DPVGMP~5eC|%w7 z>=9$}5Dt08z&{YXdIou&FP>bSkk^8>2k+2^oUV|vqb^BT{OC~&l(|?(!j$br2~OcH ztO=YJB%VVMRS4X0i9fU%>?BCjS#b5>`*ZXu61jqIWHnUyvGJ@t0F`|hOVDB_aM3|E4Y#IRiGJ1G%}%zud?i?Vx}L)5u39XqGw0ue;I>*O7Q1X!Y` z^F3C4nqU_#GI`!yLmD-kZ7hM)&ijTU+owM3 z+!uu%|5itZk4mMP=xnf5?L%60)8(2%iM{LNkq@PT#h*A-Xp4C4oMmTNj916-WcJ1d zv2rMYo;vflI64O9)h8Zd?KA{WK1wPwya*o>qC`3A5cEM~JI^|~eJjG?Y`c5vTsV&c zlXhiK0TNhnD?Y^(-vz48q&KJ!P&xFzGu)rk6P3tB#`ra9^DfsOYp#-6 zv(Xle2-uU!$MtCp9?Eo0unJK_VjEL-Pcz+AIk>6!cjnD~tKN{^LL^O~OPA~PI#LjQ zBBpi)xj)OvTU3VI{_1=)O~_bY?Wsh~?2%5w)tyw$YCyQ7%ckW}i4wjFm zvgI=>7;7!coZfuiS4Vb+=u(|(dgD;)6}oP0(Hp+0wRYKbj85i?Bm0fi+5X8bCfKeM zOIYRyMPSVJ1vR?Vo!Fc|abP8WIWC_5jAS;!6u`K7g}6gfoW>RLlD-n;k(z?J-$CID zi3b6jV#a0^mjQXl2T;8)H5x+qnYQjgaio*hHk7UdWCZ>c!bL?HWQBc%vS)@qFuMrz zvE){-KPsyJ_#*H@R?P2@P~$W9g{-LoX>T=( z*$@wAB^pyD0oQCMqIw4kV$y|T*pI9LqN?P=!Sy1El|GmZx-yJSsXLh9Q`*++n z1%|ygU;um4YcFES&oZpLT3hmSYzcVtj7RCrj&3a?Dzb^~H1J|4_$BCT>F@cn*+ai@ zKAuxbzB{ZM6LuF2qe*PEha$J?(F(oV$n^(QEve(exqmpJC^9L&IP_ZjitBWBQMJ|4 zU_gn)f3&SA|BMZpuR3^>bFnD{t+MSJs4S*<1wwvK<$YuSY$A?zfkgSz*MBA4*Y0$t zfynATx1RH+jXqYjOeA)tE6dNK8)zC%`SL;!rh`W_x->Q*p@+ujwkX=eGLy${goZ-+ zfo{%McbAGi)fvCuxTBh>@=gi)suMB7ex+Y!yv=T+jrB{2Zu$7#PxIe278cUa8(RJQ z1N7cU0-$eks7Hst(jY>U$$p6w`rIOKJE#3QWO)40QyTChjAmUDKJKaz?M@XqvoDzc zz(*!ZT6+I$U=ytUNZoTR70skP)E+R+8zXjYrIk36;caBn;(!zOPlo|H9DE!%_%n+o zqjmBtUU6sTzxk*`slmRIwO$e9;PV|k7Dc8AOuE{{5|dxo5(xNFhRSMA(9xVT`@?yl zBM#E8Hog(}WS-oN;zf!Cl6lLk*RPpyOehSmvRCw6CMXHDi!8UWq2$TOYRGsa<>PQ& zzFY`1{X#B9oR{ZCnuLmHKlwo@+-c#hmO&Br$i^x1)`sTQ@X2vvF?bp+t7jN!5O-bfCAxg0P(Mq%nni zi*TVUbp;fkS8{MUg!A)GhI`=XLBS*lF=ACyzvNIrKj7sF+sVRnJ+JOE(~l~!fSfrW zKgve{`ijJdV%FF}l1WG^L$*EeU)V4v)kwu^R@>+Ne{Zb7fROEJIBT2=i+A$r@g|!v z#x8KP%2-M>AV(^^hPhmP2Z@MT{L7>Cd0WSjXlf%Afl$3qC{ZXAJU7c!&ugvu{j#(qilB6^E11En5lNFJu-nxG9$SE}{*VATf$ofS z_(TX*4D2g`=iz`%8VP++4Y%L`JB~tRYWmo%nPd(j#|&k;kX^(wFz|&N0S7i6l9@2I zhgGs$?n@q8*dpW5X$L-y13p@3IJl%ECKDceyoCn2+gS=JgZ~K!mp|nMX)g{$@X$Z> zc+Xo|eT56yCf|ZI)dFjTh=_@ag*A!2ZF$VL z@rV)wCNfAV$5I?vV|b`G6LpU2k9Mq%sE_VgbA0Nk!MQ_NP=aK4P?dv@pMHt52l_V?CQwzMBy+Zz3ZRb}004$3F4bIMB) zVYX-UQ25EQ-e(=Ba z6XvtFSzsY)QYjMm2%@qPjI7t{g4^YyaYl*aa|#Zt@mt76AR6izKM{?<30$w}x(o9nHoPXUvo$&Yg3QljuKWpj3wnByH-igQ z0k*97hSM~oFYkYWzW}^4BWU^FziRD-z#6_dG5uHDa($HOl56q09oN^$CJBFPb3ANU z(0|K*GvXh6T{-@w()OF|ie)#4Lf@jthm zPEmwsnnmkbg|^VO%*mvGr~Bmfi!q*aqI=?#8Zr!dCA@~;UJ7d&(RFM5zXvSdebT~>g&7zm486jL1hAU) zG;K442lcB3Nn(2L5_$e>9eW=-z|#$9OOWR?4JOcN{my9sM~{z;WZ z;Lt^f_kd1>zEzIPlC9Uw5Rf`ayj45<+26LSx!y%!zCX>%2TmVs^CPcg|@UmZrpzx58t*^{2N@}fFuoP+AG)d&y zw02L@XFt8?vxV9TK#a-~FA>nJy3P(fk!cOQE0VZ@-n%}-Kd)@W{1Fly2GD^?r~7*=aQ9f2EomkxF^cBhD#Pkhtu0`15aA>rCz1j z+fq&i7c$2Wk}Kiu(zdpij{F9cD8UTfxZ6pf72fw_Tq|BjA~>2Y&v{M-i#$+%y=u5Z z*9ht{eRFDXy|INz#JaP{k@nfq3XR;C2KGIL;ef4#E1XQ4G$af24>z!rx<17iiKN7idQ$fZ} zdg&z?NQ92gaDWP+ZiLXz(tRAho=`@TPHx-5>m?ur}6KP z5ZJsT)_jC(z^z&toOsgXi13vq{f9?==XtIh_|PBgS}2lw26K(|F`H#2_4ajcGXb=! z%mq|Be3~atCI%W0j(nn}V{37L+DIcOQ!4V_$26p^@){~fXfLt7m;D}rj?c$D^kMgv z+u47`5|}1CNgZJwBm}_)xkEM&*kNCcWz)3rA-d{IWxov2xTOM>KB?G#x8^h5&*>@a9iL={wzMzwD*gQ-wB21l_0|6rHO`HH z*X~mqU5lwDIrD$|$QmU$zy^(j$wwZI(>|{GI$!zI>|;_ldxeimt*#n#!Fdb2g&{vph=^%BKG8`b>Bv3J3L9ux+g50MmedDicS8<+5JyfT1q1x>9 zc9lw-ly#H9_%=y;UT2$79$7W#Q`(XYgmXoaQlStUi*-d&Yl?wm^cJIfZP2D53oKT% z4_J}Vr*(#+XjSeZ3kB2-RrJ;QS}RfcPG$B)bH43Smg=6-BzR{W{l%Vuu>QmKnW&?7 zho@8vHF{-mVV&Sc9wz+yU7B3t-Y#{TYo?mC-b}i(O4P)7*M|;SxuJ%N1i6@^3R1in zP||G0UzYiS&kGwoGV=c~HqU|F*S{xsAXo^Idysmp)6Uy=f8eZbX%X`}1<}aWP*vwy zjs0pwm9Z#JrKneXHHveJ%7)ID(_1YH-$=({H>gnLrK&@|{Wg*engD>uk%bf}9;1L? zGA#-@u&xVfd#-C4?=0h6-gO?k3Moib31ZTSdGEG^*iM1JdAh?sJ9Ty`a?<)G5wS*x zwbu7BHqEHezdv)O$7XcX3U)00mA7z2CQ-nVttoD;z!s>f;AxK7sJ=4epgy7n%VY~% z$-nEW_OU;+&9qfG$5SO|+py_Z9l!ixr0ZV=njS=nCTo)xXTc@Wp*aeyi≶{dx&Z zgTl(XSK}vm7Y9;Vd@)rsx~(gd@wAdcovRpnznG5QCWQtMZ^pvF9~CBCXVI6qPA1-X zGCTXw{ffuq9!UiO=|man3-Nr5=nWT)W#-35TK4Ce*m)rMlmM!{RmYXL$(Er)(pnA5 zu=bQVSp<#D+H<7iViB;k!%Z7*#4q;1$Z(@E;{{kB6zqddVw{=3E5|~vCp_V+1c}vL zHj{6LORm@4;4=4Y4!@iZ!CLixVX19;W7}7E(!Yk%s=nd5+SoZMTYx;DTJHs){L2hc+83LUc z1j?*ySaK>g-fN)>IBiZflE4$013<2yR^@}IiJ8zfP|!sDe-G;2w(IP2J``0$KSu@DS-; zalhp(94`#u06T!}WTGH1>pOSJA+mff@_-!N>K;5acH~5_7ztUDJ^}SXgp>MkPrloh zLP63zZ|DYW{7)Up%^AT&lx;C=SQ&i;9Rx=tL(eWPev8#vA<9{L(3RGzUfW^e3s^y`i5`001(3L7Tia2ra2Hm;^Wf z{;E{~01rkmSf-VL1S55yITgGMIsY*z4E{59rljV6nt0$UVlG*hp9?;4+A04<5CL{B z8GX<6%g(DaMLTf^{(BRM(WiPwm+i@WN8Q_Ug{Xc<3bNBQ25;?p{psgA*|mCg62D70 z!)>MR;on)>F)hna{=MrLlvmM9efN{pu&WeBvQq!SiswV}vbnKt%zOKX%KT@fy0G4Z zG!qr3S)VcZBxbRlA25*OXRBpt=bCt*+)YHd>uq5K=i9#Fk4>hYU@gNa`rY0q<=TSx z+;p}i>-Dp()CF{E+|aPGUh57_Xu^s+Q^FV1o8M`OH`3x$gN&C*yKvPXd(T)C&$0h_U^56U6mGfN5qK@ zrTcd{4%$;!K^%AZLmiCulDu|o@N))vB2DBAG1cqu=&&1V2z=~HI@u9)8qyls07s^m zrzM*3AL|6@aEGggQab!zzdoW&3j#*0*t_4EaJ5v11p{HpO3m*3VH`4SNOzQs)stI# z=}Sv;!WP_y!f9AsogVkGYd)f>Rjs2eG0Dyggzfps`cnUrriqE8f)+7_OqLS>Bc72$ zhNz_X??I_))wbX6TkiIj4cXSaaOr@H*lb9j->|3%9%QgJ79m!yiFnGrvqi3)hnFkD zKj1+ZZjRmQBvG+agFBhvEb*uA2XGq>6-klmC!XPkQj)9MJ{zOLFH;PZ7thQ-nKSdE&` zx?w;w{h|j4LWZDb;jOTdKCKw-goUpQ_@1h|4z3_`0FfCzqWhN*?aqc(EQQh%J5pLJ zrp$)>x{9RbV6Qe$TYRo9z*sMtjHw+4!d(k-CFHCjvXe2Pz)h+L*B6P`JW?F_89En_ z$FVhv2%|lnV&5<6R(MF->;B2DYT0TiVp9s)36D0U-Q&f-2@V7r*IbHJ_IitvFOQC4 z6>`X+m*4SyjoA1QK+p8&t!$SrzK$)_79H5QkR6KDkjr>uxm7MSFvkfZUjjr*3>exq zR`VB1*igzUs-?#-JWz*2T)Qfns0f1xRvpv(30OD+bvMvPJEIC zD)7%K0Qk~O;Oiij+UmIYbCWirp))%epo_9TEK1CDuNDU3OZE+);NCJn(Xuz@;D=X% z*d=KEsR7MqA(?5~7PhvIcW+DZF<~KGgorX_LH>dRfA18noW62mioQy>>poE}A>T6~ z_uIsKC9HYFCg7WsU0*>D;V*6Zj--k;9}BL2`DMQi}sbyJmPd>gMJNT0Fp7| z&)8pcIqQ|TG5{R9;|nS%E*nH|?Yu1~{D_juAtg9Jvwwf?*B^6t02}ThVQQJ{?<^^- z4vJ3dMJ`arOvt%!WD-cy2COX7q66@E@B0(hmDF6t>r!kgxapj=Ng_4!InF4X|A5Zy zLBzmm_&uxe&l>~*3-sAl0c>xKyuCOtFyNvv33w#Dc~nhDsBMuG3#Cew;7AR~Y#KAP z$*@!}Vo9~x+~;`%zOnSo@A`lOM4|d5^8vzf5o(X!!SLFNFq1LX1Z%e)EUSi5s!8}w zXk+-LI2Vn_O6=OBw#_ia5EKg5>B>5X3Yx+~l@g@l7ZrI*O;gY|)k`SEcYhR}TQ}YI zCIadaf9+R)@P^)``Wp>$;4NptefN5jY@+Q+gv+-;5pQ1!E;jOHRjPIy`^A#1A~;$f z+LFliPEYrm!@?gc-Ui{?_q{{S>vvA?@jec6<~J3S)4Qs((0pF7Ij=x zf*{wCIjFKvCaLHBXZ=oz`p8f+N*%yqArDtaBA4}z&;N@fM6_&tR z)O`@hQnQR7HN^OELy;_h52i?+sjvU`l+|;ZMYO_zQ`q)MKmY7+0qM2i=WR`Z`IAr% zR@X&Sr2%6x!QhkZ=fo7e{Z65dQBK2Zq9>|($==O3N|Qr8*VV1&vImwG7xx4YoISH` z_Z`LH9t@%uACu@o$3Cwo3}G8SXAYsGCO%1AIaMySi(6dO%NG>iwSc_ve-D9j1>rfn z{S7Sj)i^Kq<2?Ss$`)z_zX?zcAZ5xMT5^3;w^NMe ztUzd!;dHn=@~j)PTPwWy9vYrbEc@WLIVDYwDH;fMUR^pk|F7UgLODyoNC#Y3v^j99 z+ufuoS9e|xL{Xva?qgG%_j^ru&9LN##IM2hs>7;4hO;CsN5m+w_wD7$)IoPMtd(V^ z+`r++Am|E0JlSHx{XV~jDIL=57u*H2)A^$W^bBE&Ne+@qKcfN8B${## ziBA4MFV)ohok>Q*$TVL1_jL%wjS@A)s`^u>G|#x^@(pkH>p4n#&)5GlH0uB6$0#Rsm07%afmntG2#;&>xhWZ}bv(2f(Ohn>PgRRG3_ozM8uhss;tgj%fTzEJqZlBp8{6G}2Wt8@;HV=Jcs( zK`$$Yvn-BsMETvQ>3ap{tUgQ4EsyHpY3cT6ibG%}U1%<(SEM%%H6DFW-%y?Ie^~6V zB>pBjo`QzGBu>F(V7RsN%uCKc(4zRzr5OdXf(Asp#o&SP$|>-(MMSVW&sD6aaRfYyWRWH3GN;p48tN*S@1LLN7GXJG3{iBtyMy#^7Cuc$^+tF^*3z+x+4kL&(o9ekXCm4nD~ zX(yCxa3D$>RuW;XO0-T<;Y^6Xm(y_+DhsO5dVN3lXlefX zqIfOBx$JyI=vy%Y6(a|^rS-YVyAu&K{AEi$>JJr}lmHn|cxRz1Wdzk5odw=Gd#I`X z-cAG|nblPA476o3t=^UvX&tqz;jTXKS2OJ*xDMrgsHTDYF6)8FRu2vp2)>a}7?w*rD_~V91Rlv#QeiTKCrwF>7~;EUr}R z4aUg!l0j@g&;=fK05oWDAUW2~t&h^PK&CV?>iXoT9y9;jZXvIZt8U}78Q@#PywPta z7W{o2Ad^d&3qrFbWMBNqo~Mnu6DI5>`<1!i_9d~K7sC5~16^6g+%t}1Pj|Zro-3{f zYmb|2HTSAAy!)QGehegkFkGr$dMcrZejZl5@{nI1Y+1_&^qL_abEYsxeXhX9tYPTf zD%%QJr$JW)J!x~6;hJ{UQ~sB-(}}pEZpqYlt5+G1{`e{;8o&6@ZFW}lazi{OWsJ+| zR}`vpgG;47ap|+ukf;eEBkh*H^i8+2q_tKOq82fxR`8=Fb~Dr^bNyMRl@6B^JrK@$ zjz}Aq(UUt{voBSX5g&p)T~BclFBDNm_jLGI%3%S#Iu zWIq5~hsz5W9Cxj8gfp?lv_w~jA0sj!hFYTFCE}Ng7dIIcLWhidSCoN7@VpP0$cxb0 zE;v^7iCmi|<{W>*fFW&jGANF`&@UDP8RuNo(Aqp|MHO;fo%gZ?XtsK3h9b~8@wvjz z0Cv!^(}?6a;%LWgX~E8eufCQfvo_*M1_Qf6b^-NYe#|bq37I?`6||NmzB6nmL1-B$ zr!Yb5KeaibBF7K-D&xTv`Wn@6Le(KN?aB~9`Ew7!gCG5=B`dsGZkVYoAJECj)m_rB zhREJjt1%cnRieV{kbSkCsTKTOcgD7{mB@y9oyaO06j1z=Sct<})YcrvCF+Ru!vzd1 zR`iAj7GF@S6nA&|p>_>4PqC^-*MZZCR7=JIg}oLyELZJEAnQR#9ts%Rzd>M^XP-z1 ziO=|`amg$8OAEwb{UdsJe#G-<1=R(PG){h>+0`9|{qZ*9v4*CC>0TJ}7qQ20VdzpO&W1-If#c)WF_9ujYgII z6%Z#gBd|IyhYryPnp)D*7XfYRND>E>(t8m_o`fi*LydWjI@zg%<`wE^UpfXXrs0}I zu-iOPV~!*lIQIDl1|<~VJGNn?|IAqUJ?){-$9%6mvT4|N^H|({2y5=Y{oC-(wd9f=n_Mb=0FPi3ed7(l!xK~-&6GnDPP*m)D_Jz# z#*>ANUF@Xk5gM5Iir%HGaEsWIsl(p5EcI@fg{YPcpl_ubfYIcRkgA3aWp23Fur;*W)`(G*W-kbBue`glV6_XWss9 zoaWO7s9Vtld6n30{O4(Dd-5x@r&9#%Y7>BYW0sjU4KZ9wT3hV!~kDj#1 zFp|x^Rzu-x1JG3O-~QXVen#EU5-6T)qNr9O`w90|Cm_SzTrR-mHG*xth#yJYpmr|R zv}~_Bs_oOJ&er*hexI$K)E>;L;u>A8BIX2&hkWLPSP-U#2jOO5mX2!ZVXx}54fr7v(2>r||V#xc%&#=9dz zt#P22o09cKDy5#GI+DLiDAwR4bPecGfhjg^Pn;_eN11)nOfW;tc_}w&tEk#BiM966 z8pFHm7Z)RH>ekgKVx*nBQ?w{sLI95E5~w`|pPz>UgntiR*F05!v($4~7Dt_rPZJNx ztE)H=;yY`WvwAW5TR&E(p_lNM=3e>DQag1EA>ZTA??p?+!wLBJEg8j)3oFX+(O?J& zKyf)!m~t^c-Lg>gC({l3)tBepAG~x7Ec9{>J{6eiO;9d&AxMq>7gCaoe)QJTX%R27 zHy|TV-Ded9RT^WQLM2u({Kf;4_$47&$dRsP1A#_sfZL`F9dUnVc@jN2V_(ZFpyx?c zK`D=T$Q!*#C^6i??-rffa?lsic^f_Ox)TD9sWm|-ZEM8C*td0^{NC538*7MmWi_#O zK5J^^NfY@_WWS#TwGfypX2fv&*|xgSI?ckXLM{jj3J33|Qrm`Md4S_` zKi<=b12~JNs`n~cvLZB;XoKbpuB9Hx;IU$8`i~Gz-E)st?1G$~BYSa-Bq=vn=|egu zOGv`H>)MnLtG-D)DfOVBVRF$DN@%Q^Ja$)mZ%`e!xp+8i#@tkCgJ{{1_R@TXKQ4IU zv?Cpc)P$d=OM`-3;XzbA($}~F6(hZ0}Yva1RU4c1?E{7Lnhdbp{q@75S_nyCB&1auKp;l zMo_Jq}Ek_J@dnlc4}x+iF{O67vhOJ8s!tENo#RU*=P6Bk}VNS$y%k;y2H zwQk}ukqtrk&=$|$|E&Ub5tGT%y2ZeS?E2-A`@8(}TV~69d-68#_uS@*WDJHo-T%GI z4+Pnuy}8PyAGF$%U&CCz37#g_;g5Iolt{`U$GwwuvB5v*tlfxezkh-DF+2KAtz=#D zExUM)gzk?YPt)g8Z~_8y930QGg%9m&p;y6vfnEg2CsZ62|A`_r&Hq!4$o!JaJibGw z_gFd)fg4B^GUTrTxhH)8B4gT_DJu2FWFEL?!A4c0sG8wd(b+Hgh*sl+xe2AGJQK1e zD;kt*d4I#k%6lP?)lJ+Kn~npG0|nFZt!J|9rk?^(!tV6vzYzT_LlbWwLcVg5=cQM* zk`YAY1)0$i#Pd4mhJJT=?I2kA(8B^a);)f0FgP#^4y2ff-<7Q-ws3XVhByuC zF=|J$U;rV+?*5rY%=0lZ^pG7-IFT~Qww$U~+u=JBET;qo^`C7QLVX}bR*8|4yhD8sVC)7q~*ll{y{B^&` zfo@y;(GdD;jRV$E>NmQKwR55PnaZU>EhcNOZ_$aJblQ2=JWC%6V&Yzl2WX!L#oSb`tvColemB%Zmlg+2dh zGWnYPhj9iaX?)Jr!Jp0Wg^G8oo8n(@xI#fWivSE+^KY450=hw7Khr$kB}c^Z7(kcG zsqCzqRs8mQ@+aZ5!WsbD_hpzRlSq_LY18_?X_^~aTyv0|Yz*8;DvDO3`>vtR@f6s? zjObjyH}$Wz3R1FJ@_*Wj3TuI zoV+;M`@>+>x^au?BRI)cWv$E@*?NA|&)*y9h$G$N)&OHtYQutaS?pZ|RoN!W#;kit zaZSAVShO5VLePbE8|*2-c0EZJ>=lynG|l$<5O3r)B@(AKm9>7Ast#B9C`BDB!mFe) zft~iO<4aAs`=f;G&Ybb!7J~V!_CPuX-gH8WbK--QcPm)fvkyBLNFuYPN7|M5v){(! zcI*L>AN~Ik>HZjkSxW2W69e7_MYiJZ;13c>tW!2s@A)RDtNTGG^-E#{;Pee`C|Ib2 zmMrU92zLOgMTr=_(%%>~8oNFhf_{-BO64UL5!Rqta7KCA2SNp|JardcIyKXJMty=7 zIW2=ljHXO#eY}5YYa6~>1(-OjY%O59F?z=P4pj0Bn*Ee34OhB{!yh;e;lFZrg%i&6 z81I>8p29#=y0Xsw1(OdYJ$g2)*XG9><-eSAE((*;L|CU}U4}HuUF8(8YWvD`&FFJ2 zQ_CZ#a7P1)iV!ILmD+(k+E&nF0vuDk_fL-et?B3}P|yQzCRl7a~OMh`O6x?1Kc0vG_ibO3DYC+f0cDfk-BV z9ox*0>DvmV)}rAPUel#5eKT(Ck9?a)(Wp*N8#0a?8pztRoF4V-QCbfD*^O~WDf?}D zK}2MlbMY7W=3RUm7t92h2N)~=q;q6TAy3Ze0%jlF*FlRj!0A0*%RF;m8*ff$S~$DU zMDU))r5&i~;kG>T;GChi)@4^yD&%=}-X%)?LBGEciKshTI+%zr%Tbs=`v@oa0Wste zNx{4~d_~*`tE;PBbicIR|DkXPnFka*@J!MmtR?;(!9Wb=!hO5uxEuNt0*eeRb{*M= z_8@Ng{@eyii?8go!(L!YpOTC5%?na`pI%E%8Auj_f>X5-LW~Ejz7TIFTvJI7s2dy%z8GhX$5C-x4Q}UxdzTV$qP~JCS zVT~)FA-9B2Y-%4bPdEiOa3sx%yky<|x&6C%I^jTIe8LlkL(1H3Psbe}Up`ZnOR>!P zAs`Y-4=oQ)ufYIFhF`t)eEc^YHbE^}B6tFnMciWuQU`!3WOX<(i_Zv9_?cOjhlKAR z`O}Xj`|@+-3gY>3d7dG#q%JgcBB34kxS{iKTkK$=&C1`q)d&`z>8r(mx5!%e%pUdB z){R4Dz@P^Y!%PeDyjI=gF37M*M)u>e4&yBp=QE8U5LwaknMGVByd`IAG2leqIcM~4 z=Cz74mR7VThaDM#+t~g~k6FmopGtJ(&cgm*G&NPoTIL_(98=AOq%~#fA$Kix!NQvb z?JH->Q5bH|h>dy|Qc5IU4DD_|m#7DHf22uJ0#1TumuyGTMxgyReFR1ErzWH@qJ|$u zr;K7MmBpSY#8W;dqA46+)?UcRGgVOOdI1Es7lw{#Oxdh|F}6)7k0>c;DwOe_OfU8j zTuIdT2F_rJqZ3LjtPN7wKn8H&hk$dF7-sLC&T=&F%xv?{h#Lxzq_w)b1`L+=a;;NysnazhW`L=q!>NZo@*);Tb zp;>s?u{l_JeDLLP1NXoW|Jhf#wCIR+=n8Oh%mr{6nqnr*kY*4(xIEbC>DGHb1Qj-V zJ$9ik3r`>In@LtUz>7o46h3vg$)T^YJIPoNJ~!#Aa;F2*@!85Y#w!E zI>HIX6`@X|v>d*^{s8RFfOpeQ0NP;)`K`zY%W5;Ui6ZPCPQ;bsEe+vn7_rKuSLM?m zR6d~o6=k3W!HvtPD$aon?+yg1&Z{Sih6KZtuxbfnYBq$k1)n;CW_U9Uz9mSs8Ko;w zjQUdFLU+y{?fGnp_;jbMK+Z%*Udpbg;81u^f-SdZWe(raSX+U66IBVTN1BqwW)+4rD(MT@ zRvf}x3NUG9U_t)bU^fE=nZg553tp?qE8VaNz&z`o-!T#6@A7_R-N z8!_|%MCvHfp!#uAEkscZsP-*lCB;KYqe7R&v3O}HDtu=I^smuDoZ+Gr$;T)Ax&uo{bgOE??O=9W! zI9gy|AG|DQHh&@kJ^bU^lt)2Cvp7LbFaK>QBXS?(W$eM2yth8uZ% zfx5@FRN~nns_O$sT)th{W)(~2be~-s+Yk{{3z2HmD93Gf7=S-FdPm(jWP$R&*)xA0 zV0-HJjXbhYw+vSNNB9Zq%H0G|`p3%Y=X4q+g5G($j>8LB^K^O3?)An|BQ`_kRYGEk z>^tN-0M@fr{+*Hjaoy!b%7STG&er0X1P!3NQ&y^}SF??ZGLt5qTnwWjG*B@aP(ImT zBO2G2kP!zg5$SHiEGy1*75AB`N!?Z)x&)08o)MzPv>e|GHq_1W{*ydsn=h&Y#s3Qt0dRAE1?+`{r-3JYzV+9%TUjkkpaxTgM39(IY)q9W@ zMP-Mu^z*#F0BAs$zd~Y#mg$K~VLbH!MMdeObx)%fo%wgGAE;y+JkU@Bq9`y!KUqy5ypJ%Ub@mb3)+OCASP9}>vj-dw?QiOX-L!bcqm|hUcM}Gz0^J+iq|!<=Um!#Na9Il_^V@qq;?xR@>Hf z-Z1(p!d>%E@;7sd6hsnP0I!hVf9i)GBFcK$TbNFV9Zjq)Na4NwZkvSC3%MBSe}Ev< z5dE4`Vabf}g8EYxX$Cxh@|)73hYaI+J(0s%UXo=h3x2_5vNj)Gv;cv5DOX&U+0^B; zy17QnzGxxgVdE|9M3Nyw;qjkuMc6?JQ!)q>wGR-bb(_qKp5YW0J9_&tthhSH;^d&^ z8!Y)fej>mYm{weArGB+-ank2deA+`NY+3IMVpD5}Y@yW?Lo zm)FBwXO-<>&|ohk#%#FEW*^zgEH;Alrkbd_Ioct5;->nAc(@OfOzy533We(jPceU7 za=kkSy^nMhBUQwNzmBoCl%P#vuu8BQ8M*Cp!o`zohb|heZ39#(q0_(x@>&S}@7(+0 z%tEd%h{A#eVl>2%_v%X;7L_pAC&%)9@`bxED%F&Q=$ggQ3h()2eRN4j&j zUgK!Ox=~!qt6n0z!POLLI=t-wTog(Ixz*o;@)bRQaSn2gH$!U4=Pdb~>QDO7!mW=N zRdBwK#4iBZF2x-p*STy9G)y90>O|jFGEqN+dM|f{P{KO9UlVe9k7Yt@q!}vaO1ex7 z{<*lwB0I33Tf7DVAyZgmhi5n~@9e9c7klyH2qw!T_djM87Oo1Q2E5>t__}QYhe}DRqungkIXJk}KT~2c zP2YxzVPI|oOO-f78ktD*x7oy1-@yvk<=Q{kRj3a^JOF4zHhH){NvV%!P+JO!EHG>F z7j)lF)7Q&!P)VW#(Kn+nTBxD;DiC%5mIu$r5I8Qh#$*Lun|)@BZI6W4Lze>g@vMAZ zugQ`EbvEejL0p{HnQMO!bsFI5Y&L)e;$WS9zg2{l=e5Zj@)w`1+C14*z(Xr22pZ6( zTGtHu=+Ip=Vf>qR5HlHHJLET*o2N}eGQ$$Eol&i#QNiMHit}sFE=9Vyl6zvpm&r6k zF)7>GukIe~f8xOJ%#I;<%O(Uaf*Rl|bN>O$(t=l{%jYg9Q@W>ML6vjst_iakz^z^H zZne6T%{|EL-YHx*D@e(=8fdC5xky9LY_PCP@_AiYu#_*CS&Urrfr^LC|3Zz>vH_b@ zHCW|f8+Ur7F4OIj<(VuO=R)>`mR>H%zWNs4Kv48e{#rzUDVhepl}H7g3))y@MgEj= z7g*ZKFA!iX@zOSBzJJk@0%c?F~XJRIgo{tl*0ZJfMePdn09C<+3zJg6y& z5(p~!ozM~E``WF%`ATsx*LNF%$^br*wi^ZK=u3!-bcz5)PxvdPm%U2C`H& ze|9cTy)%tI@#b$}By7skhjtLiE4uvisr*CSIfbT}2JF)eCrW-y(-pQPU#(u~wzk%f za2xnQ;VuiAPMlU|(9N}G8Lrl;m=8!QcZS*Byd=xmJSG?Z45J;)#t?Vw^F+ALM^i^v zzPC#l{bwn*{4$l?)#B+WV;E6SWWL*F!Q}i_oLLH#KvSElF8ST$6c9z71#a;doKD=m zggnaVQ)k*Rvyd_p$xjbp(mQ{oux^^G+L$Zdj4N5Vc@45c(T!)AqH|)&R(r*n58iX; z`4?rKaNKMu4&eU+Z_z35B8T$^!S|*9cG{_}>Uvqol-cjz4oRb6V=07r7nc!lf+f)z zyW@W;rimXOum-e<^zw_+aG=2aMiKvMStk6h8t~ny`^Wk1d97;BMjhEjrGCttTQw+-nsF2{t5$HKR`=l%a5vyfu&17wOTzVPGhlGsum9vU zfGa4O=mKr!S!$+LKKRZtwBG8I-RvLhAR0}LrGDw>S|MPOX{i?vl%nvhu?S|dBjgO1 z@+)|o`%-^obIL&&?YWXnzj zB%pkHc9fhJ4*S2%WTieJAuE>JY}WHnK2M9!)okT}U2yi?_BrfKQB_k@f5T7v_glna z2<+?HmM;5CKVe}jH%K$BusR6H`m6OJaN^VIRD6d}y4YM%rL&>GRhia?WIC-pRg3bI z&<|w$GIsA$jBSqk5N2jbaP#|;Or{vt^czQlzm$Yj@+&pN-c$o|*QtRXIcpaSV`?xA zL<84;vXIq`y~5zk?r|3MpqclU6987jXG=&ftmbW@_0j&k{9c27E%F*Pb98m26pHrFaNj zT22&)U8ZO_{alZM;XhiDTXWs3kEj-*$ban6=xLezc~yW8zRHEWSPACrAqg^2n|E>| zKl)xgju9Bas=o0Y>yI7B=3zk<7;lFH?eR2%6|Cjn>q9CU<25SD%wC-DRmkvI+RbCR zUuH_!#*w-@}>7y5ZA>=zTv_B752y$jKJ+YoM%y!|LcB%podWQoQ z0i*$kgC7#2;@ccY2)PJ1j!JV8IJ7tn+WP17BDkXNFfHuN3)LCQmZ93mr)z9#Qw;E# z*)n}WWKiX?bK;aV&T>e_Dy*`Lvp2^@iWn#aE_+_U)BRE6OwVM_yi@dL~jifP!}&o@6?N1GC8H2MswzvrXW5we9;;iE-tNtCfd}9*FZoXsfbaaFp9-Qn<3k#G7M#^{gd^j^7UUUy z%Ax%}bcxN;Sxxx`bA)#WLU9LiRdS-FKvTPC4#mFhiwzQszH2mO*6!&$fMK)4QK$8A zSUbkEKK9%#Fg+qts*D5W@6NTXJ$9E$J&*gSu21qx!2|8d{-3jFYy~zjz#9x>(TtPX z(>3XKEJUIOAV;k4w&Q*+&5=8n=aeZy4(BNH4#*A4g+c5;iTlw9B_S=nR9KO9q1#bMd!_tn!+*D@B^)vgnHh2gWjGjGa%Kuq(@(&0Sj77TW z;&aRkO`i@hH?J58labRn5KK1Hn;MNJd|q*2muB+TKM<^I<83>q+f*R3A)jA%pzdm% zwSlGWQ4|Z#I^u|1E}23UxO7XZ-=!`SxSC0^Z9sY4rzFp>8auy+H~cZ=1mD>98t&s1 z+HpxF?ZfmLN|XQQp!GAn!3+J!|0(m@{=OqY(fNy*|BW-f3%)KuFBTqp1&Etuc0L)B zHtPoGt1QwDe_souEuK5aAou4IthRg4Lw_3n&MTw@S{z)hVLLCA9L~z2+KW*wioaO& z^h2yg5%xnWd`MZFBeBR`%~o?zbg)2y*2s}{f!wnIVs0_tbidTGWa!G9FdSH2zk|%T zh&Ba`Khr+}um*=n7%msZgHNdA>?{PBgbh%bBI!^4Nm+J~(CgN@OY(Off<!8m%KKt3_Z>9z5&mUqpRd-l%V&==5)HqN3V!@h@=$^*s7FHoDgqbc zTdP1e03-kA#QObm&WH}kz&9nU#2+smZ@(nlIx6zbcw~x)8uuL^w13+g zr5S=xl0c^C=J;mrrtfoMnX0e5000t`L7&=Wltf%B{{R48CJEG&I3-=7$1{9>VCyL> zDqJSK46+Rs&Z0QO@ESh1$0QPUSRLo^adRY{PREtw#=%#Ct5)yXeWj1<{1>0s0c0l_ z@B}gNX^weZ9Csa`34-m{ zz8Y14Q@C+9)L9)ih68bhzQ^Z2CeOpfC$6h1=xNrXhl9ReTBG4a3-$DmZo!?7&3-r1 zeE1~;!4cvOj<5!cTO3e%P6EP$Txdakvxc*i#(P0ekuBM`?G2D&n9Iq@6@Ha|AYx+A zVcJzY&~}#g?&LU^=124l`^4O@vm#-JySWaNLBY@)ggpesDWd`hW1i@YT#OHz!mQZ8 zu&kYCcWmZOSKN#++KibIU?6xi!JDlEa|-Bi!_|c!^tV#2AX0d=c}YcPy0ST1ZW0_9 z1k=PHq;ouG@CGIoJjBfnm~bcfHhKdn7nR|G2D~>r?KB9YnO_>i(?bYrE=5ishAW8A z|E>flQcOlj&pLs5b;|qyepCmdE%9ib5Ayj_=Zxl!P|%5$2*y9Vs*-s_E1Zj%IuEDp zDK`pG;PVLEwO6;&nJ|JXV=$o(U$`RA8=b}eki3@;hiCu<>ZZ(lhKb-hTUJ%Miyr1G z>eqHkU`z94)F+*vj;L~{2>ja>RIJHNk{;@3$a!CEEop2J#}#1`g=H8sE)~< zc^WOijUBhqclJ96KLmY~yz%83_J5DAG+8~_d968XEhhZk#sDb-9fB-9IrQ&Apg@-u<2jmRRI!ssC>WM`nL{GFnjwE1akeJ;f! zmd93kSS3vbj&pEem&vI0D5^3RaUQ@@5NWm=hMS3X41UymonM6_Yb|7gVdutp|cCf(4Fe$Aw65Uz6MvIwBr||&R7$B zh*6?iAA<*N$Bu3z%S=_GGTnOKmNj>b;XdFh zQjI<+&7t}ZXX?gN=i+2tqg_Yh#pp|RM$ADEjhf2$)VZAf4wek zX6az|jvs_x*qG#D=1}o2INC8-6pgAd?7kl0RnqljaT)TH($0R#eLfLv$#?%~n*Z zA#D#bxs3B|&6F!^=5?$<_~y@Exg;Eim#Ea*i><97l!X=ZOPH3_&%L|6;V77a4p%eh zc-)XUeBN^Z6^mz@gT1A&^j&?J*qkz&hQ9?Fg-5=Wd4;MkT2N7-`vZZ+7SNemO0g+iesAt z54A)X0qLS#xQ~z^&U?`Y1EMUF<&CcSUyUyg(j-F}V)fEaE4!x||0TrQOeObne0?Bqmq%Z>wjU1&D!D?LuC+_gr98ENDhHVKyA zU;LV9cQNE8SZ5|@btO2jDF?iG_SZN?{^@S~ZQef8Nf!sGdTKl-NT96%e$!x2Nszkp zig#BdlSX06_~9a##Z)IWRf&@`ddpG+J-O~Cy7hQ-BY=Ij>qpZHev02-fzVhN^o5zB zg|p&fF+qP}*%8k#BMmE8^1rHwQebKAYlsc6=hhzmdc+5#h`*$sueW*Cgdp46@}1B> zs-nVuqt`IIy_38ht-9`AVA-rTyaX2nWt4-9%%Xk6Am^GZ@OX2cSweZry3);9K11t!2c6 zjFj^bmLkd~MXCBrSb#Aj=qFx<4wpBpy}6m>lwR+e*Q(2d0!n?H;`>g9}y5KvEZ56s=tVj>)Y z)ToCvnu&<{&$HW>sUG$68i-gk`39%gPl_IY^{IcXsW>!=PqE1@7a0pY4G|RYuj*A7)xE0%my6kR~frBOutI#3dCq@gI!yJ;B?OXx zchXS>2+M5v9Y+7Ee3UYNPkVN9g}n9LKkTpBlE%ubG!#0cl#BTGao5?z=!z&=AAmjE z<(n*FqpH(6t@8hwtcMOz)e6*k`@^>vUlO%A%W1@t%E{-tTar$bd)i!qt&VUq?#ZOI zPeZjq*g!<=V;Z#fv)l;ZR-)|H?M#az1dN`1GChFCZ3@8{AjtATinlUI@sjA)>Hy-i z8tQ(Vfe7eqFACr2ENhSn?5%5&8kh6&|C5rQDb?{LJB-|+8UQ&Rk|}BUZ~&Hz6IQte z5j|asS{l2wj!7ek%X-#Czu${P1aDEO9Gea4x&2bR6+5L9Cz|tvhLfPZfmrx zAXh4ALm<3#nxEsK&tzMwk9HsdWBMl_B1i|tWY*e!`1QfrT;%Bg56wVecOq_gb{>Y^ z-!cL0l-`yqySeG@ErBep)n9hp(-qBuv2|*Zu7E@(TJ~l zzV%uIGIp3l{%}I^^8eC5?j#}=rOh> z_R?feP1TVO7q3`>lr_XlVHd^{mTJFOH0mLJ0s-*!p67u8lSreud|FCzYozRyl zd^zLd)GQ4t>{pzi*o-dXxuZzypyVlUo}0-ThVsgMSxOAlTLUa?;|f3TlH%Z9?q;G9 zo_Qz4G-{ptZ1t71XaExd0t?Xx_Sc|B8J@}Aceq$v>VfFh(`G9*WZm1`t=2U_1Sd`s zehb{zM}H;jN68Hi68~5i&0x9yHn@*kDAc~BDVP8`@!!NX8sJ(fUyjbx74kd8KBs!~yeCQh z67&6m?RxJad`?~yWX8ZDdLU|?D};UaJA<9e(TT^G`CqgU{^hxtJfP*YRVz|-?@J`Z zD=x$F_kxRiKCu?ibdC6b!mi|S{K9X7mai`$kQ8&5U_}*<-?hch+l~6U2gO)z{DCrj543XojfxaM3!BaSiA;~g* zt@1`NvQFgg%}p$&ktiRDr?v&DS{HwuvgML=q+bb(|2uPxZwTO!zntFux`L?~Mjp5S z?S*7NUth&~o(Vuqzxns zy_q;>I~+2cMcu6{P8_}5@96;{aHzysz=82gvGY-&e#t!LUzU0!35V4TdPSqhrHl=! z%wi!k*j2^0wj$M|SJg?0m5uVyZ$mP6dZbvPtx99UCDOPp}U3qw4JX~^U>|k zqj~{5KBlDjuaDcLlGC5mCb6f)A7>O)UxS~_!tzS}kvyxoc0(w$ZPmv%|l-giNmz95XE;_iIIw*%UBu2Reib-zTwan^su0w zBn|NvpLKvMk?Y~mR6`V z8Okh>(;E^1#6hn>%G9@bLkC~Ibnc5TsfT@$i(?K<8Xl}qd+R}Z*= z5;Ppw3=kcVrzi3bCai?&>VZqeEM8QK> zEpcQbhT^;Q)VU!FbB5Rn@rL$%zEQIWQTutCXksvpQBb#$RRz5HKax>ji|R1?w4Ra# z_3<#lLvR~}+zc=<#g1AXdKRGm!nmXl3OJ3RT{0d!Z^`OF2?0rRi$q<(;Ib0P_`V=f z@X*%|S=44rO4W|;`~y<2Ja($XM$Lankqg}YxHrb`KDe#r<^_;n~aK|Q2-YvAhqApu49_-22JZ~0y3L)UCK13h)R%8iF zg&loN$quTFocpg6EvI++z8|OoIkk71gy@P8lfO94=(fZ-n_fMD@}2F%&oV@iC6M=S z)i<)iY7ZM4C%TB+{+t9`iO=X#f~PpeWU1GBkXaq4Sa&HVPMC>*ztu5zra@NP(n10A zUvMpD0jYJJ>z|WTLhgmGC$F#CuT}6vX7~csPtildVZ8x0`JZ8Far_$ajaMVKFoE z2SCwLkmgxVLIX(Pw>h?2Pi~g#z5vP(%(kVi7AJw0c9big(lK~%6|yzDBK z0B>_rm6iQZ0)AT{q33=l!Cl7F2izzB_ih=%KEQ3td`deTVBlEZB>7X7t|zd+wAY|* zFWOB*t-(-2|BEpd4~3GVuDv-{~8$A zmKoxf?c1lDs-_fPou>frqqpMp1iGV@T}q;yo8Lpcz#GS$I;m24XWbs3h$Y; z3r!!j%jp%%of8ETN-}I!$`A|$Dy#Y7$nj4uA!v3sB>%*72{Ni z^E}Q2ER}?FpFa-4w0@k~4LpW5n^?_xXzi*Ur0bI}yfo2?+BOlGB+?u?nG4paL-*OA zAW~+ko=$kWWR^$J-yi;U-;|$Ipbplq;O+O2?cUZ&!0JX%{)Q_AcwU2s!M0+wu%we#M0bJK?+^0P66k6$Gv0Mc-g7>jR2IiIm(bf7+G7X{ zMSg2|7U@uithfmmh;nW0iB^B@X3UK@l_)j&%R!Zrt z0I^cv!QCLO^cIo}6s3V!cZP&5{_d)`3nR_5#^cB6Xlv7g854mO%-NQ9beGOURny4* zyPhI%=OrT<<-9fvl#=_!Ox5 zW$+~s1^U7xI_))jQ9kL@n7K*7B#+mvJ5a^yYRNR7HuFn)JAAid*`qYPS0!8Ci4Rb$raAJqFg1L}Jd|BTKuL;Rcd z32BxCA>aoT4Pqin$@0k&#bp6^c=-m+@p{n^O(;EB%*cmttuYCiW>Kx+!%RJ8?<@2f zVtFTp{#h4`B1{}X_G9Y&2^($l@j=At3ekcep>`%h#Q_s!!au1bByxhKiKMXIi2q6? zzA*{+o1fd8d@ofpR3l}u&#yIBLV{u|57Q~#^}_kwhO{6AQUj=FZt`}zalizCUX-jZ znM^qC?o$9O{7*|sf(F9)EyD&Bs9eQLSlJWLI5rV;?A>XjY9OyV;{PPbp39h2U8SyZ zJrMZp)EYn~Jg^XzRjGl>NT1mR(Ajye7tfqv)X?~Vu>vxmc8~w?HVYNZGh3Sy$4r)4 zBVprvMhG|0tx*lxd_E@R?Jm|96Lw4_)_!&H5l}xDAgbqKH*1ZSUdycw^y4JljHn|u zD8bCk?t&`+j6X4v%`FCMC(dxj1RBVC)PWYuLSJJePgI?h)mE8_B8km+Jk6D><{AjOZ>vNr7z@PX>}K<9f8KoM1jD2=|O@F?rka_Ca?r(n7FW_eY8 zLG@gXkOV(SAzO;jVLicQEwTOE5d9*}$&py}X1im%81S*>IA`5?2*dS!ER>o8^l1@r z*3|f_eWs}Xy3Gsv*!FYjG}sWIXYu`Zh*ngz9}DMGr`;KB>bg7oV8MUxE*sqtz72Y# zXD*GwOa4O^{Hm`Dtm~l%p;DDjf6b%H=o(;xX3|DYI~6cZaaCn+wdlLHKw`_Cfmpx! zweIfjgB?_pQVk;zcF|W(A%40c${c&(jmCGt(8_)vlHlJOQ>w_``k%qx$$3lzcN7dd z0J>i|AcDnk*D1@@bHwa~dSEONqbShI$|3cwGbc=y7RYc?8^Ri}mz|Y#KKnGi-R@;0 zZ90!kc?lW@+VAy4o&~(`*=yNt0__=v&kR3RC+N$gNLH5NIrY(UFS?zr(d?4B{0k`1 z`Y;NH}O_La^Bw`$cY0LsBChq-!nnZ3BPEG}oZ7~XJt zBm4TR8DKvvc<;AHl~mPp;L71a?g~nBA-}0V*C!9o=cVv0^cJchl-++D%G9NpYS_6> zC&@g7-EP+)q8^tmb1LXSg#w)zL?GE$6|&=anlE}mT|&kY_U3tuvN(vuH@hp<(Rfpg zxWwJiMi>(i}WLC{bZ`3QmTq>!I#&{@*KA%-F zew9VvPG+MjNIERVL)6t=l8^dKcrVA`JA@KY#n~dkQPi7F z{;eu<#bTyGPqx&8IF4#s&nl)iSkO!x?f4S^wrw0%ZrL3|Hp!>%z9(X{q?RhZUq9qBqm(6RxKKR;pt?M|8;Z}} zv5K-F_dW&moluy$FDj13;f>@=^$vPa^{6U%J!!h9pHused<7hDN?2;B%cqHb75pp> zd%$j);4P+qRANLT4+hm(QzKtSDKtc->D99%8THC{jZsZ-Tmp6d>sa*cN+D;RZEuAm z<>i#~UXrYNc4ox*gxQY>JU3UdpzOt1(cys1lh5COX)E7}DDVZ2eDguA7`gmlFBtqenhf-eXxlNkbWCVP%*r!J!&4#| z!tpoDP7}wg{=-$ zMUgJxsDhKd7DP$iElzG^Yr~J>r1F{o6b%Z0uLdTW=dgg`bbg&8p49*<987VBbEW%) z6XQK+DMCJXN1pyFg%B$|keG~uCwQa-l`|!eXnBo91A(-x=>sLYF zl?;Fp{I$9s39t+|LnQ6jHyo6&Ltmy z6?E6fYET{_X2Um-`k-YGU0YJe(V3_A8uwJqZxgdh)^=t`;WdXzTBM?7^$k^0lG7=8N#81~Src3mF88qCo*vtz%=DGy$ zk%qeRGw)9ne?EXNi!0E&@os->ZFyw#DutaaYr7fNzj@yY#Fj_5Dz8=g zc-7acn#!l7{NiRf7nm{AAT=}8_y#!sXKGLi z)%GbefB*mt!~viCZbE+m08gMfL=l8hSK+m{K#{8v*F`BhroJPE}uM`96NM!wXmd4lA?tfdCsm^S|Hs7s#A8@~j^#R?)K_u4+iaK*NU$ z;%L}f`87gT_1L)Ac3T>M1kGv2ouDLU#Sg()4jT3yk#Kv$g^4*;0!zMd-{i#(GbUeQ zI5D$@+e9=U7@)T0l0?5OgfIiX`iJstkx%pxVonq4P4o-`8qVdv`pvxFcfS&@rrHVj z6=;0`jkVIqbS3Atu$EBLmE=^_Gs2!XTo~c9>RtoZ!eoOgil(0lm9FSkGnFRCAYu?fT zQ*7_rn~s$@pB+)&sKs{y&p+vndn1)ePvC$~P<#*@w(J29GO`-l6iKIdI}z$n9Av!LtKP}DYqrvdCBj#3$k z0D#fel>j6MXiu%-1m5N!N-@)J;u)@Bb=Id*RnI3P4WuF7pcK_w6v)ztpaL=1Bm>~ zUK;yCWRK6YtaHum-#`*_Y%TPNIaU)nm~(QKcDUHP$c!1si*1T%2>%7WC}ao{&trxX zC?nQO)`e$Y_D69|<65xZ>ftY~c@|>k_>bN8_-Vi9vF?f)3ltuCCPBM4dhrA?$|i0Q z88a7j9c^GjZcc2iK+cFh?#YRMDmgf`b-;*JOT?a>FuVFYW^}HNIpkP!{`Nc!y7ASM5t!x|n^G zp{hOE*$*q6V0rdM`IwKrG}*|l^mIR= zuhS)X*xso(=3hL!vs-~<#S(|YYm3`fR1GlYpb`zC{kG$WQ0&*U{Eug!co4`z!s(po7T^XD)ne%ba9Y_Xu z9~~L8(Zm_s;bek><+9D-BM%T57g`4{s&}x{;p$ z=8)ONX3wCh$=)TlK#e~`7)LT8rPIrcfFMNmH-#dy$z$6M8u>3%&kZ*Jy&K0DWrif4 zUW5t_6NH+|JU6*2*``#4EEQtjzPXbVSlHF|0{=a&v7eb+5bEFY$}O&xoz_CET~xbj z{M2jhH%;hUG$4dKrq`o7s}tp=>O?F(Rrv>N1x4uUE3QSs8chi=L|_ ziWkvl#+z3S&Vo^%o`&5+SZllocBg57CJLjZse&X;G!~d#f+VbgySX{KE~S?bRL9ma zY__2O+;g2`32|3+$7I90%a+VRri3r${M~F3UzoJnf3Vv=e9aS*vH~j0#j1=U$6X+w zp8FESV5HpqZ3(d5O4laty^*b8toaiAa)B2i?m(gKZkDJ|ce~uA0C_gI_DMGxyyegI zaw)>5o|OcsRSvR+r`>Z#mc$B>Zx|7D{?}Wj3*W;If~&Geru?r7F;Cl5AKT5_vfJbT zfxDvz=*UkIxuB@Q6}Nr+q%4B&D&m@#z6Q>lMXhwgXRr>yT`MPR4ZGpoR4lF9#RIZ? zJhPJUz)4dx$6;9?bUeq6l67(#7wNFtn!FT9?RgQzx~E=dwrDN3(=B|t-qd)Ev(YC} z_Ugt!^<*uq;Wf(83}`~%pp1|q>Be--;05k0q`}%2=`w|IbU`2wqiNQ?@?UJkU7~VlfnhX4G*oTe@MGpPhL?0^wEqVjtQb;jrDF_X{gTSf zD^}X?m=nGXb%1`XNyJ|SnUp+ZR(~g`O!L9P^g}{5@V?Y# z*PC`og=Fz@%bs>{1JK8!d$F+{ACr+q;GJZS}(Co**)J$?KInh+bsRtbr^>BWUp$qK!*?S#W$#4m_V+$Be!$B;!)YyX}P{?KJ3&5pqOmrM(>2mmVG zwos&a?Ay)G8omRiIJI>5HW!y7RJJ#QkX5r92qn;~uSQ0cEf@kfX>ctc-ecr1!eE-% zKJ6E;JUJZm5)y_O=U!OgZZvP8XCWN!RgOn!`7eO~wL1-S@!knWg@69M;Lqg-w$9%@ z&nGS568kdOu^ zf`hI5i7(DGG_tAjTmq@R&Q6OA3AZRE$n#r8wDK6yDmgVONqc+xav9BxB~bfu zp16PSQ3{xV{asHz?k*hYcDi8mKA|%E%BQ8c)AVV(?|?{T)BB&KSszBdt9{g()*P$= zefY%J`QwdT5xeFI*%X~wO$}%-vg}yTE!o2@Unu7AcV;3-|Bf%Qs>}VS4>!}&IFa)R zeXr4eBY`PmPJ<#V-RN-`4C?K86@sI>66@EwlESO!7c$?0UNsGYq4*Sv)&7%z-|zyJ zFiYV~$}X}UYoY`8P-Y!+@QgX+7L+8RFFOeno9;A+e4Pbj4EbYC(R@! zAxdalk1>%Tf(qH?vd|+A{$*7)5<&NAlNb4CB%OMDfsZSBPUsk`ZLK3N~-=prIzs9A@j+m(1;l>YA+9S>n#fI*^YAfMbRkmcs z@^Cb$a>T9?3~9bD*e{Ab1@$7e1Yq+YnA}+8Nd6BC^3%(^^|8pGDE{g-i*;v+G*_uH zxWE7a1qcD8{@p5cf+f8l;%Y@@EBjdK4(>+&b@*=S5%$h`;3`DnKg;0? z=Kug5vO$~RH3%)KGMEH6|Ng2~000g?1Q^)fr23aOLcNuk7NW%GNceFJ+IOu2F$-E-`h)vr71OGyH>SwMcTlR!mic828tK} zQc8h0RlYc5Q!BhacEu1MPJG!dSLK@j<+hM4PTueOq~$_NK}G(pa8krB-!!*Z&vbGk zD3;7d51~}+_eGxT&}OGTDRbvZ@QTU9>GYR^ULXl3MIx@SA6||NkISVn%o)vNS(7X=T9)2q zu5$UdKu9=~8ZDCcL|^9J;eZyO-BVZU9k0C@eb^dAtzn(`g&6cqulLONTlr5g2dy?rz@E`{fs51_}MBr=WY!LKPKsRZT33E~7Jn}3}$YLb%$IbT6so9V^D`Fk>q zRso7nY()K=+DOL=h3kS)BRBL z76xMZ81i;bG>22)|G5r-NdR9!pufCSH^U8GxmbM(e{XBR|AU3!jOb?{aJuq}gLa4j z@vo&JXzcb{_T4af1h+J9+5};7foJ<@^l6vzQ@%II^Kj06?iYqV`Q-c4M>3=ij!_2k ztHek*74Om~K!+`{i8fSxVI!a3>OhTCV_YW%R2V1RG7(@S4nksY%sAp%)axu8P6dzm!$IkQdO6;<# z?VOX>^Om2}h6PpV|Mg!{y|F$h(q^WQaRNy?Vbd(wE6JHx{crVPNK4Xig$mI7G$qzn z02ZCkczBCY4XIQVI|*yGWAuc)Of$atqSG#*(7|yw6c*zH4pB2|a+v2Te>>qyD3)0E z4U^W?-JZP%9=?n5Ubvpc+~eLr&WYY^#QePtERru`|@u+2K<`o>da7-B4D7_Pt5Hwqy}ogasDh$r#8V*a>#uG`XU& zF}8YCUlclKP1;+25jYI)r)OSoDiL%?_xLjW^cjP{!@?8l{6)z1w23%xr}`5%r}Hnu zV);hZepcBr4ty2@y7;=qHUSH@)J}m{i4~vg87;(OkPq1ATc_+cREOF>QITo0=HeAa z{!4?W7+YLc$k&r0E32M9S2u=ifrM*_s*HONwA|a49o?sf(m~rp$dT}j#g6$H;sY80 z=FgwVmTd_7we=ZFJV(sO;dhu<;!1WfVj*X@k0sRr>GE(@vP;MK{L=R+t-fj#XrScp z6c7tWJ@Q-!V@Eu!S^3Ox!kpUdX;wiH>4XF&g2$fl_s3IT}T?@ZH+pASm^y)GJkAYN@B>!KsNn3X!C{Q z6wA1{KO2kbf;L1j2)D0)hCXoR8U49Nl-;DGDv64LNtmswTWL@zRIUmEJ7ZyOTW}Q)5r-YzuOH8C?X~9((c> zsN??d>-7=O^b%Q3`Xi89Cg7VL97pc4JIZ$95NyqPx-STRNml%5Nrcq@)AkebLgSmS z9qH3L6O*&-bwU3r?H98%xxK%)Hl~}4S?|0WzuPTKY}!)*&U&1TIJWh; zN-BeaW#gcYX@pL?p=Q8AEb!iLa&w1#5$88dLSznb%hC9fJkzQWtQJ#?cO)#+YTmpd z^g*QXpO2F!JTgwIw#p&rF>&dg`pwP>y%}?)?+(!^bp!yP?~&z6u2F?y=)C5M>;l9g zFA}{GijfuSVTZ*Wx(ChSgCE|uiHgwX94L#3L<=4DLP*sG*>S*cmW8w(&X z(K9H)Kj+VTS!?hZKszYIDN2Gyd0?SwMc$}c)JN`qZEjwG;(2XbK5@pre?=Ftc_(oy z(JG$ev-h_od7%0?t1d11%FNd3!IJmO_lp|a_A5zL6Xidd457jtaE}6m7rd{My02K~ z=v-=7IrfCY2%+Ug$g-8p@TRvRDX)2i`%G-~iF3ulyhSSJ-Xfq3BNCK0?8PEc$DXX# zt<>X6pErznjy9jRqS)wm@$RpjtMp}nY7Ei;X$Dp=kmYgq|yanx0--HpRD#Z@(hko=hn>> zF`@jtoP-PUT)6Sz$kQh}_Cw(gfwPbeGP`Gd?3*Q``-Vc*oDdcmEMmbdC=B*2)qAbfrjQZ1p!0Hqb;6}y zpfx@IK(V6*g3jT%mGn*m|8?n!K199YyIG2&m*0Ydq|dUvLO%Sb>GImwDpX*_^^00W4XtF;cc!o{qIW|c6~8zbxXyH zw78#pq=Pv_3p+_J{Vh`(d1J9VfeO%}Bi$6_!haVb!;R-klofACPb&pI1IV(w!q1M+ zzWivti?pm(t=Zn>8^(k|4{j4EW!@?vjnGKd z0r;spTCeu|!KZf)-L12Ydh+o?avlyb&)&lLON*}UBgCO9M0 z;kD}A+K7_teSzvzzMY#M)EA3-<}q=AwO8$70s;z0PL&{3GsiKKJ2rg{c$5*HOLufc z9oS0rf^n*7ztn_};g@d#b+##XQSp?$-gkpEYC&n4u1BZoY#^7URL{d39%#c;ayO=9 z2!S5l#TAH#?w)%&RL@FF^%B5^cA#eQXat%^%2~khL@5Xp^oA?noS!&7sm^f9J3!@&AEXR;asq)kPZu?aY|o++0j&%Yk7}W^t~;SW zOSWxEZ9#?MF<`H^_1Lq`be2o7=@FGXk8WaO#_H*#bN$4$+KkYB?}*!~fz!&=IqCfu z5J6afKs~IMTX%7bTh)e-)#CaazOVl*L&Bg8ZXadc_G3pP|8pnQo>W~Zp334F3~=4e z>be88%*&|Vsv9TDSu_+M`qZksa&)uqy{z=7@xpVXuMY51T>io~bDBCOelW-y0lE-^ zWcaVe_GHSu>)1$Go6SC!Sr%t)%oocd+P*W6As96b$D&Rsb%?L0WAK3COLH{{*s#Ws zPbaqFNRek)L0M7qy9-KFd@T;0Zgv=MWBamaLUg7!eBc(!zkFmWuaY*%JWoH?tD&s-k~b#;X7YCjCQ8?r_5j-RSQ@>Z*l^xwgH8o%KQT@bN6PM>lK z`JmTrSflO)Q?E(aHVn0V4K4=dR&PU4sf@5kNy{X@o2q^ih zNn1aOO!;k;Ie1s22D8DK3xxm8h!29>{C?-PvK=d#z{|pUE@Msh#@W?+*9udTlrJ>} zNA^!~XOl%x4w}QNu=-Y1>{{}>w~|O-7ygL84WZ}@7Zka(T|hhq^*Uh^Hx-oVpkV&` z8rJoCTfUD_jM|^?se6xyVIT>=NZfig1=YsOHuK&YIihFuOV4o@4g}Z-Ku};X1x_tl zo7j^t`TOc$1`{KxqyVJ=khIV=C5t&KjVX$9p_X1t8C=iCa-V*otaz0bLK2guk1IG1 z2!9Xg38jcS^02?7^T&8R>RHI->{zAI5@(Pj){U2`63Z|&mv=w`i`#D!+Gx?W_YR85 z4E?#*A{ga`F^0hMJ)MiES#EZ@dh_5EOSugsS_4qD;&~4jlOPfVvy)#@8mcQQR^KOsk`_{V*1DbCXw2H(1 zwZ{%;G6Rc^nyv250jIx#AM96eG+p0Z+Pt32!8fc)XGZdsIXg**`x)_1udNP(Ft+j^ zgU#*KONkP4{qF+f!V9RCW;$ugf>tLx`EM`~BBY+h)T>xSR?f>fE-KX^;ajXyk*cPX zrWjLf15M9RuvMcoJHrcF?VHNv?OLtHcjCW6|3ZU6X)K9?46);synt1sHz=EMwY4fJ z3G$zIQ%PlzP1a8Spy5V*#$KH#fp58}R!VkI9`Fy8j*cpu%|SF4@qP9pj+2KoBPS;_ zwcHV6D8O8{x{e^j`eq`dtl_Ho&YC|aRe5phZVO2Erq!A_8NPe~US!)8;Yr%s_IqxU zDldtK&(?*I8u&yX2uK*}@6Kd|r5%}=sK7=vXD9WjzuV4tx($Y3wmFmerGdFLFK14B z+nXC>|H@iAx7&Ex0F2~@bW^{a+2B8tLBzB}M z2)@T!9^kaZ#fVzgW6=w#L|7ySI(~>DE;GRUnKu+Dj!WlMg9)M4^n@;WsDrod<96@| zHG{0zJ8T$TBmmFKA+#jf{C6XTVfy)FqEaqnMDw<&3Nu1Qj8L z&DQu}sjAGv6_|580*pQRhYNM3o_wg3B3cPRr^^l+;|x=T?pzoQ&67XE-o2FOL6lXJ zC6zaSw(@_x0nDEVM1g#hYiYw{gV_B)u1_Znf0`w^g+zgGrG(pBz)8OdBqw#%N5y#K@H{Y`$jjt1;TxB+~>#hS>h(6otiNd57OSoSaFl7uA6 zAtUvR_P*J64jCI>nq%=oP_q%ZdZN6^WHIq58+%-{oV@Re#SX>MA{+nu{uRwB5*C zUH#VJ5gLxf979+!`UisCREuQu{5|97&ULY|kAW9+8=&8ckW=0{{?RQ-y0IJoj3Y6S zgaBu1v~8NdeecOuFKk|a%7;24Nu3|lUPc@E({IXF44wj)=$5mhN@l*Vgsp1;k?gj^ z2{@i#?wbxO%BLIIPBe6*oN$~ZA&($O*aD)BIqm{9SgR%irq_URVnf_D5l=PZ+z8UQ zmE>Rs0|`JZQh?8Y_4URW^+>DlNJu#WBmlg4R0TWrSR>O4FHsxal>67kF+_KA`qbUDT`q(#!f{*y z|MFj6z3qnBaR-mQl1Ao55S!qe^l?NRPYM9)(Z-I)kK#|!r_S~WU`82T7oK)}fu)OK zvale3rmLs0huQ}%O+~Ufl#TJIMR*Uq`l;+7Ib>`sz62f?T{44ci4zlE_h`SJ377}_ zc3>M~`*qgRk|$CpH3elr7Xvw}>{^Kwf9&s4hIFcJ8DCxKD7i0}=2^@;JLF>;(D=l? zi_u1biUPU2WN zY75WmF&#$)3Qa5h{OOPWdVO-gy19QTL}CIFot2UO zNV2HNLIuYD0}daCp10o>atUG-E^7yBS@%Vcz@;HPx?UK{6xX>WTT)f9ju?^dk%nXlv}neMV=eC%KWlk1XNi& z4SB@sZsaBu!t;f@68Jp-FkyC*YFOTUWY1;<&<>nIK&!!RVT~jJ_@`BqVf<^0#!!w( z7;@~QF$SK!UowL?d(7!cOo>c1eg!e|!gcHGJ-pwoy_fg0+`ZhpqKi=fFrKr zTcu0cy!aZ(&HhH6V3gHN|7L$ z{=CnW48PK7V;A2cU@ph1`Pph>{Z8Of%-=~Q7{aVp2}kpcjR0hGyCvGcaP%^-tK}n( z85h~W{MY(!`T2@;<_Mo#lvb^+3rfA-uX8RVLB&*)Tjz~gm9o_Ec2lcp!ncOD$H~D2 z!vYx=*b^`BTa;*hW@5&vg#_>Q>))1v4X7zZ%}>eu_Slgog~03QVwq#KUh*qAz)xnu)Hu zy;JSRj=ONAqVc|Scy7+cFVG)+Riazewwa8zm`1AH-zQtu;T&v=`D8%Pe4*j%9Q+EPmK-frC>ubu-U555v@sqLkHHz-8-)CHa6`d^?oZm=;u7Nz-E#ml{%=cd==W+1 z(yNY%y<(`*ZNVOWJ;FmR-dGK!q)CQeQ(flmFS6>2IeNIOQW`gP>#q+^-)pI8tIMGH zwRLyGhE3w7(4_VO8pa*p`dsa9W;pFxnMB`zrPzU#X zd>pQxGW*OouS$p>+j|zZ`G3_I5R5&R57zd$=ak}SuqV{ z(ZIzY;38`mW04$KZchR3r%v^zwg|VWEwXT-2n+Yu&%buiLG#;Hn5Xk{$?-0)7*b5dmf%FD<|2PIKp_~z1Z&TOg z7HRi$TiIg6S368|Ru`Ip>Tk^RHS=`I&p*9(_(-b8RiZJYE0?t)XjhPL4Oqno7Q z$pFC6ztRMGw{RB&vCJf0hp-GP#iJrP5oI+X=~4r6_6k$9l8SG~U4_x2OFJ7L6J(Y1 zgGL6IOQQ|F9Av1l*oAjQ`K}R zqLe5)4eijke^mNc?91>hQpV*K?~CkI+~2wr=0ki850i2@^(TU z0Vo@)G|V+z<6K$BQi07U;ps22f%#T9TyD7{}quqLUtsttPsDC zHtmiZMBdYSbWU2dN08_jfgTJANOX>`!aQ!)sC^T33yvvz8|!lea{zo)39+YzLx|d5 z3S6!hB7ec@oESp&5SK+o00&Lbp5GD>?qj#dVkNVoVh>ida)bZ$*RF%i7Eprv6XCEm z|5!v@LOPRP(oaSo9?TJzIVg!iKk0C38-r*l~o$A$>WoD(Q5~ zpTE4a6}@ek$g?b5lKp3^Aa_1f=|s_jh?vm@+KSMTT07p3Mc!0ujsv0D%H&2Xc5M%$F>f1-QAt%JB(hVr7@P`EkdqE0TZnDf$-2-p9}WNH??b3Q?)&%cimP?!rN4O^L{lV z{pAlw>r`{aA@91uh1V~u*gx`1{zc@#5&81qR;Mf97o=^&DROf3CCswnj&rB~HGMLh z?6NY82+(45v;RbhIyUY*Y|&vM>F}o-osqQ;B3l6x#*72=5m%FsvzI9Bn{ECGJIGeY z8jz(bnhH+H*3E$u+bV-NPhE=Ly7#Xiy(fA5`}$slFiyzHB1NET>^VxUHxVM>vqY`w zYn>~$&#uq-s}^%%Dx?;{+JNYE$#0t76aDL_BqR$+ZazyPiv7Ngg_LF1_W1q`YdbIR3FH$g)k)JC4#Qn2lHcs?+6 zWu2oGXO=~JMMC;Z=kqlAGK0d$RzF)MMEd1{GgSU6!bEhy3H;Wm;q)p6y3QC`Sts&G zr3F=c2*J&J6`p-!31j{ZCV>86)m?dUN1G{7)f~=2SmTzyt0^Ubpz-%hSI7WSk&Sr6 z>_g=2#Za}Bnbvk(#|RKy>3_e0000duL7pCDltf%B{{R48CJEG&I3+{KZFltliQMUi9_uNby`T6MzMi@~`sl--Oi_u%O0>;pDn` z1GlSD#c^9qg^rs$O>KjRoj%a#r*JK=9_EHShgt#vNa`q*OG8Fa>rS}9bXpl!;SS55 zQ_n*N8k>@%F}j2N7s47NIKI4wsm0&|gA|->-ckzKy9WHwQ2hO_0yN;3U_9CHv?+ck zMAA}%2?$_YD-CPLciS_%dBcg31Mg>mha}ebo*EF`@hDbmHvr+4m{x^Jkg#Q=eEa|d zwhs5ZD82uEV5-xREe>B97}yA9%!@45V>ghNZ?vncZS^~bedC@-NE@k!e?@Y4{Or$TA-ouXJoR6}I@-w2d*qIP}?*Gtr&uGhpUt{cJ!aok$HpF)(PYEs)98E=Q* zTE5qHZo9od&?Mh{kGa%s#sVNWkmnspLykUYF%^=|V6cS9iSTiIt*CxHD>IDRBicxW5kQ}~=e5C)hUS&tk4e4%LYk%&l1%4I5 zV?VFRKdJOF?sm~7QjcQU^dq%(_n78Cb4yr8OV}A{$8PdDo!SSWP57s_L1+n418AR@ z5gJI!g6lcKfLFl?P2V%aRU5BgcfKsBu1eA6H%A=W{|ARhOo8I9(c z11S*5`b15#9F62s8wWSsFUe)i_6HWJ9sgVss>0Jy2{m*nITev*8b41?Sjp z3+Xs--1gpwuQlWzqJO`&UQysS*1M3+P}nCITIyGE-b4qflW$kVy?3v$On>Ym-F9#k z;JsKZe2`2U{$VQIRvEp0p6S@ij6N5hasB2a)qx=kd$tDYEfff5A;q5gSwkxbmCCtU zq1wdS^UGS6ttHuHcA*}vC;Je-fmoDi?41ms;m~sdbI3SXXEc^a^8-ZDZV~X8Zx3kd zE*P0v|0Jg#iQmyCBXhfBV5c^VHIojj# zR6m#Xw&bDyi$C5#iGWRvoqht!UP$x9Z>JO%{VILe;%rM$Xk%{xY*RJ;T9x>!BxjqRWtHD%?eSZ+%_bC96Ipe=p{EZ9r@TG8W;$SmcATcx9YD9X*K@g516m5%`74jyv9$bwY5m095r!m{` z{#iKfr(@&;Onzx|W200nV-*#~60RI zmoV+Xi-OkmT7bOLlM+nx3oQGsMw}GEc8un%)V2f2R~Hgo)zgQx@ve$iqR0;#) zK?tWGUZf;T&CeD|%(HZnFN|vvmHrEd$#h5%PPLCHT3@{179KlbZ3ytK(z!smHv3f7Rip{o5HHkpe2)|u@JibIT|BS3R2}jHNXiLV`)&hb z_rHM5)7+@F4|0(3zgbfc7+c%%XFT1on$ILlDmgLkSUB-R5^VN6x?`4`;E?^e5`~E(!!oAOXcB zh{~MsMbn0{{CuVhkoyknzff%cJ1;wrY$46BV1+et)w4bN>r&$d^PAPa`!aw>7f4?$ zu{;nc*6{c~cS#KNu#fc>W+Vw9Jdv@`n++0Wt_S@=T>1%;EA~ z(7=k9Ub@S!5OZe>) zj%KDN(Y@?tBENv2?!a^#$Xv8>a2s5!WtT4ko$#c#rwM3k0sF{0U3U5^IaIW=!zxN4 zl-t7@m0g>#WUFK7U!lZ1R?+oOfA`KCXU>ETv`fa-)+#JM`cqiGc^6}$FI$(_M&jfy z%jOmj0cPuEyl7o<5ojYtub#WNj0W zcKXJupo!~{c0=;tIl_$wdlFh; z<6Z>vs^qSK-cCPDO#&n@&kH1nx2N2|VaSzbqUt6DNi`2pt2N^X!fIVzqa@?KSTz`K z;%3KtC3cdNQ1}a&xuuv-=I5EI>>5siB9&1XUFt)_9}^}Z=;u#2{t!$la2maBdo z$?;$?!Rly?zJ30TD-`05>Z2p7T~Bf`emiTDLtFiu(q8oBdVLAAYlMNjW6#3`StRXF zch9j5y#|$A*Nh1v7-fXo83Et;U%l->!h84xuJQbEm&%&*1g{yWA^xOm0q==wBkXxi z!%;qwX>12wMwZvy0Kc+2UFq5OsqY#?Vi(E_vZ>5T7IWT?9TBa{-%(a9g_RIgA--i* zRXW^AoWr99HAR?*ArEu3hXGt z=@AVk&bZOaxp*nr;IHk({O-epO*<=7W{Lr&GKD%9<-ZY(=*vE0?4n8I#z0zc=eNzh zUcpd}%&uVlz!eIcOpN9anB3uGtT7c4gFaipm@H??Cfjk*pZ*~d^>;)$ z@vXL>y}BPY?BRD<0w3hiJWDO-m4PaMz2=c0MNSk*LdNIb)XZMhYs%j_KBH<`qI3>s*(TzZGOSw+I`hx zjr#IE$bz$^2sh#(jutbB=#uiOEMoj*!G%vWOSkq;JS{sVt!}%@k<`eAk2=j|!1L1& z$Z5lQVb&%4EbX?A{2q`101N&Bo;_(0p8x=HSSka#ok)s>HB%ROU#y+iBeX+R$K)<( zUx7gb5ZszgXJn;gc;ee%QUw{@NH$n#nD890sSnc_@t^=jd%@G70wBmFD*Sw2wC8{6 zRQx{h9<&OzwEqFts_pE~yQXhz+t#u=tK#IrrhbC%GAKxKzee0c)vhN*zkYv+#z=J; z&e}0}@>klB?lFEg)xh2MtKRs}@Mn%CvVx{$!H~|J?odpV=v*r7jt|TghM4-0SFQA0 zUIHmq{bC;Mg1DE$G2X47y7GrDLArg}u4g#Lz}K$DosvcL@-ipR7$=g_;U&i~p*zW9 z40-#WDc!D@L-oCco5a^08!Ss)9YI%o$iGGODW;pbHaNSuMOJdrI2@2~6#0M3rP6>dPciX5xfJpvH4PQ3( z3C2ldX{r|A(}hBMdzq0<7u)tl96e$fO=L*98e*gx3aiX4)L^E*Wo7)`(x|sbH2l3B zVY@Dl*wljljdq?Jqk{9=n*nSvkH#Yr`kbfsbKCNuwq=D(sf|9Iodye~jJJ#=gjq5rn4@_;4gS*ft{6d0!Plsu46nuzM&skGilf^{ac&YnfO96NeSj` z2FbN(^e5=9hGFucEZDmqN8}D)656gM0hF^ zNG4zK4m$@!1kNe4-*37)j6L)+nO5Y>jxB(rK3&G>jxd-UddjfB6EjdfJ)B^2h+>&C zMJe&|`~}J#tE~$!3SmYFIPj}b3ik#ugs&!nk)HqpsTGafkdJ*Lkml4qTNPUYQ5jt=oxJG7EjagvV_oboZim9#@R{Fl)pahUIQ`*7M*VVFiI08V4h~d|9FMQfZ^vJ-lVDQDVLdEt1JuiQ~b@VnLGsI;+z`c95EM= z*_Bt%g0@HOQ7!+)BFq1M=U2Ags^`?Ot+r`7@KuK30lIBn1Vmyj>O+y8qj&VHHJuia zN})^(Q?#}`BaTSmxcu=7&k^E*4ribz zjZ7(EL(-ANfjt8$uX3QX(k()SJZUt4o6fL^P%Q;o{II46xml|~kJL&q_NtfVhtV{L zDd~-c7Z-8cXmo?l>#+M%$vtDGXnE*fWf)=9dDxg%!4q`9fri7T2iNZ$h<}AY(I4!; zFYwpPw!I~qdghSrbSh};4oh-^+>ru%zDQF{Q2>}BS7b2epqHMheE`EdH;V5(m(X0| ztDw(T$#n8~@U^r~ubV$O>Tb)M??&Nrqnsnwfx_u^e5dYanDAIZx(0*Cg; z(sFQQUTvLF(cH8al}_5}hZP4dS`?wOzvxxA|t~K<~*Po&ggk+O1 zpU$%81KclvB-f&#X$SHeV1K z*rL8Iuko*#nANQ%=E%SYE=aDF>Gj=={jcpmeHkFwotmX z!QgkkFjx+7^e?4Amj5pM=uGbL`vph#r+bd(#w16JM^2yHQnkC`lL^B~&o(tx3F(NiPgWnp+`JVJmKZg_( zT1B>haf)(tSVV;Y{Ao8)5qS4D!r5O14qQZKi6iON@2yhy0uU-rl^fn?$8CP>(- zHV7^2`;Qm5z@!+_S$P}>n(#e@!j16`VD24;newszfXy4la%>{dxFpd`Q#1g&G%P!Y{{DE8~1CORb?*J#!FcPaYV(UaR zU;vQRp0O8+!QH^mrwS*sXVa6`zTGR^4-j2D6Y^Iuk~`YwJDu@TQBoRGd63T5wBK5I zUrd1khbsL3pdn7EJf4P9C6QQfKNxPHS@YkE*xM!&nDb<4irec^A$ob5wZ998r$r!G z&?X{wXTx|JQs+2$bP9MLT9W1JTK_RtCC8y9WqHRCn8QN&DI?~vxSIW%9I#&|k8M}u zv#D8(65j1P+3R;BiGHs*O!0_&L0c*IFL-yfHw_+ooQ~~;cd1tUpkSysB`8|};zfr{ zUxf}GquR2n{5FkB7ML}D0k~+y$I!J$ohNC|?y?479$rbvac{ibKLCB~(*z6%ZhD!^J^A!f(UIWQH81jV4u+Z% zXW!t}pq5};so2Qw)ri-*%VEFotmLA>Gh(roZVyQdX?~SAt|j{& zv1aSa61=@Hs@fSZ#tDcrnY+I9KmY&>JOQ3RZbE+m0C7>M#Zj=m+eji{M@k-=7|@G4 zcD;~SzP`HmAFJDZ$9qzyYIq8v6S9HjM9tFez-D zkz4lv8ZG4jA8;xGtTB8^qFz;mTl;Q?ckCq3NuO65d+bMCKi|T~8D*Qok0*t*7YB8GOSto9_TGU4`4vW*n)t>4-l%Je!SvF1}M5SYv>P;(MkLnf>zb{wq&59_V0XU<;AgKb~I)oU3}XnwWfoj}XTy zzhggAt_(BUvFmf(rPT=2Pi%^Ux)2uazSn@FT@_BP$l+M|)=rC31le<5MMYFqhkSm( zSVeZKHW@dGHCEm9=dhg0;UB)e#B7*%7cdJCPS?*=aYBiryt#Q}RtRbSo9R=nykW`7 zDL#{hF5x3iF`rLH;N#Wi(&=5PxmkzU$$di*OpFGZv?ngHCr83uM>z~UGjH!S76<%a zDgL_jmcLQi^^OcQ3U`a{XG_f&y5GkO9Dr1SW#SO{HGc9M#5deYPSjbKq-KLGxKR!{ zFDp?{w$JnQCs|GoLfz;wME2XN;cOC<#`Ls8njp0a$mF6 zV=j5YJ9`{I&W*`mp<<*xS~eIepiT6UYF8FFIKz9q1~tDKF(6vG>ohcEf775PLF*L+ znspSE?Do+bx_gIpR`mPho{FDC%a-QDBfK86b1q2!eO2<%sGsMc_OC z@JokDz?E#9@Y(}K>?$J2v*(2s-Egf1w*I~w0ZVa#uS_4Y(VsOlO@LS_GNI&AU=OU^ zQ^Dn(?aBIJdcqOHma#P3)ys~eYSTdKp8fSTZ0AM#YhEr zkTg#oFgN{3TVCG)PVJFH|KXEurWuMn%=n@Z%*(*Egg4l%5wfh?e}vV6v{R;g5!YYX zKcPVzSWd^&KWN~m^-rr1a5u&Y^Rv#7R&Yk?$;P2V7ls@UBVAxXm6E^J#+Wzq^jJ#M zvD&G!5~$sF+oH&GRk$3|P@^rZ!A%9oY=dS+1r~_uuP@)b^#*#F3{#eAnpHXT8n?B0 z=>d`QtLcM<@rZ9E6tWG3EcpkR@^xfe$&S9nMOZUDhY{;`6eYZ8zqA+BMAXU7tXHMt zX6;!Ug{}}HGP`bL`cW<=V4Kmc$5TC$-<`n&y0Ot07-jgvQUNGpxOn|()t{fzII?)+ zWwxF`!R69Gs{=u<&ZonbnslwJ1zw{d4VQXTp>W1%vnW zvYQ#Pw)YHFofnq)OyfWElh_)tW4;|&O)IO7X8%!Q(`EKBVt_7E6{C2)bo{dEbFUHl zS&8Ns5#!>lLw%2=v9qh(8WC=wH%dD01LAc`ucM4R?wP%#pfMjLsziRLHRw!tbdN?( zh0Zb(eW``d-Cm_i1Q}U()zP8!QkB&#?G}LrN=IgpMr$s5pC1bq3y3qQkt^fTt<1w} z5aL1ucPYbfYeR}_O04U1Y6|S7HQDAcVC{$$E4zeI=^esI;%6`SJMBq?TyT3Z@Br%S zazs@!Fzt!oy)UW3%@5K9br3T`WGy&V_(JgcSaPA^BIk8928?`pCs33|3Z(}NZ4SlE ztMW?E2g4GS#h%ZTQ;r3zJVojBb^bFt1M1=$lkZ|%T0y+1%kUrqW)FzE+UZ=Cpt)pYCQB5!l_!Qrm^F zLQlev#*3F}Bo!cRQxVKb{|T4Thc6pRu1mJ>?vgr_`^5(=fci`~j4Qz#MmMkS`n=%ZH(}G(Kn)rWSWh zIYHdZ`%dk)ZaUD$T>>AujVS_-adQ!iH${?JV)n$T-wWzl(<07{-+Ce?`j}E-ouybz zPF*gnXlaX1kHy#J_L?WkCChZcqf%8K#l`Jj+mx0v09;vH0Kn3>F{puF4n2 z!`7o>dm^K@W0nEMI}~YEh}IHCZpt~&X!+B|A9SzIhYIKRvGQ1ynxVzP+8jtsv@ zOs?`%ZmJ)RIcPKSmZ)7boTKg46@=RAwbfG|wtTlPQgUDT3=998`kWVyN^3EFNx-}r zOwSCKE%=mu%$9=-$({XB*%DKtyo@)Gb&-w_Jv04&G0M?W91d8Gd;jD5Xp{kC>cH5E zdLe$Ioq`R;0vHYmY4t-qeFV%qumW)o#!q@*L`p7 zn?%R@0;!7f3=#i21Ds1A>@EcgIKTh>%7ZWgL=gxc4pJ^`#-Rzt-+y{H|Ho zv!ZVv@O4O4IvXTzauJuL>Sj5TAM?sius%V`+Uq{;62oHZ25VteO*het+5OW_Pm95C z0u0}?d2p7kpC-eiw7jS8rsHwn{u}*c&=ZcTJOz+&3}pKmZh8z<-dH|hMM?(%oet+dh_nkaAeia&=e}0)kvhZ69-0FW`hVT?ye(T zg~Prh5^Or<=$*5qL<;l?DrGP0jFf0m(!gOHs2{UCA+}=^i!^Z*@$i@!q?7ngnUlQs z*$a7SjxRx|N)_yQsN9w>H?x&^ZWVy$=`3s?xt*MC;D`meu3vKw0b*M6{M5^b^8}Aq zVpxP?AaQc)6z$AG$5XLb_dQ`e1y;M5NOOMzXZRYC$?F+z8zJdpJZw_y*c5!v8=xdp z556PQm9r;;AR(i{sOUj&aMa|hY4FuMASUFYy$!aIg-Q6NUxic!=3V3jVBk%0rimYe zEWiK&lz=5Q-HIZ>G1@JWAC_;_NQvaREtXsnq7+nc^Ln0uTlU9;s{jBOc0rmXH3%)K zGMEH6|Ng2~000g-pmu|GyUV7>E&Di)tqcHKpiM{>@9|{#OY`3)I5+gU3x*vnaqOU<(Ou9E7aesZ5M8;qJG zb}Tw$X`YG0eAS7Z>Fbr;F37VlQf-Q(4(O^4%6Dp7+Aq!c7$b6SB9+V?+#SdF7}LQP zzz&=7p;yhF8a9e9?leC);Q(epnZGwcnF%J(Fnwe4z-!zYkzeTKTt>%!hRmlDx>u3m%KpA;zeogZDZ;kEZzli?{1hz2J5 zR&*oD1zqCEGZ}lfrk$%>;S9kYr9snJs58I?GCSZ~L0!Z$#K;mXg!ICXF#TZgwvHmj z@EYY$jYj5fs?w>xfna7d{ujZt4^}u{%dXwl2 zw7rmIBSVD6fRl<84A2j4Fq-ehSO~cTaea(-52Rnf!@sBPOo37$%j60Su0c;B(p&Tx zZSu6E{y-GIk#KclSEBs{XYh%j;W6vi4TU$TXtm(Pe2(vv^;{Z7Q$AIcn%?;WaTkI3 zbX-l7e#f?lf9&8SL4dWl#m%6Ibq7poo3TqYt}_r;-NkY7tRokQh$vEr|L8I8!{8QL zd3yIOv?pDCNcj)e-i9~`!bQq#7Q+jjEN#iopgt5actRq^HKh5_%#Aag6nggvGmAvP zcgXKnlGF|fP^xNjKzUz`Akbvpw8=!pRRQJIOvl11!Xl-C?co6tbyOGJVE@*ccweuv z^;^j|3-z-X74_<2JpLAsglMEo3kv(076o`XP5Wlxo}U+G(dWx>>iXAxxmH)3 z#{{ur{6Ks?fIYd3u3;dA?V5l}CmBz60r8*UO&qn2q7-<69MeXw(CV{`eeX{xTN%_SW3Y)0)i-NwhECD)h>s9_N zeqYlZ8_o^aJ$s>*SO!%U@x4QZavoA|n2pW(dc!1j3g9!!*QAhNboF^zog#Db<-JP7 z8O#0vT&;4=7{i9ZkmdC4AXNV(c_U0S@FV9{soqxrT-&1vqCRCcZ0nMBVekzzkW|Gd z25FB|W7Xv;lF~eL6D1^2a#-=r6Xj8kKgM<_S-xI>r3;yfc)9y;3S6>MG+LW9y)6oR z5Dk=LG0N_Dlf)?!AnnM~wBveBdz0Q0DP*1Chm0LMf{dOu=hmw5gN9zPVZ zB0DPbKrGxH@u9}fGRh};!OVWAv$41jy(v}bi7|yGcatFb`|csajl~||^@ppn3{Mm~ z-m=^TP4(VW$!-pY-o7A=}`XWp%$FYeQUfKBbw};0sq(k z%gnu>2d7FVhZ(}SvW0V#=fy_H&R3uZRc<8pfRN!po6Ax62N=rsHoTT}wPKV1kr z5RJeE@28Tp>)Ik^Du2x37Yej7MLL*Vf{SM3R8QCJUz=$FzNN}-#S!FtO?v41sEgrI z`Bsl*EAgN(v3k(3Jq=m8Vx4{LZgC|~7U&?w=t;6na+;kaV8uQu9YU(;cJEBJOci zJq!h(E^qGN;@7U3xa8X9`nymRSJuus$e&H(^t+kwoTOC zW5|mA^8&6$;_OB4%Q()26gaB>1jwF7hM3jRPd}F_rEK|0&A!IjS4CYxCy^bwPf_dn z<5cOqw{WcR0g+|3{io9Vxxf%UqR2%90x_JeQT!VbCz2<@<8R2Qsi|U~Q}7fwJaYtj zWs8p)F&)u)$P2ewi4Ah*>}eGx=G|2LNpo!}+CK#VqQNnJiM`Vk;OThT$jZ+aEI&Pwta%7|Cx z^1>mvZ%TjNJ-`3#D_%PoeA~sJPolc>QtB;Ga5mn3+1L4^Z773O>uckpI^y!G>1!EA z*rAUStrS%vppNkqD>YZ9^Zly~IBw*notT%9`|I5tp&KYJ(vzSh0} zpKy$lS_!x6=CWtPL+CzwOKx@B%b*(}Q{9>9(j$(X`2vj3k-%G{0CfHIzYK%jZ^uM= zqUI(eZy`y?huIy{)VtAbqD>n>o~`Rq%JIoVPh6B?y}Ppn<|gk*wPavO(3XM$`YfD< zxZOvJO;>USx^*oglpo-V(d^o}&u2s+D@|i~RKYQ1E#QP(RlB#C?ILhbgl`8d;)W17 z3IWKKDO`QLL5@)6IqQpJZaqN!1yS)$%I#niv?(3Ji>~FK>gR$HPBlav*69Nz-pc4P zs3~Gd(@vbiJC+EbC)w3x*WhT06)V+fS}j#;waW}hgKPi4i&po<0-=^gbA%$r9jifI zVQf-L2YEhRLe3ZuRbiZU>WpRR406%UKu^<&>>u_zhkV!Sw+RYmusvhDCM3rjJjdWhuqx-vV5k{zq=NG=#{?TZtV^kFz7Y z27}~I5VooAz}dn{fFQ&%cyJ3 zhMM>PC{OqhmX#)k_Yfi{(xOcZAphTla8&0?9P_LH|F#Aa-4BZoJp@i&maRhjf*UsB zz7?GOx6ftr;@IV#Jwx~pF%hFxYy?9WvB&anepSfe{u8e!|1tZ;p~zLWcH>H)HBug> zYV{@&MXS(cX(N(+8pwdKW-r&8X!sNFRlYe@>E*G%QETE`Rf}EK!y2Aj=M5|5(cegA z7T!8+;;teuKXC((>Q5MW;EehN6-Z*qZMY2to-V4*>0X`4!$wG5cQA==Os`XBSHHX5 zCNT;u0va{(Z#9UK6p;JpbV4Nom~ofSwT5hOr%o)Qu-w~jQ(H8xoxe^hA94mqM4T1q zR2Cv`gWo*Qvj;7LgacfBH}E7Sn|&KCY2}u5YFkPkQ8pKowEvJa?zxl zPybW+(D+Jw?MXebA%tfWsU2&2Ht;M2k2;>hV18%l^fNjUzG^lNL-C%VbZ_N7!3*?l zz=Xb4&%oh1IFQJ$?>M^VBIPGB>{sBAjUxUWj{+r-A_>Jc!4`tXDQ$Fm8YpQf*10n8 zCAk*q_$f|==uwsDv50+)&nDYG$pJaGGG3{L_;CgP;nD0bT$lI0Oz9`x zv$_r>m8{d3g6T3U{|~tFyY3cxD{St5wuMFM~q7ACC_uVvc+R zC#Mxo&LgjHR~pw%NuiEnDYRNe9X-bpb}^QCTi4EyX9tj@ZC{1bXBc1JR1Ir+1HRkKvBlVb52YBG>!crE zOevI|gIJgt<`kLV*&;{w>#7DPK1+$M0&?T%0iMo|c6u^pPh|sC8X4HG-w9fSD0{=2 z`6ushH|COzH#!KS{MbFeYLef~MoY-SNFhPXKDKq(ZtS$W{o>`fN%?jJOM9mN7-b(- zpur7e7TboypA7UmKMZI$+r2-Px~*}u!sPXrDN=5}zkJE$2K8)STRPg#BN-dnyz?g*sHF?J;Z% z9!jFD-k$BF*P&S`BnBYekeF}ncB?wL&3nYmS-cxrlwxKqW2oYlcV6fKdP8)whTXmD zx7Il15`)2i3~%NT1=$c$@I`JDAzUeKjxub?)kI zSxE`p2F~z$K6Dx*mAi<;{oS^Q%x}_O!r5qR*CAdH{_<7+c$b8?2cqQNtG@<{iM5U!w}SAy6&bxUx4nU+`mo56B^RbB7S*Q(0= zA8S#{8K6E6fC+hQSCWnL&O4abmAXK5VQlR`U{yFT;xA_4Na3O|4V&2Y zPv8BU$(b7sI9~WZ#TXyHBdraQy`%?5V^X>_4f& zpQ(l;)RWY27J2oOUT2D#=b4$G6jWOmOnpK4 z6yvQ%0qOuh8rdLozd0Q6ZU;#flw}IxI_0~#o<^HQUNZFno#zSn@6{o$$RTaR&}KioD>_BWK^k z+1;iY7yr*W>rK?`BS6JtS9zw@y2-v&>RFJNAuU8VHkJzH+pv+6i{9r@oICCBz5`@4 zaFm8{C9@-`H+ysB`Muk5^6yW2RxQfKAoZb|Sd9DQ0oUnAcB}GqAXiOB@lGJ-Ixx`8D5SN?!U#8;idu(DauZuz|p`b6q{*Lki0=)D`^ivq%PTQ8)$ z%b&&Ge4i;`xppC=;7N`CgoJp0U>HI;Mpbmho%yFT2b$0#%ce^l>OPf%>$gBSNp z6*2A@c|2EI-o~OW)~9;4X~ZnI%wQJIeYcPZxmUB0J}b+Iam++#Nc$Mjy4UvDpJL7V z!br#a$y{3WGlB(K_twqql-{%N?!}WVJTTt5y*6Rmpm!AN_dm`vPZn%#!;$bQ1~XuO!-I#(5#l^hP{3Y;6g zb&M#7ZCI&dS_&HVHzSE_ih4g3Skb%+cIB0i=ra+V)d%Gk zb%$G8K^9pnX`N}Wm=}vdwAU0aO8c~Mp50AA@ zgdRe#mwve=%s$&fl64a?-u5}fU+McqT#BbuC(aDgb4Sz z^I8VXcuZ-);9+k6o8iIlev}6Diyr$2RMc1^Pm8GQmb$j?HWTJP>Mjvu(ht+nZ5y4a zh+xjvjkp)j&WYbch6XR66j)#5j-UB(t{DcmWsNJB3E$DI6r(BpNAzo5R84}+pq8x( zwtT5HXnb(+dXUt1aHY9LP12hT+~WM+Uy#yXL?TzRC90>v%*}k~ULZ}GMmK(sj{{@xz#iwc0POQsv&td+5jGg#LSqp$; ziz<2$QG(Kl5T@8CP^@vO)7|Q)Z!IBP@V3`+H+@m#;-2fqlj0J{?TwUb4Bm(RGloG^ zL|8M!n>Er|(D&LF4k6bY3_NtIy`KO5C%)M1whil%5&LR#M-`pF9}bvckPae`Zo~vE zozlffJ0t809NJLx_~Ye*7-)-Ki1*@)>>&EhR<^Xl-Q^@ZJete)R~IP-t-kfB+OSCKg;j5SOrkKXL$I#O z=E^pk336jJTb?R`i(Vu)bwt!CNwW4u_QxT{dIsCUdi0LBzq9jFU!3S^gO4s*E{r-` z$UyAt;#CH-G#3=!`aITJqR{(=hBz43$f0n$pH-TwXj1P_Q)zuTe0#AR$i=Qnp3owC zBj|?|2`&h4lZp|?<>*=Rspi7=fzW=t^dKk+hb8Kyjpy)_5dOk7=^Ug$Q zDU=AA@R0=Qa)qUI1YtX)t6-r9W%+s|%caM=@IOt>PDzeLjPz&vLHI)w2 zLVgZp(IqQB2KgturCtR}tld%%9}%>5*~(K(_&v(ntWX}se#f1xvVB9g(LcwSU-{-(N4hG6|K;byNOs+8FFVx~+Vnf6`oo~Lgk~#O7Q7~*4NFBw2ih8& zxPFJtx^taR127&q?P6HxmAAi!-_cBr1}Q+AxLkV)&!Sl7di$>$U` zeX`iHrU(6x;&l{T7N1&C9uAtB@^%0Czzf-MMgkmjV!gysAi z5T>GL{nUMosvdm}IjpHCuBTwWKWZX1WuC20d!@fkjGY_bb==)zZgv)vbhbQWumR0T z>FJw(KwEp04*`819@S{Ii=@zL25}?hKDtbCr0Y1Q3Q^et$JUfg>R+7WIK;bJ{P!kL zh_uo_Cu561OfAiF?`97Ry>~|Ph=1)_0v^$%r|9+5`@P{&#Qz(=GQ`X^c4owgDuvqbXs(%)flh-3MG^Ia4gZ@@b%sfo z<7>l9+sg}L@~a&Y*-z>WOdKVjEIqbryL!JA%%GP!CpGZ0D(gU=LZJ`UZ79ih(490^;89J`2&BCHknpB#V*RV3 z*hxMM{{tC;I#3c9-cC8E(&aUJ>`d;lYd=%(hQ0RkNc2{k%fvEjG;rRs9#8c>KF|ND z)9|&Ur3#KmUm15wJTF^6#LeSK^`r2Zfiu^&_#-VIE+w$cq{qv&ce)G^ z8lKD2-eIV%fGi25C*i63J*Zq&G|EugU4A(p0y3A!jqwhMD=F)V@)d4p8DnF$*Nzw* zlXqkN1Qm93v{%%wPrxY=45D*=G7Y zD^&1Zy`)5rm#`VjqPaOlnhSHW_6jPidyb#r+26Gr%of)oA=uYKx928e_4xBNl&a)! z&%9y7p`h^jKutmT$YB_SPopgEB2CKB1Lf>bMcT4svM&@jxx_ni!av$UHMBUf$-h-& z`%|4%c;TSutnUG4=V2a^1RTSxWe-M_m*sHz2->)0^>y(@sK-FA0pfagw;S$xR}iF) zTT@TcbN%to8&?5r+18rTaHKv|npGDK&rz=!tzSeYmLRHv=!!A^l}B z4Xvj*JF%y717GKIv={`wR|f)6qFSMcR7wP;I5^DFLFSPQ% zOc1SPa&rfDLHRxv5V^hZz=gv4Sc8zm#?^I(V|%)wkXI=&(7HV=2|@_rh+Alk2aTy8 zzHz!@FXlmZIO!o3g~haj(AjHlX?Q%G!S_R#53BpH!=ol)lN{nKQ1>vUGMk30){`uv zb#V&l)$WR0+!IGW@H_;OG^aKz_(1gY9+UThCr}3Lgi$n9D2o<4?4w{@%*6r49fvc! zzyX!`Jj8dnGieNMKlL|f#{r?+NpSuY5$-c=-GYL}R#F948ov}H6GH+y9-M$F*p#v- z!jatnI>$wAMI4sth!v0;ySeLPt8cxh?btD{^23&LtLuDz=(s5`Y~KZmcsCqe2IDb0|XD&We)B_kcfcz;~r`oP+4{pg)^jkhI=lUBLD%Vr^DU=L>UBx<_4jFdoBJ=P(ow9Y-#TTMfQw81O3V?QiD-cspA$1Wf@i( zCjUs+7rkM3nuNDZqsW5J)F6 zbhK-mmE38%|13l~qM(2PgLamfbB6y_HS9k%u1`%Zei7V|(;a!gXhRMdT_Lh5$wOv;9)6K2ti?-#-#W_ze@; za#iT^0ZrhxZ1c!=`=6n;%T;9gv{ztgEG0bA}~<%E!8-mqjGq zr3rH8X5p`8uQj?7G4WOzxg=HJu)x#!|?6jY(oMNfYK zEr4Uitx!Dkv$N-k57SB`%dt+qt3fUQCXNefmFOxopNsP4cDJG;_AS(=HScc4 zT9sr^C0_tV^O<0kc(WYWsVtz_RbR9C!_=I83KT1od0Cx)k^}-ZMjvHBv8iphnha9V z1xX86Ni5OVuK&roV*$M$%(6|EBCA*|%{oQ_@d2ip3#*V}f?Saz?0!dx%{C_{3PCd> zYsS&Ntjng$@C-ps2^ri0Lg3TpmX=ct;_#v87SJ&f)5w1wci0+?zWLivoAt@h@o4FS zl4MPk<447`R%1);I3ibK?@aSI^;e|#VPv8D8y#B$eeJ-T+ghD3Q}U4NXTRmeo3QFi9YHG^4W|fO)idU?3t;hP)emA>xfgyDj<2vY3<_wAB zTu_~60lWEATx{vFg5vcJEts4=F?ifZHX@T~v(QN{zOgEL?TJH#aMApw<4G=x zA(>Qp6fpM`i8x3`AA;W7Frc<7qIm&k1v@jWODhG5PbFlJxZdr^gMUKjz+NoJIIr*P zS$S`f|D4rSHchhV<5t(dsn6V9(iCCWHCgx%k5Ch6iZR@{({=vxZd6z3o3JhK%L8b| zFj$PE#bMu)Hct*L_%ay-*n)z(B3T?dC9A>c!Ke&GBk_`eJ21Xvc@Pt2eae`|uaan6 zx-0l`bCZ0pHtdXsC?e}wB)0w3euC(7RiPP7ffO8Rd^P`1@4TOqr!95U6t>X3b5E{S zm?g61$ITM3-vo4@Q*_Mkb~F-@B##cfQtfwbJcL^~d!ChS4gJS}PY$G<$k!2L42B2q zINk{fNU){y%RCvx#SV2L7T%`0up0Smp-)j)a*R{FxAm6Zg^)aB4Y0BGCxyRR_-Sv& zt8<^T{=^e3&p}?Js%^_w)j~O-9v8gB#Y$jG!NG z9L+q1K&g|8lupx8;ZyHYcI-cP7ve{(F~{-si!<)^MW!!nJ1*((h;tOfn}iWO8}c#o3T z{%ANT;!NNKu<_#o^({_}hsIq)C^F-S$7%jNaRIE`3a1{qD{AtW7B%qWEhC5CjB zX_bnr^J(h@8mOr>*b3>Y_$WVjF1K#<9JI=8PKRp6M|7)_?Tqlz^_?xi@VzG42DL_c zhNH3hUB60wwl|BCbirQo-mauM)Pp7rWMo~O;lRNp?pw$q&C#VlB09{FRBM$*^nfD} z_0n1u{OT9lPCn9?fR^a2K2pj*p6j}E=rwwowAsEA-28}FL%<6(zODRv8oDz(U6_Z~ znc}V03taE_sR((#hB&S}M63s_A_BfB!s~M92<-4-NO04_VWVD_Uo)=dFNv=*4}}-% z{f!5sN>+N`p?ExCkpT%Zu6SqK_oC`$QPKCmC8mCb32iNT&9;QGKc%a1NBwN4wqgEd z*KOgM@_4LcBRa|x1dPM%42<*3XieZmhVW^#KAQK?v9m;MlFc`aEzV;q<1jMq4CJF; zB9!2PQ!Z%xa~o)q87}x`Bmc$fQYli|w-WR8_TVu``#@L?k!-?FbTyE&9-ymr=Z<%E zAKn77vzMv1NX+`wuGM}qJ3n5=@EZz%Eal12?$1hCCk{q{W~L(p6ue-1blq#~udt~h z>$OdU$)?QT@txCvAEWbZqcS?eA2@1?F=N;%F0dk)x&Y3)5?WK;2p>GIV9%MJ3w z0b*5_@SVwFUyk&&gCLjK!!YvmYtkYLlTy%gV@=T&iY(*lrSmyxcdbri zaS3%}8y7gn0mi5)7~zmVXQ&?_FOYIr;L<@vw4VzY?)m@eZUawbldL~8zB47deL?(A z)J1uSb%jp{Ll@3b@gx(iM!)-`lV6rL`fPIn@OG9W9I&bYDUN|LUH;}r)M<*4OH^|y z-eDcjQY8E=+CMLsJSb9efRPk_ZpjZIPLW!-1iJ&}LJ&Z`_(D2k={S9(?w0^@Pm9XWedf{Hs zuogb*ZZcCoP#p6yqC88UC7KDZMSph4Ng+3T==-rn`_lxAApSmvnE=8%ID8YtRqDIPq}E*HC8QcCBw#mk!; zd}wJ)`R5JyW)ed@2G6KJ#YEOpt^rb5XoT!EtUZ`{z`>X)`j?tH=8?k<;oq-sv32&P z8n^m^8S)qQ^hQcGAn`-00=?h{GTDq{&oBP5p_Az#PwnUYTEFqQs>g%N(;Z~qSwP9q z4<(#E(|X`E7z$h_4n4J1FlaSe%ApwT`-|>`I=wEj@O~L9$GrE=&ETe#;1f>RsbUf! zmKqs%;!GR@{qzh)Pyhe}04?AUoDw@PsuWHMpE*M?$;rP+PVUlZG>it|RI7Xp_@jUT z01eIoo?~u8e*geapgG>d<{TX*D{6o#9<0u&J^74_iEup#R3vA3ULlQ7XVkAoXp>@M z?K~nt3X@B&CNd#VSju8WcpxUs*8>-cdo1~H%B?L~z{l7a00!MueW&%=WbD;St9ozg zhYZh6ux$h34MNYt!~^jV(i*3B0`GyqMun8lH^+*KS|SD=R;mCIy-DV0w??xLj7DzP zLa;*)k&&P$JVp+RM{?U`1}A~9)-8|AihH{ZY~08~c_?mAj+~6qw))yu$lEN!WIXMs zheh>GNHer_u7s9I>y|=%6g-P9Z$7QAx7PgKE}r&9{ddi5?$j73L~23^B~hQ#P~-?F z*L9wz0Vhk;B_Z8dzJ9uZ>Oq_wTQps?cT{p9?H5NV1IbB*%$IjeU%Un z*sSsx3sC+Gu818|yh{FNrC*c`BACDiK2;?CyZaO=nl?S;WyXt#SMIE{AbK~Q2cJsw zw6io+rWHBfERmu+ub>Nu&-eAKEI>6$p5~Wnqr7>air$l|(b;Ew@{G9AVXx@hoB~Si z@J&2a$=B%A4nY|*qru)@m3uopv=QMR8HH#v7qf5>B!51^dZX2-$??>gVLT&os|C#| z56ZVvKSdQJ-mD>hgjd3^ViBIc!Q!ew1@YuZ{X;Vj-AZ|-hPUz_d&5eN|HFXDj|O4z z(tuo3*x2n1HS6K~|D^ZL)`grmxJm4iWs+SbRp|cUMijLTLZlG1^Er8T=FWg9HUE(` zi@0}i?d_DOFCs%B(i=Cc94e%q(fPqOR*Ta=)f(wrp|D@p8UevztU=Nf?P)KN*r#Qc z08LrcX`I)32U)+`Jw@oyqdNJ01}B?T3rawWg0)7m@2SJv+)uA?#6E8=z7N4M!2#yZA*Kzc_RL9J#W1JuZw+I4tQOPaeLi@-)zpBChHQn@IdZ<+Bb|Kq z1M)=mPYoeKpp*ij{<~Y|r4Hd9LD_@(+RgkG61B(m*l7sxe5$9_?N6EJtSQD6aoe@T zLwTPrPF2r7f)jINcB#j#9uTKbzA(qIW)?TWWCAFmDF3|@LZ^Kw^SxQ3MPoHML%_F9 zlB28;5R;mq%IcecZj93zs^tp-6e8nJ(pYJlNb#k}Ch6-SepUJi8d}`n(^lV=Vu?`M zG{mJx>)v^x-1gKeax5Tz+z>2Bxd0P-x|hkqw;D=kR%$qc9te@Ci32`mk%4g<+Iw|1 zCWT=Ci2k*7h#t2LNO(}I58%O9RO=4H^A4fVfw8<_2K$t5_E;h)Im~q&)A8uoJqxC$ ziub-axB2{p&wM^XsJx|cR8XaL+=tfmR80!ZNL=UBZ^p zS03TWjiR&ia=u45`X%upcn=+)XZ*8@lKFXWPUoFaW@~@8E3)OHM(Q#Dy91!Q1_e&A z!Z*}}@wN}?lPyGu29%c1p0n1`$DmTeNPL#bP8(d-L?S!VFP{gmiOtp<$DU5Fb*nV{ zB+{-1TR6G~25e3+v`=N*N{PhV-=GYEV0EzXv6y5zW}x?3wGQ)flYeuqu`-ef+obtl zly9EDfpF8cePpgeda3OUHpOl++r_RFdrCNDWM)4q#f6v)@BGcrColjUH#r+;QEJ@d zFCGR)#@8mSaMWLpjj%ov_!C`ea8T*klL~h0VgSVy9}7i%fAWQ(yZGnO+JT-rPQB;d zSRUDCg_sMd9&xztG}j-iY4z8u+rI`(cO~EO=<3fgZ+jPY(2ZpTXnuAL;jSV_}5 z_(`M89SVIm@Iofk*h~WP z!05}NezxhFG4}?sN(N3-a>bq+k63TphosIKFAI9kTPr{EfyripXo&=_`MkF7IpT8< zTl**^``;J`#Cm2z^&;*2ebLbvdKztUSLvMn+Isvyg*qiS zAH8yBe@uo$ZS$aC@Gxml$SwSXSzcOvW}pDExDa^`yKU)22Q^6Bj1(U*=^W&0)}h1ulCzej^q4@ zj<-B-6a$`bdUCeb%ECr5H+1oGA9+Yv$uYZkI3+^a`0ZzD$!FbWz#5%VwwKkEb`=R%# z`zPqJ*Ld03#jdxmyVG5m^ot$*nF#6(BwqU!)MIAS^WmW1!R9C$QdKU+yh${Rny-1% zfyA9{m)o*Rqu%V$A$3oHjOPLs^SdGSuH*{=Mo2g|4M=&Y>BIVg880z>6~0c7MdAlJxOH@UjjUl z>~M_<1;CsI%Tr>`*DAGgy27}BWq97Fo_SJEX*1JkWQ`DZl^kEhgQl~Sdwx*W{Z`K@ zLnCsicd6xkwMbwdy8z}gPMR<_!q%Xb9|9B zRZ)>aCU$Bcg;ViIbyT?wvmq>V?-YMWX%Q(v+<21~?Lj;L>*o+9eOfdXXt6pcYp2HP z_bVxMSB?WaLsllDP2s%|Dn6sR^UdNi?OZbdNId>rm#og}Ye8gB!B~`Ysb3WMd8-9- zM8BYMD7dhQ`uQ^+LQWV`$9-}e2jIeq&1h_cZSJa7%aNdv>n-VJpfvBl+Ovq3ta(3d z7STAh(*Q-EO>nIYMO|R%hRX+{UAJ_xC>@L8Ga}P zQCQ=us#-hX%%9`SOOeY0|H&%qDS)v6Q1hEEKW{at_Up^xa4LLO&v}@;O#U(xBKGnr}dlaXC#0<23)YBxA2`T1JFo1C;V`K|WTGBGgqWZB2Z_LF|AJ`cFOtsFNTd5=z=np ztns0R%W{5Clk5ZQ`41;bUa+_)FiT2q??DQg-pZc9nUB;eYfcP7$LQ_P3Iohi&VKfM z89V!tduspTB#xK#Vn;j zPXes2Nls)Ae^sEd{{A=a*C=EF00RI31~Kn**xJBsU|Ye0g9 zT>t(|FVF?k#ph|WEny!@rx5tWT>LP%c&in`>R&JIfJATbaS4fN}ke%cTY-- z&jw_n($%&&c4zStEm^dLX4LDX)r8L1_wmg7JFCjzk)ZK3n9(fhs?!h|cy8+uB{bbS zb6y7g&`Ff9Ogg?p)Y}%Gy!y-b=ODkbAeoNLYmj?x19DPlaZ@g_jDE(f4jCrG{zT4u^GxiPR5#87p1@4Nmt^X4d?`W8tu3#Vtk0hx7df; z$;9uNrsq^m>@+pT!=v91PIZ5@E&Ecc0hp7M_MsU1XNA#^f^0dX?PU9LklYApu68k1>;CLq?zxKsbYJLE%AWfL>+crz%awWqQ=F$%07pQ$zloBQV-soB2TC4Ik<(O?`yTr^U4_jW zmRhhC#N&|k{1Oy>^csa_Qvn<72s3f%446TUwXnM}#ZqE9=nl^g0h6^r;?HL(pXbVR zMkm1J^d2X_~QhMW3jL?jqk$PFpBW0|S_+ zM+$jrEY)JZ{ZD%{UN_>`#+bYKq;C<-Fwf_c9mdLhb3;w9{4N>9y1@BPcjM{zgPR?cmFr*nl3kD;$Ya)68q9fuaUzr9z$O1J zlx8l#-{86M??r+^2%qE1_|iF-MXv$SkN-X#u?``6a0}Anam5OlxwPFN)X%)~>0YpO zb3oF|jB}K**u*vJ51?Dt9@aE$D$72)KFNq=6npQwZW&9jx%(CPwX{c~W>~ScQ6M|8 zs*bE_ByLxZV}Q(`mv>p(fgjdJiI@}OVtlVj3k9K11QdJ(yam=3C*;mhy^LR!gp6(S z%RGY>A)3=mHWfuw^IO^ig2wS=T*3m)Vvdl@hrcMK{yMdX6mVi9Mk_=Oi7Ae8q}q8k zla`pJerCKH@)5T^m}0h($Fe|d-vJI$)miMPb}g2QPTE@SEcJwfK+k4F+IFD{HYs)N z(nY70O-!)|sXaF`)i+x?;K^qG(YIX4lGyaJ3fs~={H5%k6$%Q-RMP2}y*?c!RnUy& zH|c`@9#(JsmM~yt=$&=eP$x!-%zGO2*q5$OFmJ?ZER0D+W|4@!TEz9<}4Rfea91~uy1AuO2>zgv-(XDO_Ke&R+*$V(Poq?cD#4*Yt zLQwUZZawJ8kPYSJRf^AWu6r2J9L0El=kIv(3W!@dQ|bD<@S%g(Q}jB9BXBF?k+c6I zY$`GUvh6gU<8%T?io}@lwzJyrYFp6FqXAEYGA~;%jKvs+phK$Bjf2PNOwk=z_`GTb zrh=i|1f}dOknn|(C>RcvijX4r3DZy-0v|v`DV+sPAWUWD3^RMs-7e4rh;jjgu~S%- z=U^*~{|8fM(4g9x%1XPpq^s1AcE)5^M-Jy1UynD-!PuD4G!By9l&gxVnjhyfz^xak zd(M)+u~mhu)MbNcoI^vyPrLpb?#|pE6c)Rn+xNzS+VCb5Nfoj&h~EtvTxe`M_z#{J z=Vb#Rm!_IR%!k#L6>!)lW=G*}#ERhilnPa538Q8)Q!ll3r#-DO#70j2Htvkz;k;yb ziDItFK}%UcDX;Xq)wmL~2g;%hJ6%X)P7kzd-)Dx#%f7?%P*^n494{jnWnCQr{oAm= zLfaW(Kp&97v?A0l>`R1vA~HWy1mc%j>hjLSAy($CEY0wjP77gJpWWrpwjX~{9v%we zEu&VIZE8aO{_$1H#dUN7LM8f#S_WyP*YbkayrARRW7@Wf8g0He<_OpPl}_Y9_jA>K z&*rQD)z{Av!Iwsr%7$p|WpI|^qHFLN_kDCNnpFn1dhX6WWmIwR5 z!aNMHmV_swD>YRIODDH`081C6fA0XsD^1l{@pTuc$bo4WP)r}W56XHxD~0yjscdwQ zKN$41G|zZUl+zQA%x`H%wGC-d-C~W{{Rw0qlD^153h}(aaKY&{_utVSrh;)st43Lz z1?BQ30hh=e6sd@!m#uiWzi!Kb$q@q-s>OR1n!qrLsHa#nKy|@qRkU!%BsW%2Yc_Q? z0=HklHzkS;4S><;cZd){!L>O*{Zq@`GRND0?f5{u>cNFP8w7v<*bxg#3##xevrsP3 znftwU*H97~vRLBG_Uj<9;DH#N>h(DdFv5@Jxr9MsbI&m8fTlf&Kty$8Fo^p(&*mA2%yuzBRv2xf=SVc|aRDmntZ1H>L>+ddA{ zcZ$yhBvO-&qP?)K4?&y~)-YRbCw&UpFIYAd${l`PE-uU<23M?tXnvF_(RURPkmJPF zGw_z>wx#52L}RKq8!(XMRj&_;7gf5@(D)B@NK+^|8z}IT1m?sgBFc8P+JG|O58$K+ zIs^BA^0BHauouWq_ZvWXSQo&$y16dWgz=`n8i%2IoEDjs$ja!hDjYLvAE$QSYf`)- zb6IV5Vo+Gw@!bh;of!Il7s>hk2}2N6e+rg-%h5@&C`zH$0j5W#BZ>um6bfP*Txg#^ zcB3EFOp6Thw^~8*J~+jMBDcR;)VRn=&ZFi@fkg$xN}xm8(djh=rAd6i&^<~*9TtsQ zf=ZKK=;A{;h7Fe!?4HUsPoMH`+{=ahZ$l^obZ9QtEB8{$m})K$Y$v$6HBZKu310j& zxH>wQv9qc>**4t}VYW$9Ka5o>s0ws~Un zdwLqZv*1MSUiFyOFTP`souY~%Vrfv3B-7T0X25gdt^O(Ny5R!F^G0ouF zfHk{phXVd4>S^N;0EE|3v3u9YXo>5I#S@Qg)5%p&=;|+tFT`3`XcvzRI->Skt4ZyN zOX>lr(Y&<+IjP68Z+%`Dd&pk=qHpYs;}O7bh;x}=qsPnv@U*Q8E76b8yLDgtdZ%bf z>-K^jAlGy?1=-u8ahrOl;>u}af1saZ!cL&h9+wJ8!h%9Z&nCcdwLYYp>lXz8%KFb9 z4EI2GaU{%SqN9}8$g}x`{3=AFF1-X5HXAfa5`J%sF*!d<85x2r8uxbZxD(7iB{CLA z#jgiR5YtH?_{tn^pChj0aRG&aR=4p_bBLKoQx0ehL4HQ*j(J6MAgVG~ zZoSlTeO4|DE3&@7IEQc23me;Y*Sa%nj|GQ1j$78PhcH>0Fp>)+r+Oiga<`nT*=v-z zSd_|P8-YN|6{t%tSvjK7ahz+RSo>a=HghJcLy)$=$E77c8BsRrLSUY0hYLALn-KQaps_2?477NmR@s9joS%AJYId)2GDjPh(n#3l%d{bBiZFK+w+`Kflwe{yI2 zQ~v2b9Bnc7hRWoqUXfK8^|0X*#-S*iD?_;cfTnaKoWDqjY_*#Oe?l2Z4h#|VP~w>+ zO6`z14JW%Wf1C?a*~cHJ7WIPCvf7L`w3}%Nb%xIX^;K@X9l#JVMHpxNIrc=SDe$r)(BSk9s#_gw{vekQrn(G~pUQG9K!sL%BpR(w+ z;y$z=n{ibr#zNl{jMr6Zh#Eyaw24-SaNcV!YcntfjdVnME30IENrdGCkwghp*B>mG?=3C^}Ory#9#cXZGZ^J`s0Lfz5m#ONzFNeg1S`efuv|p>M>Y22feVyAqANbPvTkGZO|`mbpiL0eJ>&L&q&(nX(4SZ z`1O0qbVcVGtZ|nt&m~#~De?_+#|zH@PRHdW(viYq>Aqf2tI#>sVp6%`gR+9Qu9{AqWwUZy?)wVfIxJg+yH5t87BNLO>Uh+6>Zj308kt+$_BBiu%s4J_Ksq>Np zM9R#ypl@{xpGz-6G))k3K`W`ARLhJEnex&}F#+Qlr&m~w8nM!epILVV?O21>-4D5? zIByN{9aAqa3X85&43?PVQ_rTjg3Wh`s20zG6Lo5~K4^9FNU(le}^!t}e#Nkpu zDb?f`L4!@C5&;Kp7;uM-xCsBjn7|SF&|gt7#@lWXK;Y<=%5Ss;6GP1F+IFKz7pL-b zQvXb4U2p(DJKc>w-2ZSm?;Ge3np8qk$;3C%7F)-C$_J@Prv16-^NBb2h`R20amPXC zr#t)R!_PoSH>0^nOOV&rpa2GM`|^FNPuQfTCABQn;G>uUq|wX1r}g#4>m+#~fd1bS zOJSUp0tWftSuqsG`b4N+fr@5e$utGJ!gXMN$bqZn=c?}_HxzRO`^Qdv?4K=eGrI@9 zn9)YwD4Ee1tLMB?RvyN4O!97+$GN3%^z&NhoQdkLi|spgqLx>tuLbq?u!vYn?!<5# zB`=8spIYcMhJp{t)L(uOho!g8R@SPF+fv&`kiGx$V}Dw_)88oiHhnUNj``*9oZIJt zwSja}26x2oU}9T3#B&5`NWE6rBb`MKTtaZV@0u39I5L7U0ZeOcCoAeKFXrvVD7{P> zNCy+$oh8x4=y*ULoEa^#O^M_`*R%c2)fir&IPWTr{#NyX)N<0`IZA+C5 zyc+z$6da8a{>(#DIY2q z*&#F4NE=rZEh+LMz?zxIO8@=xNsiaXoM9E7qavejq{f!){ONhhf+jFa3|_`96JAJ( z=}n?6FyL>Q#4C!Uk~cnj>d{<7w9VDivzie}Ct3MBBt3K#b*4mLy6Gx`%Yq4 z35d!&-uUi^pXv%-a`}t{vUzhQ_tX}bH~oaUwt%z}X2^>}<4FKe2sPKx^Sm4JYUi63JyQ0ojUH*lgh$6tVJ~VF?NOWFsyuH;&Q_EqZ47w0& zU8R4?wu|y-ks0uS%#K`-vtJ~%eK3luW9(}Yy;)R{s8&$`zB=lM1u8xmzK+9!yF1PQ%!n)7Utg%HfDI608T+Tt~jpeOU z!`a&K>uG7e(iYxKcPf@YPo`w|Ftxs^#4Oiga)8Rf$WPfs;L&&u2tVkx7G+}aZCCQe z+2&N4**{92@qo=gOJDIK2N>qY`oie@HOm3YwUQMa*G|5khxd-%l|^>Ar(kq}Akl~{}0-LlkyGl8Iq56yu zKS-nGLv`ho5}rkiDBa@|=G-f&4YCiUp-C`Uwiq1nJU~nbPO)XU1XTj9ps1=+33qE{ z)zS?5Yqw007kG=u%j^$@5w2v?ryZ+>6P2JSPDk7QSx5H+>W5n5p!Tx^h z7=v+%<1}bz{?H%+jhORZEuQ0`UXpgxu{iwpgJh3bgSi<<;;FbgN6Q5zC#k3JEq}8$ zYY50Bbudo-un92KJgNOw`v3QO)_K_mmzCrQ3X7?tRkh$EtD>}JUt9d7s4H}9xkm`h z1zj*5zAwF$6*?7fN?^%x73d7F(PVXcx-2HE#a|VJPTRSY=k24k%Q$y1wsCT?!_oXv zil-|$(^%-r9D60t7g$L=Oi^q@>Ah5kDKnRAjG*^cZ?>zvdB~l@NnV8nL7)DFLAj9k zZcfNsR#yyB6;&eY#GpkE0$+*>&n&I@%~(SAmdG^NfSmrjvQ)yzRra{N{A+YgIcHd@t!BTL1;b>?wnm6g3Xs zKPEq;019<7B?a$n8nhyJ{d}N+?0+NrZ~W@)h#kba)dyr{yOcS)jEwyFJXU7IA2*i9 z+;P=1FDpvWufo3QL{k5*tblz_?2%rYffR2?w(?Yc&d0&_7-}h-`_=mEPeuv=wgUCL zzX{LXn_8Cg@7mf9kqdupf6rBf<&(xz{1o&%v9;Fn&zyajwOh$AvuJfnGA>`kZH7K2 z9@|n9d3+(90{9*`2}(&kOgf1PEP$AV`-C#?FTPDiuC*B?YypM*e2tXclh5YBS0Npc0v$X-rPB5Shllk-2khY8%EY+k4Q(t8RGNi70p=vtU<{6 z=@5)%%_mpD=+{q;rt+4lw;N-yhVVQd4@Af^hGKOkC>YesrZ&_V)2845X+(wj!6OrP z1M+%MFs~qLDf`Vm&!y=e1NL|oy2S6tO-%RcR^JzaHMFWcfS{oQ7rwNz#Xf92O_(wq z&!e@m=lv1f{T_u3#h?~~4&&8tcu=;Ufn&}wc}%I7%FRu!!78{Yq@=8N$wJkonMK%$ zfk%7EPMpQyaY{D8_*g(8*f{Q5Vk$aCZ5>1>wHui*LUD;~KM@f?_&v)-)kodSXPgAT z@Pl+?{y=ilMU`#L-;-x|--l1?=Hk@rka)`{%D?f8PRUdt=}#7-@=axxF5oPwye&!2mb%0T)`qA(80AdG3!8c_ zkEVsP#3LRr2p~&~6n6qCKlG;$S4=ku=KcZo3KHGisFMHewz$Rl*C>6yK?E5t1{?;b zdf}Niq87VdMRYMfyBajZ&=Ye%?;pIAif%vE%N&|bNsyM>Br$y-qn&Huem1=_mVI(v z{4eFFPe0^B|DJfVfilQ;l-H7Y2Qx4pz*z)Y@=iy=)MmrbME8BTH94ZshlgYO$SYv) zo9l^XG`8UlaFN5XoVyg5A#Dkeb~gdi?hF3F2WfYju*&uG!xzH6&aS_A8vPd~!C&*E zg&>ab=vl4U)XFpk&&7LMI9Lu6wW8EU==`TTHKL!^Z!r zzC&P(j!Y)Vbv3bf*KvVa^X@1Wu`2vn>1L zzcm=%aIsQQy9_MY#ndyRWoF5K1ScX8UHM#ayHo>M^!CRqS{idQ9=h{Y)XQ3Y7{OIe zEs`h$DntI4%Z`Qp0Gr9(#Ou$P|1wqIYv&38O9_>jChI7ZP;ETk(1rTcK`>I`F0%@r z-tvQK?SWq54%V)BN*|K}wziQ$jA`!+9=HB|a-w+O5jqa|Ic+~5QV_#}2K=A#OGStk z=%Vh+)@%ZN-371%gi7X`NOead1oP%FEE4>1EeZZ=5|#9X)C?q2I(+@xEfaE8+#{u~ zcUlTi-A%gF`26c<= z03ym3WM<6`Bo{V|SZAga^T@SboiFJ*ls^TPgHY@mqqm~50iJ}q zpSUjdwqs;z?Caw+%nn!4+-lfo33sJZgD7p){vDJG#8NySK)A}Q$!T?+;0!NNUT8&D zM0+ph*yjw?+XPTlFrY%`4RyCbvPV1&KmKA|HQBptwYnG7`0`CH&GC+{)EoKW~1? zomXf0)o>Bsy2GY|?%96o(;5qO`3wYG}v%L)D0qO8x~5=x`pF{_MnY z@;wOw^&@&qs?+<>+3FP=o_Shr|3o@D5drk!Gv9Cy(<)B*@VhGh+4x6avq!oE7iE3q z;q{&mr<}eg)xA2LPrP&=n?Ux=U$2*5$s@xmDmnfw_GxqCm5g)h;WO3;gBx>_tbro8!3UB7~pbO*cAj(uTAbPnp{lCN~6MR?`NcS2_0 zWu5zlIdpszd!!1mnkTE0H7@iPWVexaT^qp$3d)%9_;!tn)x9uL?tPnXV;+X2pbxI7 z`t$zCV;FSn6d)$Kq&bdM-UFYq(degLlyTYFQUbVIQ zy2ZmhCeuVGhEiRlk5BfL@-EfN{X*(eQH&-gtKU=*0FM$zgx$LDXFVwCHNf~+0n(kA z80^UR0maS4BSD33#8Ap&x#q9>J&~Od#8bNAL3P$8!rtATb*_Hc@N_y*4Pb_gn*}1U zeair%Gry@wpGmj>ba|v_~rrz9Fgpc2H)AAP(6^ zS%{0Rm&}-7hH!Eo9vLlj+QFQ27PAv(uQHYOO}PLLGgaR1Ky*@a$}lrv3FNW};}yM9 z!ds6f^%9&pG?pK~uB=S`ybz21t1)@ZXl6E^nwMhPmh3XLg2saC3Wg2atItF{vP`4^ z_4ZR>iEgA*-Z`+%VyKaDHDq-I%-;aa;ZjS9wNf=mjN#=5M}rC<`z!wtLM`rQc3*^8 zdPB#Z$vUF??%(87X%+8wHk?vZ9sQ0^$CwvBzvi}V={RLy*ee?6d&mW~%?*~zPQadG z3dP?FktQw~EbTFm7%G&$BX2)>X*iY}_?y}R=nS>0r5GNDneCv($256XhQvdgKHnaB z5!2czof{iuDJ7a4SWr2UQlvG++YI4?hLA(5AWb!_MN}GAkZ&t`g>hIlTH7)maVM4M zL}$#Qbys`XE$Q=A{IUQ3tp`!XH zW)p5Oxq*-4sC`O3SfX#kSZ?CqL=27i&;?6Ki1LxMw3Xwf>tLr3?u4z&qx zdZVv8Uk4~Yo0Kj#Hw#CY$N)yKs}|39cjoCaKM-3zKm_DeHj`aL;AC$kt4-Ml+@=^J z#Oa}3cdGj!;C>|g>9KMC0)z&5IPm79(Xoq_vpr@O;_s z1`F*ibMi6t3Q-{#l%@PeX6{1L=o(M`IRB$C<2m%G6X~+@X|MS3YNEydR@Ol&*R6^Y z`y8BB#!fVkj9eMa2T)Xxjm!zBD26A2nlL}juBRSY)49~jh&(5VI+J9b9DKmtT1d2!+-4p+=0^m{jv$AKeO z)ri4f)>a`r*;UK|Bd2d^ax{0Gum+*EXhdkRtUw(My>mMsI|ozu$}e zb_h*uPO)AjBR7!{NCu%Y4lqj{%|fxuFYh&s9U~*a>P7nGDI{Wj(Nvw7RVpfvkH*=M za;InRFo>?2_{tbq)y>CTQ^cepgzSNjx^wX?HCJ?@Wof!Eu6T&&Bh#T?w``0OBj33? zX3}d*m>xn*${9|GY070Cecq)vAA!B+R!s7)(QfxKx=i}2Pdd-pul|fb2U5fBxjLVN zX$P|*{&vO;64|+=Xg0Tto)DE8TTw~q{@K51a{Me!`jSlK7~Ddqk>XrIXmncP<0+pI z6U%26XO`!!taMI9Y7ihoet%gBhqdHc9-d8Ew`Ju-o!_7@uR$csVd|WzAO9F)^)3S= z&+_Z|Rizrj5w*ZkF(ee(CwVrWc?3Dq^KFKepPkX(7 z!Ok|UQVPKuuPIF{PuII(UB8PTm-KT-~t)ZJqO8RT$YNGV>gJqDCKmYz_A|d#`3?fzK>ust%q#D zON*Y7c6%)MV+Bv=HT}fnmG`^I9YJtQhWP&D?EHAiGE(>G1}5)H4Q-VC&rzo_+IVlY zZ=o>kd=m29dDb<*vm#F^W$XSzBvFM$GnEaKzyjdqw-ihoUS-ZQ!xe;`emo1mvFZ>@ z8YtGDtPZWds}sT-G~aYKWg+WhuTa%-8L8>D#!cM8XxV#uDX1IjxU#qCE6(J;wz<%o z_0N{cH8KAZ%UHGhkF7S$mhaA(s1IYc(V1+1vs0*zX-AGGc0jd9D7Z%*jYg323khwF zlU2>eO~LIPJK{>YHC#-7Na9+ zvY$!go;PZz`Qx}iQQ;tTj~|-}7SMjkPjd#%eF3I=t+1_m`L|%L7cwuA_i`>3Gsq5? z&u6Z~Ctl6bdrN0F2Bb(mF!}6`i)tgq>8voHu$zYjlns~YX$ErNtG4HW_*~M{z7hQP zR=d{IaU@rkoY$40l&&aF31%hN3Qznh0o$IL?Tixb-1E2oP!d{RzF^=DtmXe)`B-sg zSE5zO1ZTr>{M~gEMcn{OV$L$jF=B$?`;sRMzq}-QE;x(& zp~4)$xf91VU|C!?EtQs`joT+DUqrejKLf7S*VeP1j_Upln8--at0~M6w}jjJ4>I!E zAzy{eZvKNp-1{-~sTAkRGMLgmur|%8t{fZ72z#&@W#_V=pLgAsrOtJO%sE+J1iZeT zq?lfY4-iNFd|*$CuJrr1-u80(oYdcPMZBfabjIvTMm}x%)#d1+;|vbg|ir zbZ~oLA;#{&8c=^IZ816775N~y_u!S$xZgnm#Yn^Jb|*-D zw?D;cM}ORC8v0sDVCSGAshlcZ$&lF9J88R-B)aY4K77g4v;Fp)5?7BW&Jpzu8>xA{%Q=3stT5+AW}wPfG!6pG z^#T_yINU!4F~SA_jUOg=OxJl7NnL62xSq>0f!P zF8h1hL-Z3+LeO%G4am)Bhcy7FpXND1W-Bs`)K((TAN1AqR7I`MDM>@|{f5rca{7WL zd58p^vv-P^q`X7_LcGlcIlmv4uhX`uz8Z4%Y9%2yVR)E8kipRdJ;1!$M zc+1>>c{_xe)iopGyIaWl=s}pz7N3eH02|1#>z;Pp$qbSw{50ME%LK(@BmF8K^X`>7Dxz?eS5q!&+8|-2A>bAjT@3L!ZY*6!2(_B58^G4v0DolfS zT!uNM;DEqm^>0q_edXqdK1`pV{kfd5Di=`IBCd5>f!ou(|7*+rdEIk)L^gb7@fv3wrCG9IR0)U>>?^D!@|Av!q;)2)rulWq(C*jdq+0 z2UjJ!e*GvliO2e96)jKj$d^D+e}*ZeoWe2SL%u#;E{0<82qYVex7xYkudTZbg>-^K zSa_8Z3Pr^w;9#n<=JoNj9>jv}-$5zCFg4}Te?JtPD^j>3sTYuh$?8os#cca6e@ zo)uw^+1QDLXP)qN{oM3nLsE!tQS;hfXl-K{oB(33yNm#Q_)bzQR2g@fimaU-{E8W4 z&|49ZJ&w&Txtq$09G-BdSA1QzI|YDYgK~1A{{f*AebOW*k$76c=`;>_f;~LZlo{^W zr&8ILBon4|*1k)``lbN?y18R#&x2+%gl1XcAWtz^d>qIZnuOtO8%85dta~mQ<&=7p zg>{(@9vaSqu@|QV&!rZo=kSOnMX`Km_rXWayd%;^hd*-<|Mhv0Ffj*Sc0a6W8>t&w z%7LupX8^axH`?~<6Do0MJWfP&A0R@1xF#aA2`sZSAftD|_O^s;LG{(xc8->lBTP>~ zIe98rr1wsUH`L-MuA0svUtG{M`(o}H@Uq)2p5DTxhUhjA#e1FyPz$sQwk}o}kXaU! ztZk_Tui9Kvk?p(`aU|z;TW3o{n+QhBeL{D0Gbc%3j5#;ba$=lide&>iSSV?u$wL^_ z>&@YnwuG?L!~*DcmSZ@dm-I$J@@sD-J>--c=2sRTbe`!cq5U=9W91@ zSA`vvqXrDMNqq*WU%!Dho zV@7Gr<1Dy}S_j|VvwM*cT~bcvaS?1(2#V^=z*Vksm4O`E9ZM-yBDC^}SCm+OBF>%% zFXEhquE3YR1DHanIHGfl``=+6l=i5%<&>g(TP!NpbT;eQ4U67AI~h!fL;FIE1eiu) z%zVR?Da`2=9WjUv5mMN>xbZt4JDWjZ?8)aK@E~HgeYg}&paIV>vM$^5G1-h;HyBmU z2b_<@N$-+62>d15{&!qvR|yF54;BH9eW*IZ9gS$1IPvEi z|6=n+JjmzFJ7WsY2#wppw69RjpjI104IEP^B^@$jkSxRb-FdKcN<_*$?eLX%0F%#tN3x{O9`*x$r01jFW!R0dbW676B9;_PZ=0I$0Uk2( z_D8%Kt%sSnMJ0n-tp;GKV2gf6uc#DA0i@Mj9`J-fQ+DaPz1+Nl*$W-8<91C= z0av@VD1^um8N<2v+!!UF)mGz-Ss{An2k(qBXGSbpQ>0Kxel)G7mc4v@eXQ?LoMWrA z>P19yoKq$dk=eprBiS}kEWQ}UL+3;Ct=M~w$H3hYfP{L&!y*YzCz?9_yUJOOt2s z7~h|U;E179W8uzM@@oLaMW4(Us`dVyEE?$!=y_#L=9Xj{4}{Vns23vN8_7zVhjWNV z3BnENZ2twQ!jZgcDxJ5b#XE3lWms!z@Kp{n(bc+Ov1gp`esCL4^(7wAiHwM<$VihTbq~n zyA0n=OSPcbBqkg!{7xoU`n30#6CV7&E6d>cdvUCK@CY}sW#cs=Ypi37XP9r7?qnpo z9s2lIxH}SDpO+ulT-lrSWO^M`@R4pRq)Xii2R%J>3Z7gAX!3}N zlmy{es02Gj@?NlL$)N^G-;5Lx#m3-lBaqAvlhk^nW(~>W;0?Xj4EgIbrF87}XQ)bp zDonE%7*RUoX<*Tty$Eyt@VNdu&fQdTNkYOzkCG}m6(HyTAht2~+pdIbe1rvEVio70 zK7i4Z5u%kztMc$6hfxCZ24`Grzn(bIt&jrRyURkFD5Ko-iVb0*%J6Lppz8R54o5#b zk)8tGACv3BuaLWXge(;B0k6TodS2^|uz?%vD@6WyJ)3Tg0A zW02wp=l?hN3Amd1`({1Am%eLog>JweGD1hH6=#)S|6Uy+W3?)~zZu#AmtT`kpX|%Q z25T7w9@|*!-}=I9USv(ztlX_Au_rI8(-dX0)PhbX*rIh_fF$53s^o%~k-E}Q#|1w5 zs-Llc@ZHZcwK_#Aun06#O{FF{3MCHvEccqg?xk;5tsXk3X7&vYCCx*dt4?&fLYhRZ z2xnzI?{~54FI+wfQ!3|$(Zp9Js9+kJ zG}cwiv{UigtR*-{1<}j5;tqn}N}(jEu^P!jA@;2h5>oEHxq2^KC(F{w9p*;v`dzVE zr+D*5!85y6ikeC2`_^$=+yFj60v7;L-D(CW$>WRs-cy#^)=$#}LCAk0tJ!y_qJ__g zQUuZ5bQs`W`2N+4H_oh;vOMv_l@Cwsp@1<4X3*VsTjAO)XV@eB28_)_e+D*bifXkE zuT!5Y+xnlcgDz`(a;2>O3D}?pIpDkl$+EktM!0WzgKBP9n>M`-d6A4iDZ9hPg_1o{ zL|!X96cNd@CTg^&&XX#vbxm_tLmN_@V)0wsWn7^u&d(L5E0eb`!^1tm!yDeWaG8I! z7`kmk;Xu&xf);y2ft=uY99*AmPs~9abYna1o{JMcZsyze3UGQgvLaV~Oh( zB96TH&A&;Xkn<0Z4Em%>-NxIEN|2ubNw;$P$kC$AW_*$2xfbz0D3HP}V%oC-K7zGirp~U;ywHajn?32Yhjpr`Q|}UM{4BIVUH?DFBL>|z>zc|tM4yM zy4psT0pfJ-8##`-A{CAj)~x96ek<7Y>kLK7Auh#F-sa&<;9H(9eXl%jOpY-?MOaU<1ier{@ zTM;V~!LNM%sRwXX(XjKLI&pBz7H@)z)tNbLl zgPHYsq|G{%Vi1f zk2Ft5(QT@CL<@xB2J^w6~?5pN6!Ybc$J{e9i|kQ(0q$uCs#2IbdmaKO1?oRqGX?1=9Un5;O|E~@mSQHvsYJZl+Vru)3v8J}J{#xC|s zi8I^_1`{CE)5Tg`I~N**6T7OfIl@SkNZ-AFB@!^@#mptxXP*}mvN6 ziDPY5ob6m!l_tL5{S$OJE|XJhN*73EaLmXvw8&!a+l;fn8*T-UU!O?Ns=w_!nnleG zZt1I(u`aWeHH`KblVLN|Zm<;MZ0wWr@-#pj-|8_1$^{tXzW;rK{Hh)QcMN@ANk9Y0 zmB7UIi6xo`D)D}68n1#8|L~E<6lmFoig#Y4`Sy0$npgmZ{R0Sxm+8+}xsCDf-PjpsY_f7Pmfqcb z=IgA1E{%nO-6N~-*ngdzbY-Kn_lcz3@JeiVuV`}zF#JUQ7R5>WWv8n-F4TB^K4k@I z=#|WH%~o0`xA<&g5EEr@W2Rt;Ez=P&;6m=cckYd;9OkO|T&Q$K9u5~5=u+uobS$&Y z$Q3!~9A21us1|IrTK`i8z<9Fq+We4)${6*;_AjSTgi^1`*8vkS%JbuVXz{^Q0>P;X8)Ep0g#V63v`VO z942dv;HIwF2KrlgN<{!cXWl5_ZDb9n#O$dWNO^TIsyq_T0M6qULtsvV@3={? z{vuho z;2zign^>Oa0@WGtv+wvwU_%JWX!v539!Ej+wZ<&Z?tL7 zJh}sE0?Ymt*TNRp>M0Ei!4$IOKD(Trb51+C`HkAlZ!&yPE!|~amvY0qV9!qDAgc`_ z8=#HTgKaT2@}bql<-`%12*l!tFIV2Z1;;~fdU%CEa{yVJyDy?Y>N3o37QtQa5#)s@ z<;DW<|M>Vcy5I%lSVJ@Qn6Ag(!a{vf}RB6ESxlj59x>@qK_ zSbJ8WS_kcCrvNhDJ%-gj;f&xjDWfX7%}CX#W-$UX(g-J+KufSsuAek6#;JCfNT8JT zNt;Ahy5k@R(TWi3q*HIAfL6^A*NR_eWhVV8gBI~tb zsf>s|MKa;eqS?0}2~Z8xzV?qCT)&fwzwceV?5ox^#r0e4vA;W{1l(Z5_iKr;Gu-V#-M@u5~7vhV))F-+Nh`#Uc4vjNoX zKh{d4M-dY{71P{t!fUac5>8niC$s)ax>akk63N6(v)wE~5N?LC>>k|$cWoKfY(~3K{1*B*A%fao zmgLtYtUJ(fYb5_>$(42$rrdTVu-t<*L}g%hz#RaIJFzd3dB4oXW3^VTM*p;JfEZ&l z|6IMgIO~X<2GHipb&N4cQ*ej9ac( zPyB(FD+X}qEuN0DzT_92Swhf^VHq~iECKJzhx)VnU^7j zuM)C_$C0!D|AdU>^Eq7WQgM>POJ&H-j185pg<(@T_ra%mUSNJ%?K*TZpVav+6w;wk z{luZ6)nvtmBvbBVz0QD92-TiPv#K}>qZOBMUs(eZlG9&PbFkEtlZ$|jnlxr7QP%-a z%FrdaZJBwuK`+qwY2 z*y?f`)XR!s>@bV2zJ`F9W-+IQQJNUk7Se?Bf!@#jJk#y(8?7GQzg)@imG)&Gsd~9| z;&t&)(V#km=Q#F_!*N^Q(YV?ZX;3RbF1QX_%y!52%o@-Sw8VvK=mAMb-;deLh_OqU zyR8MI3+$VpA2==0c$4xC&c_#DXj(f?;Hrey1~ma6qzXqF=Qwl$6DR-xW#j<|^r#h5 zHue{>5#80{{%i_*I5o-yOz=>oxsj(j`)=VkYDj9H#a)@s(Jc0bfXIQQT`4+m@HXK9 z01Y((o~3CJp8x=HSSka#pXx@-en3k`yk^VI$Ox;T^j+{#0?Ys|>WQ`95}vF;=((~G zB^~XGegHTv8^qy`V*?fh#R6XxR3-V6{E5YJa;BUB1un#_#AKTio|ttZrJTVaz)GP? zU0t^5aF+G<5Vo-4R;ZLYP4%`OQoZh(4=IAi$#%gFe&r6(c1LE{PNP_rKX$xUHiA<; z21nl8-`8DuHdifxBx|*eSb1F}Wi1$zfyW&w8hAA2xv2L5isr9DR=(<`-ruM-_2Sld zM=OG5&UD!3`)cn>a4b^Ce|i#Tr*VH!{>67GF*Z5sSRCiopa!v zH-{-uAE`c!K`4=sS>Jn_g14Z7s1_x1icZ^&Sjy99Lw=2MUF+UPaF|oVf+_hy6jbsR zSG5-+kku3sljR8WYpb`2hy4g0B>d_iD6ioKuR~|vE|7H62l~+2dgT8rXZ}w{z z0C7N$zlI=SHSri7p3YfLRNF+PP+VSxM!AgD@NIiXcMYesVVRb^1WgZ}`&KJ;4y(Zb zp&tfN;uXLZx--&53HX=vRd1|vxg$_ z5dESTha$s=JbAlip71Q2i`Lkgn<^|#g!m2f84+TH-0xRwTZxFx;0mb!BNBUKX0F3| z4Ql`qdRp`ckNQDA|A>c0^A}_aK7S^L+9vng7r|7?G10TB2Ot!~Rk(*gi4DxzTca$#Yr)%8ldpLzDRivN`ld z0#@q~6C0eqg&7n?J3(4sCB#|TeEe~>$>)#?LPlbboUfyRg#`_JAg88&fdc!bA@CcY zd2EX$uYvLJ*f7{-jbT{RZ-Ek^a0FU#a+oh%mr>jDQc%^?LR!L({**F7|If2MSB3p8 zS-jaX%ME#x_joQscyf_1_u&D>wH4jE?W!~gEI@qJtmJRW69e>M^tMw+8k-aGaEJM* z2;K*Oa|lYEdymnvgaxgJoqjbeY+GxzyzIBahXH)t`}dHiMezC7Lv=WXv~>}v+6~^{ znGz5Kh$&3py?RJyAwWc70ACJ%|)MZTmZ0h}Zxvg@x4&)s)S({dH&aT_Ch0dY)v2 zI1egfZ%9C9JH3*MpbE>KAqdIUyz!)`Td`5q)aQs5$W6-V$tdSSwbR0kZHj4xzqEc| zA@NG!T{$bhv(9y+)$P@jy+$Dl96KqyvOafwRp_W4D8;dxO;{Vb?L&`^g4|PU{k@-o zZe+VVbBJznf4-ePS=@k&`D=$gQzUxNqhNC8R%L7&EPssBd(R^(n~$l;+x|;Ar|Q=I zXQ&vk>+zx&KI>kfKtRzkg}1>25I#eU2Vo?BoL3phS|Wm`t<3yD*3d$q<51TWd*8!^ z{!4!mnZL}#UPdi;bsV$CS#&f#_7Orc3#vtcXoIe>>-0#o9Rw|0$ zrCLrbrUxY{V=f*`KkgdAL0C)S<+|W0)5XH<0+`qWXZ;9#iX(Q20ipc|qv=XogDL{| zVP!XpcxPf`=bihsu|hE`4D~a-83zj5eSNk(ut4u9)j8mB)i&O7nC{03l3&tCx7;Tc z^6TYD2eGSoYI1ef*B|LOHX15|Ybf>{8Neeb-Q=kn`S>W@{mL7br6P~Im?O#XrrY%F z#sQZIP3`Z2Q~UUGP{YkGrYZYbdY0zflxewSz|g5Ghf~68SJ{e}Am3Kd%hZ10NkV0{ zWyB1@(9%dNG%}w1;5)kIa|$-L|BuVL4MTazyquX}3*tSo)0^&xoDi1?*ekUQma#pb zMfDAxFlYgHiroI`kT@G)Cu?EE+?3qXqQO`}O|o<`v_gt8U?epJ6h%&=$nm@=J2iI| zh~24g$aHt2^_!t!b2tC^iKoK&Ck8g6>L;SYZ9Tw1n<9UqDU8n!ak=dhh=tnG)JhQg z!9)06f;WU412@v{6A36~Xc%q0^yDxKz+{|Q2fSBiLp)+XjQFqx;9U^Qqe%pUr5 zVZ@>Z-aw+&xgy6wlyg~;seQm3Ztm*_t8i(j<-^6UuXEb#QwbQg`VnnX&96m<+DQOi z3PoXB@T4Cr`OxiDzYR!p&IfqO zE6Lr^%0n7f{fprZ$MvrBvHBs4zvX1kTVy`^*46y|A#)_-3`w_>YUBy)n$Pc?zX+%o z!exQBSC8#~el8fWCvksBEwp<;L^HzP8Ohvt>ZQ6Zf@3s zK`%3?db|woTf$dj1=@j5UTF1NgRhm+MA&8`|Mm;iztOawRRn?0T7ru1`jF{&WhBRc zw7bTMuE%4LuoBI9OSnLhfU9Xa6dE%)V(0OV0l|KMd=AZ_6;u{7h}CHg;5QQ>db0Atu%#Vr?E+Y8x3|5>GvZFd zqtaovansZP0yR|VHLP-My%iw%*7x?BS8F9`M6Z9gfjx&-%|7tGz3S!2W`I~#*ukfA2g3`ErP%Hj`>;JF#piQA_jZ}$h2glPN=JX&nPP+ z10(FVY}wqdG{X6%hnq(U58qB>lRfy+jCKhO88<4KN~FmYDHJALB4i?HlN?w>jRDP~ zq$V(VEJjmG7?%9Ozf(Q^iocA=z1YOXe)4C>ZUF$kTyM|B8SZtfyh72O+vz zqObrlrt-4iy`$(T#^K?gMK#h`WLU3!wmc`~XriRSap!92Sjgi?JgYHM^QNIPLuX%I zdZx^tW4Y7%otCmTgXz#u!Np7yvJ1?lE{uqYSTrUi#)O_>4@uEnqx=V`tpuiv#zbHNFv6qR}=7jYv{cfS)`SRZy zD7XLj2MPv30|{m`n)7E)peiB$F3Q*_PMi9;1D&elmfyaI9;`^QupSvauQ%SHj^pX% zYCv@HiRdPtM#Zi>CXjG3y!DR(bhLb(?Z>bk`R>d_?1rfuu zmWFpe3n;ipMsQO1NdOl6Y9J;`oNX0J4#!kV;FOkD0O3LyMM9~@-8@~G7v=x}R9)hZ zc4`~^5G_uybZF4$#S<$@XsqmG3M+Bv%T_@nQf5NsfcsjxStLc$?@Ssy)-W8(Zln~i zq6Kirjua@#qNqUa-%{m~d?5O@o0ZFwEmQiWC5!t3-m6a4N1!A@%Y)!HjUb1*`m7(W??M}h?rKNZLyv4D z`^Bry0i(vyL*)+g(o zUIPlm9?9($0OdM-bt9LI-cRRKuK~E{y~A3=p`sh-cR{k3Te zNOa{Ob(4^((Bn?&a)7ar7}2mxHaamR0A!mlX@>|VNLmNED}0HfxG-hLyk_eR5RfhU zX*Db{&)_Qob0E_+OH=0=uULadDhrao$^b+RTBTuK2oRfPs69(nI+&?Gq^_>7p&3?Fa%qd#V4LYYr`~<+TEUwZpTZhn~^o9B;?Haeap~> z6|zr+)Y)iJ0L0iLHYZ#8Cb&rZ-k@&Vr&RiZ0W+=Kq5^Z<2I=M*TP`w%_jrgwb5UxF zD(SX+|1$C^_utC?vDq6K-c6uemdUgVc&=&xysJV4<4;@1B`o0kStETv;$4#;PU`w_ z?hE1U4^TU@5}x{G{uJn>IiXT-k|08@D`_&%Gh^^cnnW67K2SxRr50y!2Bd=OO5gf> zRXBYn;WfT#v(!$>BFaLvnJxjqb}hrNybiBR^Vih)Tx1S3h`hZsy-|4>X?WJrcU`z-N5J}4f(xrs{U_O|ktbug{L8UT|6$zKwOEb& z=w~58Hq_#*b{JRjKEo*8BjDoaW9EYy~Cp4|8vM!FDuWn9yOHb@#<)UH=me}5)P#L56ASK zH|y{V6x`}ey;ZBHq zP(3TwG+X@yne;SF6F8T(h2XbNu6mllXKl@kx0>gWMTk2aiek_%UzEL`DG(l;=N67H z6orbzamx+y>TB36b*1EArZxP}#9M|wz(s6nRE$D~f{5h#(45_`188#m7F8e2VlcO1 z0pKxz7U;w=wF9;kBdG0%Ieu-CV!07_yH199a2`k>i6i>H$#qCFMX?~j(lOtyGmvYm zxu#%zR^BW_sN^+1+)eJHPCBwCG%V?$3Yo!7Mw@ay3qQ}K_Mw3vM2;8v{q zxs)boDFTnn&t=3DKyE2^y0I$qv?8qJk#Vc1^~LBseB^u>esp0X{{0eJQ!0w8>GfsC zA!ZVSosN)1oh?8GMPr`vzyyz7_5PqJKOpXG-mlW|q7H0D{|*WEr>52g*e}lD8id2S zMAoC`qs1ciP$suKG&k-k5M3_m_m`Y*q31OP(F^s9)RRZ!c=DMKI0EXNr2;-_L-VOO z=SYTrQ&|@^hI7MQ&QVT*^xM0gy{95Z2}GOC1V1KDu)za}lYYm6a-q2`6BEdSr!YtI zvYfitlpqT(A{J*Vk6!23`OwK8W;5(5Q8t?DXYf}7<(c-vkTL6JWYw<)P)-{mG`Wes z8fE{(F%is+PMB`U!cdIH!2rCGcHkTL>UA0!XW(L?OV3O+$Ads9V__HvQRJCasKR-( z(%Cia_(QL2LqXZ6_F?yeh0>|R;y)479lW_IH2Tm-f|QKP3Gxc2JXBuR-#6|m;F~u^ zV|P3K!SX!9RF~ba0n3qk9LhN`f~D>`mSE;lPgS}xuHklpyCjBOMmcD2gS$xi(1HiI zDXC%OPIFCkvDEneTbdHt``(e-a}g6LLc=UR=^e758p%t;FF8H-^|RnpE_YHklbl|$N`Vl+NgG~&nlzY=Mj4v$bFX9NZb+~C3CK}wtbr9!3Q5AMYS zb@dY`GdM)7H{!&IK}PG3BMB?|)e#I=Qq|C`Qy$~hzm_(&iaLEZG7&d6z_Mpff`n#AC$hD|%pW^kxR_ zz=*taftS2SwvLpNS4?@cB%l9jeIHTBrYbBPZHFtze5sG!hnxtrV+1Gu?HQ(6MTQv$ zi8WUFVQqkMv82M#TwNJ)jy>GD7|su=ukO5stW%K{4{p+rBb`{S8Lp;FvFovyC1VSLm$FzDW} zWpDYfpR`_c!wjDwJGSy3zW4P(W6cIeP>WC8W@I`$1@4T%w4U%1&I|-#4XJFp8oBlu zAtw%X72jJOq?B)lynDsCcpl7WsNh;ohJEQc&!# z(L7M2;A*F>X)guAZNh<%JwC5c#xHl>2U9ngSS85UTt-d{OkMFllz#y6PxMR4EzhR` z2lAp5hfcweE$f787Vmh@mltFeQyg;xxq;%I>K^c+ zr<4Cw82a}Wb6RNiGx*;WSRS@3s{_=$i&BdOd#)g?3T(cQ zXDh!A+Yn9+_}IFg)eKu!k>djj3mc;MoTCdiu|c5N$M zV{x$AMq>O+KLBJ~2$ju9vEu2w?%VyG1@~A?aI#~4fpu-D<9M$zc9l!%dDMuuHi>Tv z|H8YVp)TsJMd^(>65j>7vC>IGLy5_*O)2&>C_KZLHji>&mD}2#J&8v-{*_fNc~tLo zddfFbtdrFc(P)hNTo+d-=Q8e0HgTkh@GZAsMrtGH_*M|U zy!56J?khMe-m(b!>YJ^zw2)V)h20I=aGU57O^+hhZfPLh zCIJG1y_#f&mXJAdLod3{y@<{zDyac4t=pT}_v%q$=5UcwH@QpeL`S7SobO-hdp=dqP16m`Xe}zD>(V_wr);}`=YBLF zSrF_DGF!Z!2v5fmtJ6dN}>W2lA#p7pXUh!nR zt!R8ma-Nby#P2S@qR0Bs3~Wy*ffb@0Kh3VNQx%4%wn}o#{cXiq7fxDDIYX|4p`u*J1eKC7*&r z`77kDmh&T~`~}aI9Sah(u6ZO=@nC-VPyh?0Iht~5x(j(uL@g($fYG7-K;uPx>9RVq z8n>D7{$Rcy_w8qht3@L);(UwEa~gtP;e$!w>{FK@W%>du7VOU`W~Mz?=zQhDo%-34 zYdn`{w}FzR+u-`2dViMb>ig{FG)Fa)28Rf1!|q3V5p@;lkx#KqIm}qjxJ)=>)^t7M zxNL|WZQ(4H{0?Awh_q-GxS( zLxDCJjYF$djNMiKuwTr|(Nw|Vzk2e1JC_$y`4P!lTYNr{^HA@~2_1y=6AS@E;^x$n z`!8JGPzgZ)3!y_AWM~+-l4C?daIbbO?yRcZR!gsdI#Oxfu{kGu$g{b>B^;)RYeg#zz5hxg+xkdy~*tFMKVIVP;W##+^aaY_!6J3WSiYwV7M{K*X9cBv$b zeY!+DsbOodD}Ms-aTkTuA}tZmKb`s0H;OPptnyO_-TdE=um9jT37G~CAp-`VPnbq= zAdA-;n*^^nV7ihXk+xxmhLf-xx!IEoM6hJIKEt(c;!YaDBi=vI5l^+Hw3@U&hi{c5 zcer~2{*`bfcdqdrt$7HNn@^m%i)l3!*0TO~7>9n9@3;_8+n@Z<8#sM-()lOxUSl43 z06GA_azVcMZYrm%d;hlcb_eHI!p8vYzqg)Ng;`RvN8PQ7B;h+`g@+F^HchSt5zZ4( zyO=YRnD#&=i2R4oY4%Dry{+Z%+<5^PaSPUEi(al=P|HuAq=R{=%n;{y^{2ovBfen} z?=*F>rZS~QiZuk)Ppw(;o^;Imy#dK~k7r-@7U<@PyNDR$*9%_0{3sWqO1x?5%!qOc zEg*Z}XiD-XUrp!jTGeG1oj?h`ut4ikmufTsweWr9_RH&YsCRVJ2-(}iBz!f zWvHg;(7yf))F#5bc-RWdg2sNuf4~2`G8n((?*Fh$6-Xl2QK&|*nb9RISuh0?d{ZUI zp#BM393V0aTlzQT4D$di7v%qWiwT{s%G+?WD~N`6Ww zYZU?P$j{-bbzk)OBp6Zu1$Ft>Wx2!wgKBeP8I8M1nHv8Bc_Fq8`s?q(X;*kaSkNnQ zy9wyA-v&k13;24ROLU4iPw5FKerzG2@{b?M!?qXCsfCAFd=7y)vDfMM;OchFMNRw& zliPO@kEAt570MG*br)lydaf(jkHGia>F_DuACmy`lAtWbOx2eBUbYTsrYFI|ge?92 zd`!-3D#?nX3S$sTxi1@cp=J*q_(vcUhbA@rm+%SGqXE!mJSeS(YI=AXTs9U;Kx{fR zd&s7H1~aE$HoY($2AE3u59t@pcG;-+!b(*^7c6aa+w9@8>t2|v5M@3uBk*zRr5%-^ zil>Emz-nZhlFsXbALE|FNSINzPuP&-X9R-FvVC3jYjE=bqpR=wy-U@*4eLHzE`Tar z{bTiOpyMrkDo``6p37(wa#h*)$8>5n2B<%%XWKMf83W9RZPH1ZIsk@y)!<672zi<; z(-jyO;U&{M|DYz9%cVRL+Zc!W-Z`20PIV_VIUFH|*~XbL>}l=(_nD?e&VF~k7M0;S z8$XONy!ZQP|>|iG>dQ}C30aTB}t9U#*;{CqXO?l0i5Ow`D%fG{biI=g7Pd!Q;?~WXW}wz zN%~W!-G4zTck~4rDO;{Ys~YIjwH)qKZ5COpeCYZsw`8&bEw)AM%6j72Yg}}d^Da+e z!;d=#r(wCkT@CD@d?`72?m|D3B&Ayar1>L%S+zR1`P$N!^Y1)n*uKv!LsbShwZ@KYK2>mU@e2Rq%Emh*po_5Iah z?Hf@LGGs8h(;d=*(R9tI^H_%vPRGm@#lPGKsS5|@pcCERgb-^s36IpHgDx&tQiRCz zu+*cL<14Oes}5lh5iL1TfQfP#TGuEAwYwT8M7NcwR?~7|(V?-igDnY>1#h&<-MQ3j z{XtMrVc3pQ7e*{ub7$FCII{f#vOZ#|5zYp&+;@m*7S(2+HPA&(NvW#b8h2td0dR_^ z{>6y%N7qJ~cth;0B)h-QrCXj?zCD`7oxNy^q`b)uZgj&N8 z=l+_TC|=Q@UJf{PDYNtM{?3@-qfx+xT=SLfk!_rvFN!-2gFDWGeJmfPe-;9h02t}f zT7na113DCz0$~RccU4a^%1}lk|2$wWchd0`|7Zy-30ce(t;^KTItt7*rA6Dia<%rR zSkmZ`Za6UdZ6jBqe(&FvHyCjSRn#1t=jn6=D?**ym;gL@i+q0=wCN?=xQtmkCzO=%10-3odbZr~#c7(E;whv>o=EXkI+Sxi5i%5&=@(?-h({usm3d za+2>9=oL`h!@nqO9cMm#cBuLTS#QCip>p(zLoAO~A8xcQVF&8dQ3I*E##4#9rxx9W zFV*Ntk`bcQHLy*u%vBCA5PspSaQMDmAIbc`?sUWI#3^tE@?l-`R`JQrND_wXw;j-%4(2{I8y&afHwv;?OktwLdG!>swbn;8qGtZlZIT2S~ zCQydOi z9XjQb{R*XFMrh9Ps>9ZR8j0Oo(v!qQ7)4jS0Lux-shAmi<+i*dAp^VSKmQ52D;zj0%F*Xc;>Pv3c~Gsn zT}3)C|ly_5e^jqXA&4s!RC~5*!Qyj*06* zNoZ=C1Z~VsEf=9O;3Jz;qF;-Ak$Wg#xfsDN#I|KvgOPv0$^J*Q18dJ6@pu9c3)K_z zv3{6&1n~4u%0x%DxFINV>T_wP5OB6A>%IPc@9a%b2#WFIv2?FqDd9|zr@!lZ7~+-8 zI13z1b6!P!*X%U##fgSo%vZPdOL1+O<+!Hj(DlUW=j(a0DxLN39h{dLy?5M&LnV({r{0#_RSlse>mIPsKcvRDq&z1xld zShZSbOM}}iUC}-mrpJ^dp~g_??S;oPIMs9JP04+%u1?ITQM*Ml_j1EQT`=w8+iqDG zXzD>`DTaerM+`Kbwjp@X=&_j-JPbV-z{l$Tvvdj`A%hF+3C__1L~PFecn=mHSOKIz zduQWOZFJ)vexb~Z(8_!$(Qb6V_)9RVv!8~`^obUk4LVjrILx-r;(hDZz%q#y{LN&S z2ZW_jJqFUZrq-Iw67_n>Df9UnUJKL?G`C7a` z9!m+G78k{Iz%4hiIIqfATG}{SSN`t^h?Tp632b5H*}ugEQxy#|nl)Tzk?P9JJd&q^ z$XsGBJj1H|dL5>QN~luK2-3-y(=!~mr^bz##)gBiV7ZYJ$N1pvez_(64A-`oCx-nM z$=lP{iovx^*%S(7kvzd0Y_-J8F(%_1LbA&N@){?RmF7k}g#HinK^8K{v=R7f&U)l; zFFZMg$E+B`P?!wWhWkV{PFd$ZF+`sbFC+-!fQ#)(?7>1t?q(I@hS~4s+f9gGl=c{m zdAgj^?1$j;StIBDa!Ey8nfTZ;Fo^30nf_p@Ad?|LmzC_!{P%@8RMiwo?`XBWui8J~ z84F<{kwCl9ei3g>4g2}z3)vP6@;#frmqRe!y-N+h9 z{{;mdAtx~Mweq%D>q~WFI9hHV%i@%;&O7I^Of-Zf(}|a@?{++ruon6MJ;vR|PF)iW zT+KJz?w35KfH5 zyNaHVQJsn1>CI|AHHWMV^IwAlU-V)>0!88!lO=uwbMo);CcB zx}$E;jc^E(QU%%l9ow2KAI^B%ZSy#vfi?|G?Te6pU8|*8BgjMjWt808EB%3yzRu(v z=JVbJNENLoQq=Vrym#sji6;i9@gb2ZJ;&wh$_&CI2jIU z)vw5>sW*Bdb9?


$De_gw;?#$YptA=ZprKsaT+(wOR}#>Ys$!EBkoT~}MvGY~WR za{7=Azy6bD3SQ5#H8{tsHpT**_gg;!sZu4Pzd1E;0DhPB22!k#Z0t!&#HW1C6pxL= z8AWv-*Iy|v_BOHDE0_UsYW+gzcyaDtM-`QLVWF0^cSYX{WN}o6=r239i~ypijst$f<&on974JERQ+gQQ4jn#FKhY^k4j$8dZJ?Ko z;G17X+h(=&Q|Y(-#TH}!B*Q9o$AXw7iH72g90#-5u+BW; z14@yM#w-GBCfWN(XMF*aT@|M_q0y4wM&RnMW?Wb*PmlNJ<}D;JVLWVeg2P;4mxw zsIvzW0qnq-|rmiod3uid^QE_GyqWY5738&cdj-SgS@hCK$5#tErGztaO%< zrO@d+@5`E_fCoyj?!j7nE+bU-NT$%^wr+>iDi`-uHXUBR)!c33(=~gUpQKG!2iLA( z1Cd~zusO$I%Si`PU(biD`oTWR5cC~V4p~d_7|D`xM2cNO3?;Q3&eI9{4hN!>SM}1H_R&!6g$gorl#NakG8qhX}KR^Fo@qF;~Ddd-oU8vtZu9e*^(4)TK@Ql znWSgD&KD=Jh)bG!5LnGiSIfr1J8`z{qgx$J9a)(8L@OCt4X*aLIQ_+fK@4n>$r*)E zdg2&KKQkt6!$Z90z8R6QBE+ zN!3K0nwqM}tIKe(z8vGSFO?-Q7j0AZn=uNC)iecd1f<&Dx^!x3e9}ysh=l_?pIhOd zy-~G>YatN#mkeOluB0oHR(}Llzz!z_g(JV~fS`GY$&MyInb3Dq16I3miPTvyNwF}dc>cY5fUr0?A z08`E7R(4^!mo2r|TWluko@jE6;76|jIJ{}v4YE_Spu77c_*_z|Mz$L&&5&*Y6~KKH zn8hVK!hT0}j7CeZP&1sqrGnJgMP3qtsE$<8Nj!d*i}EWPye&7AUYgMs;XFDM^hFXB zF&?#4D1#?Khk(2YB_^$g=bO}ad?~cp|5b7_JaV6|rNuY6mD>)))kOT@sfpgOY5TreE` z7Qsm=C$MWFgeYi;_*KdsT37vYCwsLG`8D#Z+&$|I7_eG6y|X?ktg0|fO6t0&ZD_lF zmc^TuTQN)e96iQ`7Z~?%Urg)efi@4oGB9poR~wEmedkM1Q;SD&&>=*@^L~s2ll|kJ zyAQOB7Ii|YaqlwTDD~y4xoT7N)%h=QMDebAAtuN1SHD23o7_h~FS$UC02)^5_MM%ew_IX63WwlxLVInjk%X znLY#^8pR_^?8ww(S!~PxrGjQFfl1HJyDuV zC&CP;v$lFv&ja|to|4E2QbixQ!+EbMXVplHl~3zj{eKq4W9w~P=gkAi5Iz!h)`)+c zumY8M_N@~^mCxE@IBh=T0fm4R^CaPnq{e?I7mLCzD?L8 zcu2&y(G903AR`!(>i{W|cSB`tf`k|hAW<$|a_ufk zd$a7Y2HGS3eryJFeFL6!dQ~l5WZ9iLO^rY*(F)#ZBw4hEoV`#o+*COPYx(A5naRVH z6&;YeBnC~+mj7pGdwn(Wyi2@=`B93$jd>^NEl=I zWQ~H`;GswHi4~lz@Kt^H*s@wvzvkc0AYDxsnSvG$=5C@mmd-N3&ktWTR%ZilDt9u~ zgrH|mnrK%KtG2Jhml5%k3lQE8Qy63wcQ-4H-1-Eyl`%RefeU>!dB!UcS5^yV`6r+< z@V!=yM;>aLvaL6O z#S`2YNi2q4RrwN#Yuk5~z6B%zw|)#`%4)9540wT_e+scfEQX!e3EWI+_SGcVBhUx2 zvOJS$0&^wzqc;u`8dIxKl1R5CI`bx5#UlM?jkpd91X^AUaHnVDl2?J*RA8%n?)?!C zilRqN4*oP-7gV+e?04 zB!A7g^)M!o6j)}{7PvS~#Z2H$Gz4!QgrKdaA}r8NVcYP^#ojTs!1$1#b_kO%C&|Ybj%5UI$nsVf~T1rb#P^FDi z-@y3wq8~o){nQPbLktKM5tvUtX9JT@OZ0iD-+V2cm-+)b&P*`j6*pTqkizQ7}@TrqaesaSx=iX%G z?%~48-XeU)`uOmgHNA40PDl26LGZ&0Moq2VQRgeQI z_PcwjM1fvwNXrz)h1b2QiYefF`6c)&N~kEJuEh^NQ!kil`9$(Dd#@uD{lB+X#33k- zmAnH(Q@-F=RGcqS2B1}5Klu(jxC5vqf#0hBKRWHZ$Oz{ED}PzTtU@va@_hWoGHfN6-KS?brGPZMQgW9{YJQ>0@BP?^ecd zz~H&uWEGwDiNNE~+_ptMfeEz>dGk#^khC_5vo_*XSit}Q2Xz6S>1hz3002*q9boO< z=S{$ag`|2k^`SV30}Vn9BXx;=(-JhpbF_=+8Lqi`#g#-^PW~R_44c5thh{9o_$V*f zMah5wO)M~>fDoB)qf9=ZcAJEHPTn~&pa7EyP6C#Zbyr;ed6X4tUY?S!1^`F zcr1$jrb1{|7vt#w((4nuZg6&&J_|NFOAXXc{E>j)Il8~z>sb-WeaQ(4V&=Ih=rGq9 zJ^ZL=q3xTN({J98_v;n1@%1ioxKW0ZEe1XHUDPp4t1A7Qv-p?w=xiJmFD-JjDyhz% zVK-P1MPNYk?^wGTEPS^Y)Iot0#1F(ycVLM>_}S2@=0P<6$=)=8SOH8&V5KmKjc#8M z%mAJ1c{6C8Ew(Ee{m?H$YvGx{S6S=TG@MTj2?$?LZf8!L?VSF+(Z;+-1O< zp0>4%RsR1e*60%Snd*?t76Awl9WotbGfJ?t0xGE}K?A!B-;Dm28E2~LPt^}d9lXOT zXmlVW6LhU(eCH#3SOl1gl&cW*W#aY6)OSh04JOrsI?&5+hK&|J&ww1T2TC5^!t&My05rm6aJPx%i*eaZ?FQd zb(i!#8&jO2N9|I&DkNW8^d=v}Ip6ae62v2uvGXN2Xp?i8-0pn|$SSyB(la`DCM)imNi_@LCyRBpPgRzw6f-~e#}T*Ad_KGN zAC0)ZC;~U&2oib+2|Lo%Jw*kLP%mm%%{GrO1yk_xKdGeoYyNEewxz|P{tm`J-aKi# z{rTi9k9B~~`;2VHvUBE2AF`h8-Ps?ed*P=#+?Pe-7s;pt>wZsQ4`P#!%?X_tRimwS z8+R`FG6fo4`NJ?aURZHnz8=|#i7A-qf4jzQl@bkd{T0HEyJvVtgw%M(*@+>EmT>mN zyM(5I7Mcv9WEH*uzK0xY^?#Oi&6m;OX@&N3r0PdUWPNViYP+^2HpJJt(oGV}tR=1~ z3<~$HY`UyLJ>&QDauEUIRX4;08VCz^rXVAcZ4Nvv!$lZ`NwP@8F@SF2YSg69rj=j0 zPqA4%j(?LbEkE1Du#bOIV2i8T&EQ?@S?#{pj+uR+DSBOTRq_{s5l4<|J7#(L4n*nlelZ_V z%nq(VQ7TF-uG$j0hGpGZk)P8U;1dlaE_@=BbGKI^+FDnR)t6949+0TC}bR%o#)99vs?+Aa6#8}rt! zxwaxis+>zK$}tHB4f-XTw)uqpsoF^^YZ)eHe43qq)`R-Zc?U&~*s?K_VodN#&4o;j z=&`sbf0KYPj6q!KL20lXmBnT9L!vCplcv1EFkv*xd)^IDMcY! zM-l;NYm_~d<}d`H{x0i!oFsl@b3YomGIgqbB)LF6KORSL7|*&!_OPLYQawxpU2N8# zeME$|Q~*SI1IC`D7)7kFar(-e<8MZ4ppxsi2f+*#J#D!C61|%dV z$fu0Bm4Nm44@eOo7vs)c5qS-@Qh4}9XaOqwRS@N zP;e4@TV9v}>S1m|b(1}CgYkWjzFT^@q2kc{4yY&e!X|u-a(rP$zimC#Ni6!)3YI09 z`}!0AK&?N1BL2LUEtN1Ir@kjdL1hYVcZeO(V zEUT=5KWoMywLpc49_E!@Xc zlT&3@Ce&^jd_U&Ml;@LTH80kMZ?A*q@Bjc{_3imLY)ga zs(J{nOfaPSlzAT-KBx>V+fw_n0vb=d;}Ib%j4=WG%{5*TnVkS>vhGQCZ?ja+fKFS% z(+*ICbp3R!;4`AB4pq&H+oJWKTRp_J^;&={IjP>1g~)L0MA|ux8jVIVC!c3YzPiv1 zj{YT>VVX)`W|*I{@G1usAlht^1?oozu|%DXGXg%2YD|VtWLG5R*Dst7uW0z^$qdNQ zH-*vCz+l-7!0BF0R(I%U#m6v{&hcL!r3rwG>x_+oC80#uq#P3X>Akexx9x-ocGR@O zb;NLey^X-B2B*5J*2G6Ih&x>Hgxtc!^j={dR}TQtmE~W_J-hY^LxIncPKg(G_*vr1`;M-CQB-@`TFvaXTQFAvD1Lp*wA-=PunlDrNKh&gk7uy1v z#7_kyKa0er+5Dtf8o5r%WouK)+?MKI zGSuC86u$6}Q0-z_LO?lTzX`=?A^UqODkKlg9FGl=bx$CQHpNgn!qK%$u&;;WykaC% zyBn?w(`LdRThr^){IoO8D{FKso0;Hu>4?Xk$VO;&T5;5meez`q5zbp4I@m}$kf786 zI5FLn@x|ss&%#T4>UA`y$^+Tk9}%rFDKKP-gnRYiy1fgSMHDkjje;Wd?O4!CL8c|8 z<+a}SxDp}P#PN?`mT*S+le=H7&I=J5J8-(fx3oIb zuIW1-Vt-HF8f1~Go>E4LP_p}JM62; zf%?xferPdyzQ_p_$rx}BG;>uEOfitNN2cnHH5Qod!ers2|FQ; zu9!E8eFW?2uU4<3nLD81a|}s9-63Av57gIC#D3i}=aiEM#hrHRx48ox)ojQI6vAAl zD9wb@>+w!7I;4d~R4LQW@cVureI~^%BZuUTrH%Eeiqx_gdP^$?C#Fs4E49Nlw8@5TBDOv(mzrVgcy zkUr3Ui(}g z%oV?IfX@O)iUZ{^W#y0M+sT!-J|#H^-#1Vhw62eN0gHu^}$Jsn057nU~ZN z*fGeI0tob9%r1+VE6zhDYN85(x`2v%{WaJ2Hca#YKq#;|OKo>_Teuw@QVqyjI*378WdgOHc@O!9L-*$HJuA+)E<0i`5r1 z*IHE56F~OEw}OC+7}KvYfhTnsQ&)eFO$iWxN0=aPpbz4KXag0k(P=jP@e4oy^>Q{0 zFu0lcf0IdZ(%F=9wejtfBB=gv)@xYnG{VydF^UsZ?B=_5EKR~I%$%=V$#sP0aki+B z7hJ@f+h|I$^V3>4-Zb9Puzz=YacdciPuu%x-#P;}y!|Nk5TBrZ>Yk!o%%ZsF>FEzYm`9c~YO1W+y zHcT38JI2thJ$$k%xj3Wk`7%VB=Hb3?xH^3OuoKRV0BbcG-Pg7Ka$(&p+u|kg@wog4 zHd~tXNS*4u5|JLEc-Z*$>hTb*4t0>(U#(fqufTrk>7{VxKpgTl zO8y8$8s&SvHETO?=>&47!kpUo;J-H#4D?Pf8^=O2GxE55u7) zU(Zcc8mXh-&%G&GK2je#XI7Ia8<5qhpJgAz>JYqv=rKU}yrAK%#k%$os6HOp-8k&u zCt-IYOAy>V0{xG^=nUSTot`(e$yOPrjfxxu@wocTZlrwo}|j-**yTapdw z6{2#w{iD5?P7Vt;4LM3(?mW<@ioZoy}M6g=AWZTj#t$(*huz(2*>CNv-!gn)5%Xj1|_qFWY`s=`^PdsVIqx1b$jr=?|aj#9c~zhwP@JJgWJxmVA2+Kew^2HK7E?#+tjAK^76N|L9;5 zjy*jGMM=FyI+^uW3ifH$cq_OwK(=Ab|Sz?XP&J(W4#{Hn8zt9520+I@#lXBYHVX*5W?R z4p`!GOyH@q=4#sJ%;a6&qP*p5>N6Jo6bnz) zv?tW%M?~MPyGi3meu%$n9bgrR6c2S0%_n{OTQ--Y2Jc0<5&Re-;ifUPHqUs%BhZ%Nb*_t+O7zo9#Nxgp@5X77_G3uIK~x_&{* zL*{ppWHmo+l$MPwv)pHE(^P26P&%v=gh?!rZ;)#s7tG&{G-&v_!baeyp(QoSELhnf zd~G4IRN|N(|EUR;$7c(F_NRW86(-`Y|2`g zii%$PE*#6hvtsovybCcm*oBz>XHVN04tpa2I3NH3Zf4LHng!pBKz(|Ms!jCjqMsCd zo9l~sb(dCz1+#B3^)LVcD;YtW@HGf6sWO-ZH~;>sRR91EI^eg=zyv?n)d;&q|DnWQ z+rgIsbA@mU%1gB0G2i6Qf{zgYHv@XHycExEK-cBss%Pod_(3OTc@|tk(CHW(AnpT8 zTy4e~s}mR8**DRC_=BN4kZwh zaJ_|mit3d!Cm4X**F`23j~w|3(Hk*055Ie}X%)~HMDn83B8l9Z!%X+=OxHSTSL9Z8 z-T0D3njrhtWJ2i`=XSC%S)kGAxND32JLmj5RG$A|)%sBZHbbPeP}k z^5x?+-(xgoB(OxCfIh`{=}RdWUpY!$?BjNpeV2_#gwuy9g1T{TZMAA{eV)^)#e3~I ztG8l5Xx}%ENKZRYQK@dv+#dW#3Lb7xi-5?6UFj+WYTA-ygwecMTP{noRWr%Hrl9;x z=jyi*>91XDLkkH`;3Pj(Oc?{T*<5MfI|}4g>$GJ^OtJ9uz{D8b;T>K(!bfpV;?LU; zQ#D*;v%2;cxl{*=fD$E2JU}#lj#IAY8*#{iWD-)%K4r7NcNtaQLKz@c>n0N-2%&2p zV-YpB_msqf^L*O3PN54|qgB{fH2Otic64n)8n)u}OQ-xr4l;v%WD}9J=KRL0Q;*2+ zoU?S>C%ZG82b{L^Qx=<7@l}qid>|p0F$~m{2JMy^FW*QohpIS%nF#Pi5q#&wXpHJ2 zx^4c%MHhoU22Ru?Yqw<&@{75=!7(Axh=&x73PU^w(Hl7X)x$)NE90sU&^6%VtH1@4CMu(*9;tJ3=v*du6pu@=HtsoH zLj5Z6AO$c?Cm{Ebw0C2Mw`3L(C+Y0_F$8+9j17gm4w~i7Id<=;GWPO-uqE=mC@lf* z8nGTY)kK~DxtYd)*HIgoO`@4mm0Z@!G{h(=?M}h>f^L36k3E-I179pp1+R!yZ}Yrz zYSA`$uwyO10Ji>MUUa_sK`>henshW3N}$l^If$??P0h&M7i?J%kuL}j!_64dvzT01 zIAV}yDz#_8f+g`(y>g&Mk6#R#>(|}Yic~`(zNR$Dc`Y7vy;IvCr>5TqB@Cqw5j)_8 zkaCj0@dTf0qKhepCdR9Bmm_7ogM1wkAP|+I z;n6vUMoiLi!%ld>SPA1z4G#B`Lf>|L`}!Bp%eb^a%Rl^EGmk;qs(Rc=A`*g##d$BT z)Z1m}aS4(+XiU&q>g-t%A_+59b+rKM7eo;%lFM^G@djz1ZgUy((coAaQ(7#@@(d-s zT+83;S?S;NvL7-XoS6u+e$j7c&LB+aP_m&VuQ6y-=E&fJl({wKxRiXfr{~7(ocdc4 zVQ(U`CT`MlXd8Mh^l9fD{i9dC&#U6|!>Gv&KN)y#@V2(wvWG?vXlI-5sE(vfYcc_| zs3|!d|4=&RZEf|Mt_whJSw54Z&Z}X}NYS%Q=&B*U%{u)rc?w9Qj#e9? z`TZi#D2j!GPGD<1&Fze388eYO@Pl3&r2)u z=JG1m^c_qv`WVb86qwXOOpru~~T&ZUek1gPp#Y;a` zI?w$X?0nv~h9MHwTl;g&NE{%6F)FMs1nRT=qc|TvMwfH;=K3E3W+krn%IPt%`++j! z2!PALc^cmeeokW=x(PcZvRiQHCDdweg<)QM?}7U=!LyMtfb~ccenkexNR1!CW0|u7 zC?;}L@@L7BA)838wNZl-7?X@2^i&e2@KGfMN~RqY8Th`3FD`&;>F%I3*iIhEtIyjT zitZlR6p(BNuite`DKh9Fc4INC2ik5-SKd-9+TLEcJPtwsv@lb$E_vU4)7=S$F>YfU zVLNIf%Fc>Dx~VM`YNIiWl9rIUhQmFXRfU#^yxBTC8!1d(aX7psfZjFZM{m8X#_z2b zc4%r6(W@wadug}iFr@j(9h6}NCyBT)uQ8>i$5k=)n4HJ%Sv$jTA-4BNWqCB=IYDir zCaAGuE*?terYnR71DFLc~7!7jCJ3&}z?={jBPiQkY31WBKc2b&-tbBy7J10;I2hMZYME7d=fw z)$9G66$2&Bk*oRXQu-19A;D6XASy*u-yf(9@ti^#+ZAb@;M;G&Q82~cAPV2A>RpLx zs{FHYB>DX2k1m^q-D#v9*tieJI+jxklU1`0@bkvhgfOq9E5rlX%RSi5pW8bp0ov6< zJr{7flrl*pw`0=LK(2i_JJIdaAQYmNoG91SxABXR2&4ZFiR<-}Pf;xG`?2#0!(o}c zEf95I1X8fpYgo%&PKE~6?xXQx0Yv%4$C|)UmLo~qY_QLjAZjvZ@fPBQ!j>!QD;=%O z4(N!gWHLAcvNP7l2c-pbhVwKa)=60D8=31E(CsPx z-*g`d4+a0JtrWan2w(|Zn-000f=K0%wK-C#0+{ZcyJ&)aK5&Y-cg-IOFJDIpaS4e= z-j@eC->^TsbhQ!1nhFmTI9pM|N)*}!ZL{e5>hc@%tfDf)8O&$HJ=rh4#;(MyQ!&I0 z_QYd#1;{4Ir#`z=vP&EVhJHX}ZCsXjafO-kXgN|%C;Az2_xsEe^CiQD4LF@Ml(9z(+m%WBI>*%Ku0Ix<`)S< z)~ueY7E}mgQ_`u?G_`os@O_B5HT!9fZ^Sypj(c637A>jIkKOl)!vmu#m9vv2qTs&l zYGu~vEW^bOid-i$x-~@CM+N+AML}qyVX?XP1oojRvHC>uGe6x-0Xf#T9 zuwfSMQiQ+;J>TJXtmO(z(2j97DQeW2<$=BPG_*GVW68 ze!oJtL+wbh1)~(20SQPa#0=ErYoXQ$Yl>^IJPs~u52A=<37v*_-0)SXl>a}tr}DjA zBy>ndDbZBRya;Jr`@MLP&R2#rpxlsAV=MXm)%f0S zHh_RmQ&d&WG8yZ(Tqoh(@{Oy(o0K8F>QdO(V&Xd?PeFc}+}gS-k7%)Grvy_v_fLoD z54|90C&yt0{cFp}c{5TMu{MCK99>Pp-{^=_5#R1Jm;U_k7QbK9`m}D<2LkvOf-RIq ztNv`3y3smLn}Nx-rJu8B>%7q`y(dU?w1*GyvQTqJO_--FlzzmW|Khjr53EMBHwO5S z5hxs_@KXF%uQ!kEOrWRi-ZLQ^Z~-js;6F%|T-o|HpFC0Q!WK)~Xilo#O*qt6>sh_o z>W8{OIy!M4FtR6H)ew#=03Dau9dam(X`M{5#rc;BmRg&L!OH>f`t)%~#cz7ytS=lq z9i;a4Hd-V1kX2`v3e2Z>-=>I+^raLR;tkhi3k+M!j!HU5(P&{k3Dv+`B-%1spI}Z=rQrdEil|)sj!6gJU2m?hU4l$74F1dzT!eJn$l0`ZAaX)+fIw56 z3~WBLT^13VN8&@rbX@a;?WG!MvWG4eG?8Z)g$Oc8Q&#D3$u^v^pT8Or2Q_8m>+}Lq z15}g@O=%G52q2fTf=N>w@&PMJXr3jqsjy0rYwRXMNAI*b*=n!lPC&Zg!2ZDM(Yp7V zTQ`zg(B-mq;Kwjws=ZW`K|3os`R&ot$gvzI0IVYt2EGn^jcq~&Uy|nfxPe{Yt>W|pQ7CKs%fhI3iIBk?L!vGx$D_55~=#zwiaKlZj-*FI% z_$Y^GP-Ng`Ks0Ewpe!r{#N~f8JmMw*gTq*>5`M`V0>%S;dGA_w@6)$;eGW!;U#J!qq3@!yQ*X{& zXEIV;_)Ipca9gzH^0TNDC|!JS(OQy_QV3v%w}*_Gx_Bc>n|RU`@^9@|K3aL0>zQ2Xs94q?nCNGA~e|WeT#CsFCfdEh~y!TGs6%s z@#~p%3f@*WXCd?mT8_%Eg-_1~haK&cs{D2wKbNnK3LBf`^gaVnv7I%H2HVG1@_YN3 zM_Lx#8KptB3DVBJnCc~VK#(oIXI;Q(LF+{E&#cDIre#eDhWCFOb^MG9Ku?&@t-iue ztf@#I8t|XQ(pxU zQM(1#MWW@N#Y#a%Q1eXSL$By5vqA`HzkZVpht!DmpxvEo#z${DXxxij^l#gs}DDO#ckt6bE~|`@Fb`lDH`ipW22~ z?Gc$B*D-uS{rOu!QNxS?k>CUKhxC$)fFv&?iO>tPXdeT;yqO9OeqE^v$K%oyHLoP$ zO=oK>yGLzf6gePJ*P)pI2>f6 zu={HqjtIff+1~BNL@g*n4`tpfbz}p@PypkrW2DML?0xh>6v|GvSS@tWsmk$_j3Sw( z6zi-3tUD_s4;=|=cr075`( z%IXwxuTSG)fu%*$9R{ZpUx(u8T~uM^y7ENxyGu{%8O98Wl?_JN5k%luhd_x5ea8>K zjcr%m8E7^4qvxEaF9pCWY`CyGoF+5Y|K$u!edH){P0|4v0jhog)7I{X`D2im zB`q5^+IzPsx3tFaIl_WFqq26wcw-}2=+TEO&X4s~eAp6a2B|~TM zxZaLY7es2#t{ZVk1e$PJvF`ilP&kDO{MVwx^d!3J}wK2rLsI1IN9qUwb4djJ_ zYz-AOh}lgLQPoW}v*Y2N)7)*i;Mw)uKu_9}$r8=F(%Ha_ceRjLE%Um^m;^fZh$V?5 z?8RYe+B|%lQ`nH8U%*eZ(2&`2-lwZ9E2xh(}=>bJ9alIDPyXPvYtLV^4!ehe$M_u>gMaoW(L~p zuw*tiXud+ug2V+lyzd9Cdao6GxQW6LZ0?Ob@u^cMLLvrvT(my|uGP~!2YcvbX__G9Mx+2* zIgmHsD}~c?c=&`;l7)o$&EF6R^k(8;zhAurkAkeq^CCE#>Hn;b&6J zq`e$DoRaiBQxv>0%Ur5E^#%OdOX@cvfRmV6RovI7%b+sqRGrv5NCLC9>PFY@fKV@~Xx3kD^9cn1--a;o{Dl@{G2UnLzU-PF`n?r-4yP zUU=UW&lF&Ca2owu#Xww$mR2nJrz9W~$?D0{^$HBbd83*|VtUL6qpJi{@Nr5l!%l-9 z#MARKavl@ZAvqpm8to6PqQiQ31d3Llt=a8C%3$x@M?b9LaS2jPiC|*Lt#BiuvhO7# zz}v1(S6_c!YeSSlcgDtS%|&Kf>5zLc8G6MiA6CzJy~%l^2~kZ+Lf1;xDt$|PxtYVg zbZo`h;`4^+0TCEE0{d$7LoJwPc5D2lv-`Xe0Y<|Qvlnng}ugQK>uJqRT)rgwN5DQ@-uWrxZXMfOTL@X|{%1en?b$d7E zPmA@->?8P9MZL45?}Fh1`6TI>#Li$2fvtLn@@^N$-nhwQ-mCd=XnSp;(7GFjV^}@k z?-*VK^e#-l>K;dvm|3jfl zqbOM?FDlSBVN%f&>LAUBmmR&`Mmo@R5^m9KuKxtP#U&l@;yXE}<- z1Cm8SS0`y|aDN!khD$N#9-=~Hj4^C3{w?2`EX?AcZLWTK+c%};P=kdE&72WM@&ua%iRjx6>|S6@&^g%_ z!EORE&TP|uHI!Vs;LSq`%WbzP$wvDNpvQIgKL!MixFe=0M#42O3$H7F3&FfG3Vb^4 zPc`{$p$_~_Zn)5t)X$7O=|(SD@Sym^wpAC4L0_ebLqdc9*6QaRu0s7_#0a&yK| z7|1}@4~xRE7sb7%w)!9@KIT79?XP7Ew^mKBF>$D#U=5hffAOc31es`<-&pGc62jmN z#5p;X+*oAd^eDR5z^=_UdvX;RX7jY?qkdzQ9saM9S&OQ#R{u8Kwc?b+`2@{D@N<@X z9#2H2_`+3b&mBhAe#JaJ#G=$0hb17z8PK`AwKI{0%6fKYw60&+>;NZ5ho|w)4;c>&KVTLH2-p-(fde+%kl6r5TC1vXV zi*gTY#hjIfU0bu>+A@+N3>T@<=HcN_wH4Fr%+cE4_xjq#Y>C99*#_a`r3t4qWW`U5^AUd#is+3q*Rf}Q^o;WL?I2V`*@R^|m zyF4FcHs67RU_Y8-vwY%$JNkwNP`p3S#EXblT#(s-NoWoqxw1WXZ+)I13#w2&{ypX%y@*4}5HLHaIFvWFyS59s}qV)p(M}Xnbvp2*&*qVa=V$2R#jpb$WP3;`^7R#(}HayW2Q+!;nG8)-V>l2u7XWE>%}J7mqjp#TQm;q;l?z^28}J+lfA99 zFMwT%sbm6+Rfx3YZHuCxe5xHciSq;f_1e}>h1(qMB8BlG&2lEfJMZJfg(T#4&rk=17zp8ywa2w*|U z?%n>YCK9X3=77dRh5m52%@e}`eVm_oE5~(2o_N1MbxB60+9tvELw96eqE@a{$P~4C z9j3`hM6rG`Q+MwxdW-&Tf&e+PKZXN-tWh~R#rS-3m<>%pkX9YBs9XH#?%t1FPlIEA@~GsQ)n+&O8d z_3#UfCMR{r{KavSc1~9!lPYg?>3TVR$Tl=z^Jp;#xVl1Md~{lqpbkX0c^MoBiBGy! z?I5xY!)9^8y{}cBn(#{>#u;)7o5qR;8y6V#LrjEiRN-PBcXMDh#bDkQa!{M5Bb?<8 zrCK_FqHk8iMJf@}`2S2N4c^~1ZN?QNXlrFWVHwm}gW4B>ym&}(?q)t@15f5&-Wf7Q(x-(gZVKwcv*UDQGB|_D zSM#xHYK^0ELYcRbR1mtUvBsU0-h&d7&9vuGJJS2v!sY(KXo=mliLD{?&0Jjep$ntD zt05Go72Cy@u*G--^AP3DEs9u=;Q>3~Y2s2*a^N`KA0>xdUE2R$27k76<(`?Eg)0Rq z5L@X%8YJ2Yb^XbriqMpC-1Nx~(>|N1BZ#M|Rz>=z2wf3`|8Py%790R9;{qee#&c*U zuou($*!KT}K7jI~IS;9*sC-{tjrf)NM|)PBdpXjFRsi3`?ffAhLskm50R_8*c`$Nd zt>QXZfg|&Z1;Df>|8l8hmZ+HF=io<|PBZ5P*nD2B^Ab1q=t|^5eiP>RV49F8kj~UL z869ILCLP{zGM~OAtKRI1|3&BQ55nGrx()~54^)bGUxj@&M!A#_dDS%+1RT!IuJTt{ zs7?oO#+Lc&BV-sVX$!LKTov7)PiwvsRRm+L{~EJ5f$clx?8S#0%$YV7UcZ$u@lOtC zK_5iq3JVBH7+ZlfT;{0}4hsii5eZQ6Kw?38UZT>yb!|!?9Bre=G;c?pa9pjEOeHWm zHARS_WVwbuI0;pI!qswbbR~%=fz~7dFVIu}v(?vug|V61Fx)2_0+L<R4F4$+50ef*sDlAA^+@@?pPrRaeakhC^YR_! z!{5sQ6+iRGr^L%mNsnJqce429pv;3pBD$7q{p-vEqC%~=lu-`m2G9F?uWx=n*S4tb zqWDLT%N^ObolNb;elYuSwm^c|edC5v573NKFWs%^srjv47p228b^jwxN5BY64^rN3 z;`z@KmbetQi?K}ktQfYe{Q@o=G!VM+{pk-Qxj#(W{{Nvw`1CXo`%l{%fYZS2>XZfq zDg4O*PV@^~r+y3p+1Yq(Iqk+rw}sWmxWXvkWIv|7)pEKn_bJckZhccP9S=bG!4(RG zu!JD*Xx8Qa6#|CO4{jCfJ<`?T!$J8;ON4dWjzdNCF?vKfN1IRA=-T!~EbeE_qna7V z(R!hmdrq7t5z;~Y=KPPry^9q4ZvxD2vi{eBeD`5EGj~Fb)1EU`VbG`~pzLlqHq%qh zW=l&!5GI`hUax{A#eSe8we`a(y$K}b-`uf8?|YgF^$;#?&33%c6*vEEsU3o>Xh}~) z&3RuSU+jmG4b}Jn=qHL-yChx)6F=6ZGS)wlXSIIOvtd!=YDN)HLEM&U0lH88KsUmN zuQ}OHT`@3+bPFDBi&5DIM^3MEW8B@3`hCK#I;}7k;?H?ZUo%o8kHZ6uD%o2tC{{_k zImmRb!!16fcVJ9?X#wREEXby~WJGrrf5?4dK)Bw1>2Vt}zGt+wuSsGoAdVb^G@ym_ zzoaiaX69_Aggfq|a<(>%?IVQ!PXJt6JUP_?wilG9N*U87o`yNcH1WhgB`Y`81>yB5 zR=L8W+TI?AE8+#>S?MS5R{?_AWLjJ|T8RT@8QagpclwheFHbiFaaD~5(x%jS{c`G9 z*}t-(N#on&=tv>@hLaG*-ph}=V%oF}r3H)FO&z(P(t+aB3UR*rlBI%gUJ9y|sN?jw(z=bkn&dG}pQ8eMI25Yg+s2EfY9BvX^Z zg3`80j9vJz41CYZxu6_5IAhN6S5W1gj=i=TXg(1uk1dp7V&gW|ul#+6W`oS7l4F(n zL8V@ndR|O(bPe56d~-6R1P8CjnU$7oMcqQjq?=B1017)S7(th$Ta;PYPMacj(X%ku z|A+IUjDH&ct1fe?N*8TcdkRw$6J6CtGkh1SveVwxH8AnTTlAhz)qcU|3b7Q9QcHBB zbABS<;mgO)PnJz@CX~=x`xMnhm@$Und$&&%QcxvPi)DEMY+ko=mz9V-^)% z^#TJfA=_sny19N!;n{*#bsYlM219TM$$`&;vPm=urcf{|n%^Sa*`0B$`){dX8kz=1XWu8D0lMejhb{^EXe zE#pbouaC3QzmuuzVPyMc_Srb$6I?eG*d8qd>ASn3iNwOIOqBBI9D)flra}DiyQ&pc zmiIy%Ia3qZ0nfG z5v0WdL%mZ#<_A%}vQck_biKI4yAl(s>WY>8Z$|E4T7&}746EX~ah$^YL(QNd*GB4# zTeUL|xlnU4os=dQFmP|Uf2Cr4kl4kARM$Gn`Fp?&{-)2L7#gLK2RmMJg-OS^q~nLj z%j2-Q8vm-T(ee7dZL}&5c;2u8%)7pilo%|U?sdZ7p`c{fhjyUs6LGNb8n-#^MBZ%2 zV?^>4$$s!wN5qr&5tZC&=Vz^H@jxPx*-J*fK}bBB)fD$*LiLXa(Msr1&+b>*JkKByP40HG$Q>G?Hsy+-g<1 z@SsPZbjWv3Nd_7SHmSiS#w@npPi8m*q8!mhGoGYc?Qiu{;Ax8(!z9`b7B|;^hZ706 zsOO4Jc`ZbY1=IPkzS^TDWYy2k6(ZX1-pZN~>E44A>>M2G*4Cbpfr2;y{D)N`%Wx$T z-(%=H*GgnP(~3%ye*H6xeSXr_#~ID9LkKh^>fsd*Im^h-mluup^w+(S>ac~UXy4uW z?Gs)o1evqH!Nj-MK%^?`iUD`|Yd0WNO1|HfdAv!;z968y?xMYRnoj{|DJnQ)jbFGw zak9-clW*3q4p_sV)2P=YC0V1~)@+Id5ZAgx1USLMRa1*G9@MAg;7X-&;7OX5v~da# zX?3)xLxCcW9WB{??3fXE^_56gs=52dJ$2!i`4$14$pep&}kyD+tv0B!hf=LL4HJTk7AFb;lwl!+) zpTbUo^;JJ)YzYrX*>~eKz2)@l5okaPyPNYhgZ26L(2|uGss?Es`yPG!%x~v6k9$vf z%z^1lyBK>*tRTc4A9SlXMv?H#L_fM!sHNo*#e}9P$xvKFf%pSP!-qjd!Y#W!%-0YJ zB7323#dKqMM$2MO%Rv$e{EE*Drd(SlAfmb$R$v=nj5iuDm9fshFEhvn%XKXepTh)H zG1S(GxUB0ORymsCzwOg5hs$DS6`;{6WNa@XHw&;D;RWbe3ztcdSz6rLI(`3IK9PoA z4yc#)bSp*JKyzy?-t3!ZzAKQi<%oQ*D*VG`|q+yT28R=eNCsOBA>4dg6ZZj}!({8rR^!AOmKF%&>#^?QC$lFnL)vhu+6k zr++>d4G6m&7fmGUCM`2S=8M-DaUQ|fGojUP>tqd_I;mq+W=-cPwqYv=BR@S&0?%92 zpwz)Rc{~~#MV$#%WGAk;AQu9hu7B-3l^CCVMh}RkQLvzjHJ5GlhE^v}Wy&?X@vaP0 z7>OR%qg4Q_lZO{yEw&A04($3PA4vhjv{n&3{reKLUZ6#Xt&Lo&o{R;EgOOOjP^SH) zHEe_<8pXVEkcWj*RT#*aRccwK`+}W7kq!&Z#rrEvZa6^qE)gysD&B=SVitnX zhzE-oeyRBSVp-hD4O&@nQ^$*J>#a++e<3gBqZa?qbm!OBSz1IMUu|(V+WK zWI(sI?|4s&*A1f&uBt&|R8P>0f>+9Mv~A6a1i3!@Hoo&A@zj*EqwPf3`Zp*|67KiTucBA-R|K@f*As zDfC--`HEVfl@wizYg4On)E*4tcnyN@ios)gNY6~O8gSb9ipckmLeZTc1mBFwZ4MtO z+>=_pjnYEV9OsJ&r=QD$Qpr!m@BY?z&2Zw#jFms-J7jIGyyuG2M+nd}t!<4AoengB z0!4nSw7$g>0T6s>xudi$UL;;4wG zEC3+ND?DNI{feXFX%d@i!P&llagMSf{S)b6^h`b}HaY3H-KdA9*MAyuFn&$BGT_7R zlQYPdor%~y+7|>sSNwN7k9ll2@qFnUH~Ui7DF0v2X>^LMHuR3fJJHnH?~KY8pdWZ) zE={7UGCl(?m!}Ysq&y2!^CyA~KhCD**Lc&d9a@3^y-lF+*vv#nzm|C#scf0ls>Sx@ zQ^v3CJq*dZAFsO7B^4kkpLVv~bdLtqgwskkNa;S(Z#vZ~T7Zl#cI|_Nio?4T3IY@8 zWqpiY^|!m&4-aPIkJ~ZtB7~_2J^X1zvjHMg+1B^v?u#}4ZT^nt>@1-B3+ex|aFy&g zbfqjQ*J^Op5|>Fi^1Ne@%XuM;Y!8kPD_@fe=Zrj<5XkihlzCVH=f4FO5?%;#_U5~D zIhEV&5*XeLB9(@R^C-LET{<6!qBp%D8z=ybn60?6-UuD8U4vrtBH~mu;(bKi9+#PA z+TD!K`sWfhICix*nXslrkX!c?qUdELsW{#$lD@*fx}?Sm3W6%}T=Xn5Eixm5&H@h= z0fEfyrd_-*k{fW)I#gc|gEYkY|3C8tdyr=r;rNU4?4{!M12X(VTuI%7qau^DLHeIm zjQ)qo{$(LZbK(GBB5gFhS5TIhy5jj?`~=!7aNv}l+)g8Omx!=Uh9n$Nkxz6 ziRwczJ0gc5bp%MrImV@1XfSUp-?0U>qjK3AVP~n7x7=I5o5(~nO|@Wc`6hb9Sza+! z#5=-;p}-qjH)Hlt-_7jD=9NpL-;kLIbv30eA3^`w5p(%9g#cE1GG3U1*?i~3Cl@i(@qhR*gn zQSE=$%C-?Xb*yD3&(5~zTCv3rM(;H7rXkN_{-Ek@g3?(DBJJYy^CAV9mnVY)Ss=>?q>MbsUcukl#w!|cj zf`i1B&GPAs<^TGOQ`4%^B$>oQ{zXNmNgmWE&f9Ru(t$H@v#t2yTAENfOAqN^W`LE9 zVhA392;8uDzyC`;CQQO%oWXiii6}M9!&Z=_sdkc%F_$)QB0)Pm?p|0NNFTHN{^>RS zPRsR|rJJaTW*g28V~Mvz}y$Mr!LfXriP$#IStKm9mQb%l&4Qs-8$GsmonlNm@K~q<9vP~-fE592V z#eJ62H=~MPxc8WEKmye}1rc=EPd{s1KMj6|f=qjT{HrRA-&AXk-7<DCzIrlU3j(`X4Ag90~prKB*zE4IAFz|HEuf7N+U5EbWCuk zG+XwXb0*qvrP*T;kT#*}B;c7wz3HBF>hX-6yUtta+uzQ0;QGV5wgR&CES0sItW zeiPVNU*BS^^DMo;S2}Ya`kIur&6tyZ%c+_0?_-vV9ehyh#Edjj z;9W6Fh30tdz%4LK3-H+U0fweG)h=*oQ9>CjZcL9NlmljF))E{csGBohKIE;B&v!RJ0@>2rQLa&1jj)28KzFD}tne zB*AK9kZ?E6>WV(x96KzNROae5{*}e68*RzO3DCgGJ%Lykq~pXh#@UwF$m4b_2;l?) zq~(Hlo*;q-B7u8X_y$K*V;>{=w!YF8Mh%pFq-#a83q}HGy||z%+ThK%2MQ|FlOOkQ zUjSLN#|>12`wwo7`N4^0Q7?Ze_fpTVEWnwOXr?0nK%IeWEt%Z^e82FygLSjlNZ?}a zf?{j{0&{sD%F=@c`<_3mJe}b%ojr0DBrB!>&-((V+Jb7oc1HDEg4(M4^$LA$d@m6? z2pW#xDXvWDB)*tUjAR4DTjs9iN49%Em&R(NR!t3FM|0WBU6N4K6lBjm-6 zsJ6*cMpC(M2lp8n*S8uVaN8o4#EmSj?75Z(AJUhCC~MecT#y`yPW*J|38u9|AGHS& zyc9{Is@zeTZFQr^=<{ezhTt|qcZ*>bwca07Qip{Ea_;-<=(Jd8fwaw&9Nhf*>f>Xq zR{Z-kmIypd?0@R2&xU-e9#R!wTN=Uh{7NRxd^`yg zPwJ~|bL0CWUyCxDwVeZheBSaA$t+vN>lJI} zGc#RLTpcX>)yQl7QvkuGA5ymybS%N2qc@?OpkFwZ2z<^`mqTA^e>CV&0V4Sc>)*J5 zI#<&89jWX4NdD>Gm}BKyT>5O1XeH<-_NksZGzuzPo7o%=3c4LH}QW)D_^1!F+X*!B==BNZPE9l=}A)*m`~6rWd+c^ z+)=@vMaHuN0i&)i>N_>?t5g+m2kJf`8dNxrS}W%#CCPVDFhD$~<|*G$}*|U5=Bco+g1% z`eK;RB)Pi+ScJhCvDt+)C^^XWIck7Xj+=;%()L2|*1n|Z#{R&M4W9c}!h|-j6-P!E zoDV8HWKEL^!WcMi>FC9)c=zRPB39{Ya9gRH1X)}+ad^-}EV}rmzjTqd3Y!6MIZ_Nr zTP-)XdAeHKb<^*b0O8!ljXvwLPU_(iVgpaLUO`!af6oy%{D3R0)pm2JhFml9;FP+z zkWCvKOC5sICxEu|!ETROi;HXD-(iUWV#Z~?iNBU3oP|zuqi)H|6GoWPV65YcQ{ss!MNpzA|Fv8Ay2A6S zfu=$L18n(>0$&x4vzH%t;2ngB%+~(i=4q##)H+JWpe#km#m0)G(t1%+_p4xN=4V+I zz`X_bMSK_qm+rI7{&x1KG=WzD01OoYpDk$+p8x<)j~t6bRSup{Aold0zVYvAYwpI{ zGG=nx8(H3IN|KGW;6nwRUHRG zlnjMD&APu8iZh0Tn{Mow`?SehrWXC~mI;2{_Zu`Sv zgx-~-NjH@?u*si{4_WbEsG}*R6M}^UKXbEscpJOs*l05D5f;*YKy+GuZd( ze^x9;KY)#dp{hv_!p?ybz141$3wtytpd&BHT@Yyo9x;woFy4>Y?kdMO-u@_cC>&Oa z@n*-2TdwA`^=6)`>yTv{LgZ8Q=S))+gA3&UNG*b>{@_slX$6+zfVjtmr2~@ZGoyJg zpKhMeELeN0oIz(k=nfaQcw)JOEt*aD>8*GcB-;lCv6c$L+HV5IyAm}{q`b#SwTKrc z;t?|xjP=Vi61F-5!SE$4$#3}D$a&ZAa6LV#KZwQd$PADZ1^VXDYwArVJYb)6M;xrh z98yc41Yc{M)E}}=rFk*l(hmpNE#wI^=k;3k%1Gv2t3wSsHRxMiOGY{T|NoVDS<&fS zc-r}%L?Ws9Qt^RXd99i(b9{{dUtFKr6*3+9HDQmm$_9X_Uc`$v{jEoXz5 zuJD3O=XpEFbmpKQwq!L4$Te=o*hi^gUiVQ9oAGal4NOD5 zct3Z6Sy(9>dKvd?@-;^2miN9@RUroQz{J{cwJ{nCUb_oX;yq`MizP84Wrir8jz!#q zB6J&gSv8(&9g+*x$HMD?AVA1q&+h$&lH%aTB8`$-kBvts^SE)*z-GTr6rmQNi z!(7@^2WAyatjkyGwuxR^m>g{eZ*hZWx4%# zmsDQzA@rcc4$6AyDdpPeuoyZFiTrDS=SJ>JDB<@K!$pY}Re6sYl;*|+x1duBM~mXG zkHEEht5~lIM78nGa{aI9vf9lN#JC=pUhynveo2AH%H1|STDzPTRc zj(m;M=Vwy>i1T1_&0cs%BY0T3PAip_(2iO3rGHImOEt#}_O;WOf5l-4lcC2|;vd$> zg|_m2tN5rs6`X*AGx}@ZH(?j+kXacSu0aJzWAPE)TBYz39i$@FpQKITeVzE>EEo6Z zH`6uOqPLd8ZbGzp*-G{>i1Lh|6i(%)B7?K+$e@)~+XTB%Ezl>wmx+6Og zCcZ5F=my1THo61Qgyw#=A(Zwr0%gL=7Ym$sU|hhCfZ9ZpJKE^wS{#N7wD^XEQiK>f zsdbF*XtjM}h=I=-6KZ}>7M>`1Z{r3=pLO^+kJ&Y_fUax>sgXGxXG>HyG zX~+fl&AqQjW0JQD<|+{^CHIYF>9S``dQ16Vff}e6fLHyHsajb6#gb`^%hu&hMfL^H z)bM;RM9@=xg+jtig6lz1eHwvG+4nS1e7FSNgxFqURQVt61dxXdB4k^hNYh&3&jvDI z5hp-W<3NlQqyGV(GOjkLA{JV5x>tegul**kHrH`Yd_1s#1$_3KzS39?4jgwZZZZvgw5b<`c6f^uo|nu)a0o!^+~bvpZu+qXV3{ zDM5k$8X&BiZ9*Ca_<^-7mDpOIPlsV ztTjJ8KpfQsA_siXUM=s%lat8zg-6DgLqL9Gp0JfS0Re8NL3j)}kg?o%#&cy$lqvw> z!Nbm_CJ6M=DF0n|_L?*?Tw{KQsZIB;y)=3OV__za1J|)63CXP|Ixnhz8k4jP<1Lhz zivg?y8;EWNB$?AC{}-5mHu@_J7b-CZ6YD(%BfI|F?PuRrJxRkN8lfGpqU$S086-$6 z6CPUmNPz%}*8l){c!;0?V@V4Dl?;fam!fVH4`DG1uyq>snEba3 zjF6B&vRk105Chm1zEGypcE;Z+)b>wx;uHzP0a|JLz5nXIHCWUB?euAmZfJ}x;j zKo0OW0?LWrR|2_;w&*yaqE^CZcx~iH_NTe~~OGQ1yh6;?lT9(+;Fb<7_sM(D6sCDl_CxTaKUz zmfr0j<|=Zru8R(UzbtsKALXR0W=@A+x>Ob3sA5CS^NJ+`(^_WSAx|dGOEqywe-(Qy zWZ&wuO#O8b0waTX0mVqF4*sx9Zwscitqj;wpJo_C(6JE={O9M%Pe-BDI_XT2@^iA;e*TTXN zk_GPnBJT)FaUwiw+ynQOMlGyv+LZ6}C-BCmsNXP2XE%hMKlWcu8K&r)SXN#=`m0?Q z?_&`WGQIY8_}3DiJ94&Eav{keo86ee}Nom2## zSFhl)Y6p`l+bBIs5`+&J>(J(X9HE7*J7efMMXa}29*&xof&B*JI!*-1h&}hGp6QM6{tLUm?L*lxC24d}KS-uKqs(rCP$Z^&+soU1 z%@VFFffQ3wX^qH37XG&JKDr0%mH6-eT#rdZO-5fjSII&HCbrqAkmDtXRKv8@*I>e1 za@}SQ2@D3;>|sfd9!Rsk;ncu;bqM};k&q#a0cwHp3L2D^-GfKvzQ=Z-`>uSL@ZJ-H zp)`Vs1(ksJ>_Xkh1eX3Eut6xq8Zmn}uww3-8XuJfL%T>{M)xmZTFj1YC(#t1*SC-7 z0Dh!RY-zE*sZMIC`AIgvS|nhOjbD{Ksl)u?75W`390?!-jL!6W6l>%x8F z6za^<$4-mgko}i(S4h9TRFni{+ipWba=MAh;hnxrZoR1*PL=oXBks%FSRa|_#BH-< z^Jps}TATMwP!kdrYTem9?ucur0@KF1gtV=nI;ANx8Qc*CYA5l_v~@T_rr zCb6_1V*(Ww_O#sEpAVN`y)xAmJ>ADVs6OQF1==^sh!bM^o1Y=5zhbx82CIuWN_bVk zwqu}N0$~x#wQ7izAIts6#^xUT!>6VtDn&nfzXJ?xhAm$?OC7+>;UG=zaB~gBAE^Cq zs2wpuu^yRFfb88dEhC4_uu6a|JqHA~pyYya(tohi+ld=6;-+uV(eL%A9uODw>?D0) zfMg85C^|2ErTOvuIf*X=LjBtigwm3!hy6x;}7Lfl=nk72ik4Zn6~=F zQ>|dscAyBxr=IQSa4!LRB{HD+j@j0q=I`m#$2}Sp8Re93LFe2U)g!Q^#^~=U-ELpw zgE-fZu%x2izR9s)>}3Q=G8rc)&`J<$@I>1<>AlrWkkSEDoDt|wr{v9;wpfy{8bNua zzVSHKKDDEP#T$iXA7}#Cz@+pN5Z5Donm7%Hrx_&#Ff@NzPi$@5y%VPY_aQ z>^DN1h1tBrdtu#SIx#40&S#L%8qsH_;a6YC!u}1^3THa^xyp zDZ_a8p(`Qc~ZkGeVG?0zdM`C^RQvKhhZgVarhvAn=Q)85yOT9P8(-?J~Z z4&*}t-5v0K$$*iX$Squ2OO_c;PbDiD-;rA)gB~>2sqi_glc6!CdetH(ECrw!SlwMJ z;=ToMekyO}0Ju)a+!Hnoh9qE{9?Lkr^OwtvWw+gB$lz@Lc~yPDW%;1;8XKv|p+=}3 z{FdW3Yac~21Hyb%ivG?FzuK^{r%6vC!iNsI9a-68%^9r!#J@?-)QcHfPmU_H6UIaK zXn0$j)wM~3!hd(E=#EDHfoWOPeoaX4lTCebIT9B{s0+p(sB6R>Wz zi2M9KLanRK20@PnUmVx8XlSILaT2i-ZaD5}=;j$7x1DfdCYIIeeZdn-0a=_!Q`Y5K z3gv5nqo{6b&y-OBn6SueI!3M7wCboKrU_P5y$90kcZ4kg&}%(3;J!r`&4Lt+TkVL~ z31hf>k3x)u!`rO+PZzWViEZIn>)0{^$~gyE`Kb(OlA8k{9UMz)6Rfm1?joJc3XV%= z6h7}eQ<@AkznrW#L*&yjWtFAUjC8U(sA9kN&sT^#n*#SVXn949;)k_!KmD` zp#B2};-v4rvS`eNxE_@-4w~T<={zsCF1C)0Chw;5z{stJsY1}djh6=R|0b0m&AkUO z8`Wo%`n32=XQ>{5BkX5Z{_9)bIxW3@g?Xa;k2ecf^9yHE_zz}yrMmk5PuR!Lbbik% z5G_DuOgX1c?BkV0|Et(*4LV_w5`PIRY{QGYI%#Vdq9yt2LB*oaL`M7(g9cehPljsx z?c$hP;uwp!YAPX9kB=Af*YNPgPI;{{s>%xKdXq4@B(^=MrbIZ~OW7LNfzoKjVNHPc z2S^5`JzKBHjM*M<@kuALQFVtQ5#4hX?*S3vQDM;2O5kp!jRE>|Owq}3T5ZN8Tn;Eg z{WsV}{HohvE1iMTXE{*_gmNC{@p@5L>*4KP!@pL2QDxT|k(npt>pvcGpz;+<`0SJHX0GxQ(l5_jK~`9#7;alN^NmqSCdQ~Urw znp_KZw329{7ZPJL=|N5QjB7AciBuc0{)wDEsPfQm5k(6hgROFQfTn4 zT5S8w0H8XjjO{|=<7{upbF_PY#=^sMnAV(qKdg<0^DNe*DtdE;R*+~GbroX*EcBun zSt$In9vKV?%(R`JwoQpoK`1#fH){Ag`*ch zmrxI`7`u%693bf3I%=DR9HTbyE*on@oJac^5q?Vp$*)wzp(<-*pPz>)o`eYvs~S?G z{bo1JjgM}N1`TfT!h4@#7y>Jesw&aOTI z1N$qRtc^kShnqD~DqIQ#R2@sy`{l*D)B^mK4i{B!0K-QB0g*_QaS6e+k_54u4%YUf zY}CsBe&`ciMP$L41ETi&^HnJaPyP)^001oZL7Ox+2ra2Hm;^Wf{;E{~01i6otRdS+ zGbR9TXcXCLQhSgk9zSa?_4{4F6-IuYvi4U}?)u+Fka@wO2K z>4wzG=&CJY+=lPsh37mW4j%14t#|*S)_qp!1GQs6e|*xjw(tlw^t)1&&ZyN;YP#4Z zVBB8du)0QRM+K4%e($^fzA{@En%-FL`2m>3l}(OuR!KD1i||n`N9E7RdDjEzNW=OC z#=Lf<0Z^*YTq;(Ls&H#e1M&)voA|q%X}M!3!4wD(JU60`D=Dhqzo5~mvxSHU+z~f_ z)f+bt=#TL4sVRsefjA@RYU~%`<)c}o0NGx#SXUrdH9edwF67b>0A5vKr0`YX;{llM z4jA^HnJo;LA8O25PASe0DdV7PsXs2tb<%ECGAI zyJHEAP0mT>!aD*1V2Qi}?yy1!j8H3?W>TgdtZ8C`IcqE3wn5prN79T8LUxO~M;1|* zVl)sjJE@_37+%cr_>bZ>9SJ!P*viiB{}a^o?oo8hW6^+TmyuFDQ1gv}t^QO>Y2j23 z9v)v;F)hDTmZROG*UPRj3E1d6D>B$sKA;YLaXLks)CR0E$yi8q!?7=;odbM*8N z+AHOyNz-HMGVc2QSFTQLpc$jF=^Sevc{NY^^Iv>)A4oJ(eXUbhP1e1Vk-x zpxPo2n)I|6f*!#bHN7F_0IG{gFWe`Lwi{3cfn{-00^MEA%rVH8&|(PB%@I5Hb}&#J2=Qw zzdg8)@0~Ro6jOL?$U;6p{-m&tJ%rcUVeWtxIwj>GqHLgm~<_#}=3;?M@a6%*xx`@o~dW-s#&3l1fc7Jf&?h-xt--Q8+z*5MhvK-0Q89 zhW_mA3nz71bLo_b`xeDP61t=rTvO2blO#ovtva@DH%96ot6uf;mb_JrWQyyCb`mtO z3sucsfipYl5+ZO${zjviCAfXu$hgD)Ph*oEgertit&CbQptm()oA6SRL?L@3T<*-C zwVfz2mRY*1YFm7zBG8z%>p>EPrc6TgyMS|9dCuvLnpUotV8!y`DF)PHN?S&I6=ftb z9E3*Jd0T?R>BjT=S`WDCniL zKB?QsCU|PMJ2M4N&;Jk}Hzn-+A_wedXqg3}$5P&QeMT8r##P|BOo5Z_9&-|R0YU{o zE6+CDR1RGbywe{=Dp9bXn1Rr!4o)0xK5`-A4k4n=1wHF?G`im-Z(pE5eDsuA&XTiA z&{Egj+{AO9A%^XU#fQ0tshmP=3DMIB=dqQ$3_-{Qf&Mwj_&yiw z(=}1P3|U`5@>+ruw}NJ}`{Z5rXw9h3;TZ6hx(5wnwtyH-y16|vt*9r!VG<563-&%6 zW+uoy%Lg?(sSvFT$7DAtf@m6zv-zb@y2;6m9OYdw(~_)ERmM4chp3&m<0z(g!nsVR zu|w#t;W_J5D{-{h)i+290Gyb-`&L2ZKUDH2BsR+#z=6?9z=Yk8DCTWpIBrP62jXJr z^UF&yT(8|J-oB`V+Idlc)EZTUa+G%Hk0d9JJFmhCRvc@ z+|C7)6Yk)l>#>)}?$TBYTN3rs&M523j%lH?@j7MAL?MevA@c~g5jyMJ$?KH}H33@m zf4HCsi;7`R1rP$v_|v`xns#)gj>)71@mo#@U*SfMW=$(fX;&tS_}}&Tau(&9Qzn29 zf*cA&CAVKgr*~ed&%wq9Rm&|61}Z9^*hbP8@ZuShAUwAXCa?h2kKf`w7SvXANl`$< zMXdqgyZ4pc3Y<%><}v_xvS5DaLk{8INb!@-|#obul)j&hgm|B>WVaN9~ zj_|_XK4paZEaM=Js7g{{1UQVN%j;%I5B$I^!wS#Sfd*k08F2e|uI9;sT7iR_W&Vu8 zu+9RKwBzRm&iqfOTQ02L1`5fyy2F7uw&Mt@mJh%M#{Gd`SsMB9hJd-5TC^PqU&PeyM<2Yq05ctvl`ZnpFW%D;Z)@g-=GgnUK5HJz$6h5R4ghidYR zYuX+y87(r1B>q@%wnmb|{iCGnKEsJEcz!pj<>j3sffY;8C2D`Nqj(Gim}i)N3ds$)waFx5bFGoBj1N4o1vs%QMb~wE!0ECW%Hsnc$!OYB#7GWlhR#0ciRTT)mw-yNjvN2RoK#KzN{LwD_-CmX{G z==LB9Ubd1;Rvw9#)P#%{M<9({@BM#?K+GFvQ9x< zf!kMrbtE~gpzL@xoAB`l$F>ftASvP(3&15)2JJ&=L0N)-G_4j=Z2`vqLj2d*@s#N` zUk2I*bWzsMK0d4?$bUhiy7%N~aJWgiOz@atJ#nyf-9u(=Ct$jTLUcn%EO?CbeR4kC zY@(o5;oqn38W#ZHa&GBaHE;kX>~ zTcgf`)E}1RtFrT%km6)QbduaaWyTaZIsYbgqyY-96oa!3`9M9Vh%1?;%USy(t-)*G zM|+9=Ihc#|*hz5c&+VVEmwbk~{Z=V->ZZGQ`wKpd@P?)Y@zy}?WYwOiKqq`NaMcKk zTu92sjYo7(rTqR&y;No<1u9-JZ^@2VpzxWtlPGK013CgQ89ptR6Ii&SL&BsAxM=_=9HG`nz^5B#hIjJC3?2)hHLsiAMbJd`N)_R3^O#TrojqsXIjW! z%5R_jlVvS9T@NiOFgaJ4m=!`CbeYZGc6?S}XK_xLZ;t_+n~Gk0pLqz8?pkx<@>sSN zI*VJ($WIJ+yPM(2rklK9{VJI-fbtOUKo^_soV?1nde^XYGYQdOAW<($5w7=Mrg6Ms zDfO6XI72;y)wOeWDIC~2_GT-eznhciQKz&RX=$pvG$U}HLUaGTxNHugJXW|&MeZ9C zGgLx{W4Cb$i(ZI$s{=J07xRc9lOMn3-&SjXCzg%#B4P3o8bUS$8;zQWT>;|5{ZPVDDJ|2ey#ZEj65X zTa$72KE0ktq$_&Ge!6^fqnt>)%#RC5S!ix*^s=@w%!gXe{r#9+uFuqQlE9xZUy&5k z<=&?XGZXV~Wywc5PG)K1SrTC?T0S6?e0JAuOIvHv*<)|qCRr3IZyp^EJdGjmiYpLX z4~Y2sNBbcU!==BQPD`1@VCS8Wgo!|NJmdwan5^oXeaZ&QkUnmlCXkfy@j>++F+oJ$ zsG0)Y3o4^hMV(*l{2AyVpeZG2hls-E#ELC|wMjsS<2J(Rs^%9>N)eViN5EduXbgDb zbW!Uf$255J@0h3DIGlg2ZKHvXOGUS`dQ{^+p3|Z_OC}zhm9_PILM(++#BR0)~aaMEmOt?ijW{zxxYkuUQR z@wiFZ5pm%5A6Dv!nh+ElDKLg3FFL77fidh;6fa!~non8?6yF_V94zzVhv_2Yl;Q_2 zX9(q?J}6EM;?sYUD(Y8AFhYtUg;ewkgVLDGNy!JY<~+$o)$PgF+?qHus-m|4VZM2M zF{-3zjC9=#u!m2+ zp+7=biwH#Qa^6SggGw&L{OOny(}QjfX9v}pf?IK|8BET3%b5p9?lWr(<%`m*M!?te zq-3%uSLnkN$$N|c2#G?6y=y5}3UWTn>FWI_&y zjrkcCU9F+P{9!Fo6^f3WVL0rdc)7>E8WV=Ce=apgY*Z0tPtYWnhp6?if{~q67g`$( z%)>FB_QaowC_~!^-f;9*AVZ3ML)zUEQ<=gg5WO^N%4G#KvC2qD*15YEy|9(v?-UzT z^eiTIfPMi_ots>=M2OJCJZUjMyKPm7+@KB^-W=V~1v+wk?w*vE!8z<1rO_O44$Y+} zJG$KCHxlx=@y^&kg~(I=!Q~~W(_@__RUv=8QzwLu=UMd3EFRI}LpCc7;%Hq6A(!Mr z@Q5nU1~B?|7jB)uzePdC$PFZ_IowY2muTv@i9s!zDRQ}~f^$w$kFhJmZ&pW4l9zb! zI-pktAkD&3RWm?AFf)_OU?R}ZQcc$Fc9WrCMzqydVJ+z&S}a{VYEV}--T+M~G)BcH zK&07#UPcoit!DR*$;@=q+V7>o{O>zV!++fcAK-8&+Wd5JZ@Mfo*DFT-!?O?~WUC^= zKKc?o9^lp!n!zoeU5Uqi8|%#x>xCPJ<;1lfoIxX^B@_<*N1YoK^t<)K5Na}vq-=g( zK`w5-w2df^$$ePQ-&zm{xc*Z5Aby>kVaT6H&`>@dPn>*d6=F|yThn(4aR8TUUy^|| zPT2hazJiDSp~kISdg=RZ%K=am^%dbO@gYE&;D^BqgB^kR(szDr7ZQiDKc(vA)-MJ~ zm8ane_A#9m&&JcG{g-jI$ypt3AmG^cX&gn(s$=xk0tr$XHCl~ z%_f=&WvKYVOnqlP<;$C=XKkTzExh)@DQBnde^~CgM=`}P;~(5xvt=No1v-5#->6N+ zFL4V;gfBF)kvY{`1`!wArwhQ6RWvViN&)w%*$qN6B66vCCBQ9Ve4kM0Xq-)*Nh^rw?$hAP!=)v_rcayqx^z4TQT>U=&!w zs~QlaSIGlM>=LlZZ4Rm1h!0|uVbsWob>>u9z8@$la6hyNKggz(XYmxTx4hc>5Utr& zHHCg|-4p;OF2LhlJQKNU{D`ce`&m*sWnjd8t&iHq;E?kkn&auN65rvra|*!3a-7@X zjq*9b-2~S^C_pVZcZTkPimo>){1q`-zJZ7C)Z(S>t9b~MtgL>XRKFaTDyAnF+?4lX zLB&odEexsIZ#N3s7)o|o9Qnz@2m$rP#H zJj;S>$Zbw7KY%(M0#E%W?la7}>@z0dn;4<9kO^bTLzqE`w2FGO<69xg-8jY+b!-kD zzi|>(T7fAMdsj_=Ps*B)IU0z&3yq)%CrBnX_`&HLsw{LN{iLA_Ry`wD%W+K1 zEpmyqn5U=fFiM|sffqdfSSlT!v^O{B{okS^CmDCgq-#35g=-OOW|l5|O9O`2oIJI~ zL!lFSIVH7%mD_f?k|`FPIbnl59J~PO9!yx`c0RH?I8sfsVSi)WU>9$AocBfD1#r zX-l~YDNtAzG5ab(69_qN_f@Q3d^2Az)TNX1H1R5H+@I|BhH5R^E|*(qx&L=MVMc9o z#k=ga<)a0;D9|6}qc%x6gjCAt<7EoChzQoXti0E8AY6eK*$wVX%O@+Lwcs1v^#mWW zw&MOv%=q^&=&#pU7~WR25U=PUJJ``6yQM`v^yjbzm;3COaEVybRaFV2pl4L5>HPJ2 z75djY%L-u&Bc30duw)}bhK~*ke|}nuHWjoQ3G!o(zK0^FFr11!3882%i(1M1Iq7N2 zewBt6m~jXHVWK^m%f^EV@;#Auf-^K-AJYI^$UIv&hln&eaBr0p4ep;0<7!rWkk<5} zoBL_LpVzscvj~5@l{jFM_BbzLk*AJf03NX`qB9m`=?lb8VsP_uUgT#i{aF|NVM3r+-4} z2VY-wD=*jO2O{5HC|$nUgE~aiHCRv7|UE*j|2haD{MqFS^8072}t9iPi4zHU{ew`wUBHVDFj# z>I?vyWz)q(#%SfaLldD>i=0xeulG%{+EGxn5`HSLpScRnd!whpVzeS;Yb#VQfhSni zyx{h?ij3M^Zr1n|Xwf%yX9Nz9zO;m*L_)1M`RCR%Zmrg76bWsgb{T7+_>gByb;Y$9 zgVQI9#C#pywpD|iJ+K_T=PEc3RokLR=LiJU8ID0{M($I(27Y0J9{2}0m-}m#8Mmg!(~#;rE_DD!(q8yH5@;$^FIf{u=Ed8@- zNQ=6ZlsvK<-lv*IeF0U^Qw`Yjqh!;RNwt4}HK&CDj@=tV-_!QgJzaqyLHI=#9yqLu zYLyO-(Lhv9(^5U`_`M|W_`ry8#(+!-t2`cqstL$WeNOw%XGXWn=vvxNaqXA84Qd47 zlMgfyZ`_J|W5o0zU*_nsgT_rzdCzzTvtZ~ z*IA5E-0P#x&U;iq(^U;YJ7tAMZ5o+i(!Q@YF3f<gLrDi7S+LD` zFbZ&PfTYa=GLQUZNRfCi2HoXh{uE?SXcHVapeUcbI(9Wo1jbiwEtv6_oFSWp`Ud}0 z7>b_xl8uvoZjf&6mSBz=#(4_{YXz{65FYrnjC@#AH8fKaZ-(?$MYs(!m0@@oEFOqq zQN^KbR!mF4?EdY5pqV}UtD?_LX#(JGa4|5DDbn@qc8QPkhwzM&NFK~h9h?zq%l1UG zkFehIkVQk1b5yW4ee4C8qkl;x*#;w0eIS*Wjru``*Yb? z;xqgG^4Bk7a93ka_AE@|;K7{^qG66kKSV#OYzgU%Vo4R|@Fn8*=h%r|kCszF8Lf29 zs#x;Vu3UVh(r|r4ybDzeV;V}B11yw4)xsa@!!r!nEySF}&^7r&L`u5Dtk02$gjsit zI4|`_`NEq+x_pqE*LuXUS9<)D2I8BLu2t*D_7JdbBf`Q30Dzt?OlTW7`{9Z{cn8oA7 zK>7hr$ezf12n?rp>a82=hASb=HMQ89fXS2X7Jqd*0Y+CiFVNx*;#N4A-XJ6gwO5fUMH z9ffG3)Trg1n)!to$&b9R7NU+^%CIg4V%Ch!kD8{A(8|RYc)o|z8yHvu5Vp6NAXO}HQjt94i7-b=ZA38zm36?p_ed#=wAr>vpX>0RTvlHl= z@%i4sVmV%Q$e#9jg`9&&p+||EGJge%6r2%noz(D)`5QKyh@W=wT{DS2s%E00MeexzGw?XLTL4MD=F?-oJZ@ zlN4zZFQQ#XkVV@tf)vbSyQLi#7hwFD4KYSY+*Lf~QbV4u=wge#RZDU92v7=Qs4EJ+ zWdl`UE>2M?A86$nh00znwOt@32{RaXcg$YC@_gYvX%DFXQKbF;*~lDE8D)0=VD2SD z8ui;E2S_lv?nRT40Y2OcwM4*(CT*#rpe;UUu8%N(}1@wj5dEk}#zVwTg4DTJVv za}E}9^Nx`Jv?Hg;zL#{262cacbmdg`Vk8nTJ}U`OfsgDN?8q{WS5KT{zp_RdprAwQ z?|qhWFjm9!kyb<*TK(?9d?&*P?3%DpI9i{M`b%w^-?|k!XmGbBVp)CATrcO<3Op%0 zZxHDplyEv*CV2R~J4H?~oMA-ssMl$Ov2+vwXF!<0y~rXSD37GVIVs-!_bkEZS`Lgi zO47(u0n&+opsxuzVm8+(9%c!88q2?LQf-1mELmBMS8)D7h+}$_q3mRCYjEz&eFsNz z)6>4EinzXiAAxv=94XC5i+3id%Omp87>1;;vFtWTfPgH+RP`W3$qJ(EoTDzBx?#zF!4l3M!orp;3<)NK?5&JxH14%NlZ=z!_oH{~q;UISmC! z8P9T`nT3W*I$lhp>0a*3_b*shj>03s6lq{3;o@R-{L7{?7t(-!Erpt!rT8p^gE^4` zol|tu&fK1e5&6mH`ryivnVR|gLuu%~0$)mfSop)R(-bnMYQ1G!h!c{VNMg7_Ycg7> z6pn-<#IBV3F*i_210qy<4b$i;(NNqlXbz%Wp_!0F? zqCvo%g)Xr$-(9vZ-EDt{}LEFTrS#Vki|pVOHejNk?BMGFLhFHnMIf4dAx)&Qcntu7u! zc56YqRqq)IB*6gDHbVnvnqm-~)?7|U)MI2bOe^mLH5T`Fz*D%B<;xF+?-(WgdZT?J z7_UfrQ@mKMH``?Lx-03CzrJ@=Bb^@85g(4RV=Zp$#}qgJRPALlVlhN~SMSZ;+zuNe zPNVF;R9 zBzVe2*I51BCCjf5Od2oV#?l1dn^TE0>?eyU@#+}W9Yf2)6#NW&b7k>ak6)$M+h_6s z0+4jHEzCr`>~Iix^YyC&q$<;y*3==BVQx`dflG7?NgOua3DFEZiwQJDy)08v7S|XK z;}1@_B-GkRliKWBrik1|Vz=U8LhrlAX&hhSpy-b^Pu(V2s^QOOkt6tKgV=l9K)&}h z3-t6*qQ9wVEQPDF%C!A5QrS^9x2!t*qTvtDD;d0i@iXp}?PM?-!l(&Xu(=G~a2JZh zGW74afNZecU$S0>&IcMeGNIdoxspH$qbZe`9%1El8(INvl6DiPy?Th1(&F~47e@si z5(y?C(FmFIR(j!5>6dzmWP_Y#FhG1p-Gi-m_*?8s$<@PG(Zik+JWZ${)RKx2inLuJ zQ3r|ui|)IN-EXs`Mgeg+BeWoSqF`}=G8bx(glrP2YxP7mDaQD#+#qp{mjF^JPgdA$ zmAj&0AvB z_QQT)JWb&N=iCKDhtJXvhvL<(b11%&^ew_>fZHa7plA`gbSVA3XAV`(r5k!0tZ5vZ%Bzoipj+2>)Dlh-RTE1hvrfMm=PmMRIMM!DzH%^XspzhvzoBM+gx8)Hw@Xx6%;?HD~qJ-J_HG7$%bU z{yDIUwcF#h#lxA#upQv`_wi7xyczjTfE1Bq(A2}hel`#r3X|T}%o!2^+C%e}4_{6-GxHuw_iEqe zrvmm4(^FkiD3e}&HbNR9)hHBHJ6_WioDTvO;Ot32@n%Qjg$->K7Nnv9eloK-=N+e)$@`S7k=`Z!2JV_kv z>BAM7Y&+1~;22*_o;)Bcusdm3<)?74xIfx)6tMuy+*eQp*hb1V{@fr#@Q)i_557#b zK+?AM)uK1)k_dwus(of8a6V6~%JOlMwvoi*{@Bi;O7S_Ekj;g~|2IvS!Q+L(;L1!n<9g>$Xn+iK}xoexv&}wTCmY{x%&u?r-hGbNLxPJV# zHnxg}LdDJzX%PO9Jivw=QEHYWFAva&xc-2o8L@v3IugKWY-%O9cyo)}LZ*egGQ3=n z$VHq+7Wzc?O_2b>kE$nRx}(PWc!*chyNcZAq_dLlHIa z4wmCvum~yLW{ekGrWGas;rpHL)eU1HAMw9Bh(fzg+tNsB4q{rfMR1;_S*$EI)sgAZ znB5=GS{4`tF~T5lV3@zD5%ekEm{ass&TjAyN)aTzgY8~WD-6NT#PdIn@w&OuHE&kZ zx0IX~QFYrP2uCfAs09l<UgV%e#a9^8Yr->xw;iEAiZG}?nuqRJZAJ4P+UDD<|7{*V)kl)&T>7ORb z7Q^BdwHC#t3(xxh2ye%I_w59Yi6#F<#!xkwjO#~%j#HVKbt|2lECi{;bQRNn>ar07lf-9OCeXtAr^aB+q*gQt*=yLq1YKXXFo#K z`*6hOb!lemMOobrpsQxwg?K<#W9BFxe9C;X;N(ilu5{n6`QgP)WRZ7}e`ndC?cNa> z>`Vz?Si$aHfIE>9eUHZT1so|1Od~iKgh27HJj?DwCz8LQ7d>lUn2$awkeo-81)~P? zlz1KcQ6Ae|2h;Ai12Q zy+D9qOe4lL`Gm|kYdA%_L{c#%c6E`X_fHfZxod?mB?p;82hE4z0$;1i=5amH<6S$& zO@|ma*kr_d_>+$BF)B_Zk*Wd{?2)0JUDv(ixg7=St^>uWFcX(o(l!d2Y;4q$R8I&Fl}Oio-_77J~(sYu2+#x*z$gkj6Z&9gj7Wi z!~nkKI@C+$ynpNW`n=;jt<+N4Zk0o?dQE!IKaQAc%tSPJhSA2`HEM(1hSduj<^w&X zqEe@+r5E@!S9GR|6^WYGQ2#hVLGi(4@4+CUfF*$OR6*(+d&y$5LYcMcob?{sgH`5HnNu*r6~Rf3S?8cH~bk**=4xn=R48kFVc zAyw(%7^dN@Qi#+8hCA4uNiC1yk{del71SMXzTctZp^CW)hzK*v&iGqLXT=q~N6D*_ zkH!~p4-I2;B3+LVw30=_CPjTBa~>6dWhixBezxqnRMM1K35H*ilJ*(#RSQZLxWln7 z;U+ZH{koyw*-Eh;tloC_p!E)cHK?_JJ(3;eE7)$CwWY5ulGId!D6%lQ5InM(XQS_51Enh0X=fZYmn=UCuq_tXWUkqN*5Au1Aw(obJf;U;w!@j`l>?;WVbK?5m_6 zZ01tMeGCLV8o70D3Jt>VbmTz0-ek;IDBL(Cf=D_t;|LGyRLZraC}7#7G|+CMf-53A zcC(?mCfJL2We_ZJ0cpybF?psaE*hAUfAnYQeiYHz80#Sp4uO2M>X4X@7ouWVF?XQ1 z5a`rI12S#^_7!p|-Isbg>9`8vP3MQ{h4`OBand<-5n7&(fw_>RZRg=jt#Yefm5<9_ zW8e}TE)SN$j89+(OLRe1uoiDRF`y)qsKi_MgLUW^O7hF)-iHLh5~;e-t+_ZyrkfUh)C#u8*bzNI~xh`g5qf|{wg*Px{9rBa_Q z+fYU+`|-Gg9^7UMk=Fn0s5!C zI0X(yYa{pMQX%z_!|@wS)CaTz;8Tb@M2X3NE9$>*=eCFv8Jl(B{JIbM?e%HLIp}_| z6aH?d@F*ic3jNHUCKOFU|JH9V?UvkSjFGGOPY4o0Ff53}=AYb;W}IXT{%V&z+xMN_ zc>2hd>IVzt)Hx=%yuMFM&wygEQXPp6`4ApjhVqQa&EwSbjlnMUOHp?7#t01!PX01c%ZDEwVW`tQ<)!|>r+v5#6; z*g!zpZSyrBXU!p(VqK=UjUH4j7{9pHy_hJOnGq5Cxy{+~>J8@{HB|Eq!P+}fb1SOz zY)*5Cw2cjB8=hP-AqK9mb+=qC6Ys%PgPmN`^EQwHrrqW0hPeL=*P!&_nh0}+*a&J; z8yaKkQPx2Jwk8{6(tnNa3Oo6B=ysxtE?*{a9Vy3Ot+8yNJ|ORmkeDuQRDw2RgM1>LKI zhxllvH;enM07G8#?2@V`nVAyT1A$xV_qQ{U`I>2?W(O?Sc<2vXl=S#0`@70oCWOE`9^Z?ph$d|j1Ee%S=^ z=qZ3CU8_kza>M1Jh2I9##CQ2ZFoO6Z_9pQx=nxhbZ&Uqy@Py^TG#Xc()-@3#BmwsS zILlqo^xi7|7PJ>t;EfL?$I}1dJ?#y`*a-O}<)o_7#wO{aBN2abgN(2Ez*8nNzjVE4 zCXWK*=>lVrek}$UHX#>KQ>CMIK^X&A(_<>4FP!sESj{OpJNwAD-3ykR!_!k1Ahs7cLtuZvHLIz*2xcKYllE5 z*?K1-teKSxpp9KjN!aL(&ZeQb@nNWioii?39KQrnrB}?;8ybYtYm#NF1}gs2+B3pn z|Ia(e=3WAmz5~X2Xsh5sR8vNpC9^6_Q$SF+QWN8IXfouYe{-o_}&P=V^O~S-#~P zNlZ$7gTsjq=`z5Lg*&9vtI#9`gr%dTmQyG_`3)V;a^VWmu3PQ-%9Hu&sH`8wj=hTC%T ze>3}_>V2U(loE^W*mSEGvbRcE2D*RI9>I!8C;l(!C zpUOnzP3i6<=1a^CO3kbFLzZi-ff(=M&xI!6tv{TJtjJyk8!-&lG6$zGHySGLPh3PONe`2`%_R#A1ys_m%VolX<;_d4{- z;NVfUZ(4Qs1RN2d(mF|((VJ#+_jsB)$M@^a{e3LscQ;_YO1|tR5)g(t(J5YdyZAKY{Re!W^16^q@oUvEY+QX{ zKTwEy$uAy-8mgJCV2%pl$P2fV`c~j);4{TDQ zuNVk9@n9Di4X=Ughi+nHm@vfUMi(!#ZeU*>zn-G@yeCiYW(u&#mO+gCvZ=^a*qb>r zAS`+D+zi}O|7@5k8%($y?o4?{drUU}M2)OnLPaHDGwX!aSFx%d%!c4cew#MWK3;!K zR4)U{Zv~Rg(D-_=JP$%P()oH$H2&Op{I;k(ml=EFWnlb|li|WO&$vqX@v!1pe>ya~ z)!wQC3Al5BMqWPrLgIg|~JC(^7XyVIH< z0a-$Mzb>-)4=gP)%8Cq=g0ZSS!#np~jTmAeBjSFx6uouanfP-=F7Y5ts~9v4xElP{ z8MaQvame*tp`uRgEY3hhE~|s~b4&@l{Pn1JAoJBgtZAjx4nd*Tu75}9=SU_ufddlu zLP~IU!aGu&bwhHs7#+it=iV?x|6AqmCd!k~5eNCo1J(DMO=IHKGS#7O^-^eIT-YA7 zdf^axz^K}&i|C5<7*v>vbboM^zrTgvt(B+wLBN6%?uV%(DZ2kqLREct8A%0jlG_zp zKcV93e-OwyG74UFH>GA5 zC9>?hw9Q^P3#ZpE3&k|rvNAR39m6jolYug-EYI(NBH81hO%;~}f}sbEBYHi&aee^D z%JX}xeFblg>IaOmn6aKUHO3rDq|~L z^C{R-V52~i5`ya3TVQ@I|3G?YoI%B%JJ4>G3x_`6XuV&Zh3^0=%aZ?qzQ7Q z(LL{t6YI#hA_2LuX-8FAZo<&t_3Evr$NZ%HbUuS)t%IIYlRtdHWsL!3a=jhYr}J$X z2bC($y&r^DSGgym?=!0g*%jtCYJSb`D4uDq900D(6Ezt%j|#eehm5!tiDRHX*+YxO5+2oBocY z3Ew%t=#heH?cP?2B8#3lc4um1GL;gokVYOiA^aL~*oR`ir_tbtHi&HLfY z`xvZB+4>$njBXJ~4-<(?+eW+Eh`j&q}f)DT}Yp+i6<~Y2rci zV0t_6_<}fwsI~s~z8zarrqdc+^I*Z)?piTk=%@wmECI*x;GaB$Nl44Pl402)>Z#?I zggdRIf`Y(nsrp!=VkP(uB9KF4CmoE*Eu$U6P;nN>@}*Ed&uzYa7R1<~dSVM-pCvgC zy^}?AXy}UtqqzFgk35xX=zSiq&4d~qvOm-zE}zJ&+blK(>Tkgm-d1M6?k3DcW+Hc0 zUsx$BP4n-5-4NZtWw(@d21=U)Nh5~TnF^569J09NVXNRUePF;Rzi-MSoxW8ML3>`W zr0SY_V%=mJnhV*#&p_&Ey2jx%S{0}~i7F|r#RFLo8TmYjD~WZxWF8#D+`}u(Sq!Su zFl5H4qeQ)M!|$^6U*dYOy^d;-PM#b;0WGOx(oid~DJZ4i=yPz@AUBcIo4}Sb0uTcp z_I}%pX{Q6Lyk04%*oob8E?-=Pnfh@B3E+|`TXc#fl)*prj#A=}ltHcnx9)1a2^!Dm zqNS;f8wCrDNAblo_%?g?$B-snhtU79=(r?+nc)vn4@QXv07=)~qwt zY*~LSe~~Z*-tk0LhS;QD{S-1DZGa$!M8)%)BAy8P*mrH)coa4fmb;BS4Dom7Wc{F-^Vi*LIR5ry2B%PICMi9R&^bDGmC)K)l@{*?2Utn+n z&8axGUhTCkLnjP<@+MV)jpfL!&}I(VD2D-u*a+qRgurQKZ>}5jBpDk@_!2_WiC~ae@B)oZPw!} z%fk!_1?HUotL-H&+eBTjbCPLLt>413T8jI_rGoa2=eml!>^ew)_jeG%B?|Vma%kIj zc~z@L)!0xbw)8A^Xw+hce_#FGE>s9}VD0(Iqgt9^uQa5rrDJA5=0A(zs9C!^hW->g z`bYtAh6E7i2#K}jMA~0Tj4J}WdLv44z63xpK3zZ^qTphbgozefriN^dpDZ4gNcq_w z=&Zxio6;X`6X^?){Er(kH~)3mrp|lF(`aV}Ndng#AU3b@oNh69Z?SP$d#7|_F0dlI z``E!n{`mC}$j)ko$FEcimLw8fS?}K&C_9D)nQ;ybAo73?>i!37Gyo64$aHOlSE6O* z=y1?kC8HA8(5ohBr@2al?pu>;gCgM?wd3SFG(q>)-=F{h3?pY2snf$SATdlMe?k|r zLXtcOfR=$~C@%UtSe>F($c5eTEU3;h=oWaQ;UAhaOqMNdpamm4g*dg;S#0|SjQ{`* zy#b$bX%L?P08ft{W>ZzsusdMEJ0H1XK=#|1`|89kZ*7aanJxcDtXy!08vsv4M~|vp&sPC;=S(t zGn!~GW=PW#>_oJ92)0!SqyNtXY0YkzdzlJe-hI}q%VXgFs>d2kjWeLDAHoA zp)^yIs349pw4=)7?cL#3Jkqo{A_gnMMZT9Unc*%{+Gqb?tC_No-)~BZFn;s(i;j?` zFPreFmX9XpXTYCOw5I<{hdN(>ive3ymDf&_HEyJN7d)JUQkqLRmE;IrDp_1O?xp&s zufVU0y%K#at43&&dp?l+>50-$0!j}0?^63Yc!UQ1-s<$ii*c_!=#n@_;V#(b=Nv>b z_eWRNfEzp1Gv$g->~5C`I=)QiwXwTxpG;+Gg*q)np)<~!yHzSUy(RKj8ZX*MVLQIf zuQcf4)Rn~Opz{7F2V^1}@xs4Href;@FYobBSi2no3PL(&m`yxC#ZkEWqbITC4B745 z@RlFG87bSIWoPruR#5S>0t~chqek?I-LeD_NR~k8v1w{_2<{LVm7LJdn!N@x zfs{vwcH@7$pq0uB?@s9r>)`A7-Cfk8LyzG=ank9QWwr9)S0k1zCJM#cZa$-is5mgxiPRCtquLp}wGpRzggYs(pN;@^4(G9&8@yjDp{E&J=``?~(PA z@rpJXafe)m{uZc-AaK+69SgiKEmJk$uYH0;G_p~!CMMX)hX4&-kA_n5HOk7LQms7t zk>K1-d>Jr*2a11_kh-d}UPj4oV|fm857d)vX!tnSYeXiI6Xas%Em1KZ^72quQ=FAH zL*I&~Y7J*$upKyMv@csXTr`BQ^m?eX1^rU;);AX90htWNzS3B-MsFXW=gV;|jsQaAiuca2)MeM)@kDc^d z!92;oi~}p$;4-z5A!7kmBwI9RDjy9?t2>`x{7X`{E0m=C=EcP$TClq5b2l@I0T%<5emo?;}-82JoaRy@R2z;MlpEPC|K zE}`-Y*Q==NXPNv_w&20@M|OSwZ26bs6#*_dDj!|I^h*vG_^Y&Vmfoas*i zNZ7mJ8CgX`Hd$!%51$ zbUbMIlmgbD4@yneW+x;?;1W0s4_5-}H&3%q3`H^6w!J1cf3}DgMODt!3`R`AKCXKd z7P>5)%$S<%RqPj9$L4HD*4O(JeOw#>?7O60Zs}+ zWnGJ1GC`Rxgno7guuQt|I+{}vA?sAXFSO%o>0RQ(6uJl^GciY2Vd2^bjDQaI|14!^ zfd6LdEwf;l;)sUk30S-*=rr#h@M3@0HP54aje=C@e4TxHyJ6CZSOq3*jH19wwY|US zDIt!;eblyK+37Qf7v%b!LaM2h@3Zo7yNurs&N#B^1o>I8QR@_qtE<%4LGVG+P1J zfHr5O%ieAt#OjO(8dY(_>ti)h(5{-*L#0M%0qMx@OnGnH~>ln*B zcMdj*0&3H!D;nF07U6FSGo^mvcQXZ#pemZH_edWA%`UIyE>Q+ zrkS4vW#jInqwK2kFAX5=rj6Gm&#EH*}hdy;{Y1CMgf%|kAAm&Rk*{=KgITsCwkZE!y6 zJl!ZdFMS3>%#_^zs{!M0g*#)x6DLT03lTY;H4pn1O#L)|{)cBs@sxTnxdSY*2)O#l zrVq2~U_MN-Xpenhp2^S+GvPWIB3=Cln>@0Zv(CX+(sxuuyikn+R&wfdH@gs?YB6dW z1yRWF9qiLe34dTX1adJ}7ci>C@o4XTb{1cYxT;V{n7YYebB1wPXDzo^Yav=&nesSoczUU&ui&_R-S?4N& zlADwO4Hq68jZ&w{;2t_2@2qfW*;r~>@cafCN#+7Rijs@t#E*75Bg<5Ir zjkqI^9WbR@UIU;KtqN-j&isN|#NS9EOb9;y*GA9q{UWj(DE5?4JS1gnC`L43yPn2_^JGCxWf;qvDPleRNG%J!^fxo2-+wTG zdWV6z?I+_|Y#S#Nh8ig+?07uesZz4WRqTnL;F%RwC}-X3H?~1Lvdv0vp=jC?xE$K# z20MUuuN-(}Cw8j}Jzo*3`xc_yGsx8CdBgY~M%bF!;WZ~Xw5I$+P(m1Jnc+%Sry(I_ zZi__P7f~*-cdM~n!plu5>mAMM%#5wupB!jw3RS!78Ez)GcsGwokzl`Z?*mTA@W2TA zAEpoH=IQ@*bh@^Ag<%sutPQZmMfZ%V&efa6;zifHhp}-84OJbO<%I)$Fv9X?`nqN_y5vtwv9nUhkgdr`c&ReMNdF z)dcu&;W&;<%P`0XxQ?>ifAD2-4V+aO&X*Bv?ILW$xn^O)&jVNZ-B{7;jB*;>Xx4{5 z{T7xU1s*G!lWa+e&#Lf%uv8C*xwvdXDl3U1QggVpD=KfG#^7Huy9{^13cf@4Clj`R z6yNJ$?TLIfvA1p8l`dJ8h<9QoXt@j7NvfFZ%pxH~h=e1`c(Jm~i*xNAsejD9KQN6c z8uT`2mhf1NFus~-3!#k_EU_uBVp{oN{p z^xDSdtWc{MP^}R07amRix>j4rN-uR$06skz6pYB?=($f)--2I3AsonyF% z)lJ$WQi_Kabizna0=htwjtUS9Ri6ucDgqY5>|ytS;Ix$Gsd@fxqJ_RZuSun}C}g!^ z4Z-Da&0#}-K*AxLtZM{%0>m8zu5Vlj1j%xU)O_|4hyhzI{!bLn=8B~pV(Ufi6d zJ{~veQ7hj*)zmk&dL3s}H5&qNoE&kd0WFsLE~L0q^JVkA>aT23HSFW67Ijr52DwZq&IrzUZG>%wQHOazYup;sx6eVY_Gf{Kx zi4K5~ivR+T(gn`_yPa*zuZj5rlDJ6B;;qUi zLM`S>a4KAQhPV=p@~H6tWQ-VaNMT!=hWEW2gHO_vWP4$6?lz6b&02D>15H3LvSzx% zSH**n;rU2ad`pq+W{XOB5EwZ8b0_hFb%ww8J7gJ-TAD)QS2Nb}J1L+?^iE=`RGEZ~ z^KB!XZg-re_66SKvOEK%3#983AAez`h%iM&p-FR58Z7?rpumjC924XL5$tV?@qw{z)DL}*#pvR%)-5vWk!9zl z|7_83XrYu%s|%}|LpjemVl*^El{{tkC)6>4qqF_+%}7vs(#Jeqdjp9qw2Alz(HZ9l z9{#HpZ4FS+879%|rIFa-4QjpU(zoRd!0i+^blueKe;h*WRR7+lV>#gV0^FA~Z4;d< zwtb!j$lK{ru1xIpmFGKFkg}e! zZ1hG;n?gi9Bb(@tMSoh?S0DfV&hp3x45Us&qID=uog#wRJe=C&)Jh#Vys%UP2w6*P z2g7j`TF!*_V&J8w1O^y;oA(9mj(}iY`lxqr&#(2~hw}oC-jIY2%OCJEF49 z43K)2mFv}5E4-_jdRE*V!ug6v3sX@Jr7{-!4U|E&j8z1V+&=Z^P*dzpmF20KiH1D* z>|-$z+=L*gV=CsmEx(s)aXOu|{_TBu(NycIW!vxpm?GkyNj|U>l%w60{89qLtlF3j zmRT$sA^X@*^W)+0N8lu#-VW1PoUF4n82Vt}gHQF*HopZa>8BXvQrkE}@rDCV&w(^I zPK_vD{s2Kgqt%27;`Y}UxU9b0R3Kl);QI{>Q;hboj|ZZJs|=G$jBRU$=?9}HP5oPA z4yNjIn&9(7X>t~dY|iclNp`@>!35b<<(DtOFV(_3+QY9P`tr%+9=-C0*X@J=F*3AP8A6Xj0Acm3T8 zv=pI1WIvK$32?2-%zmuBrt$mln}cj3&4Ue7x2=(ya7%R+W|EFCgy^GSoLQYKrw2M8 zvHM}yISO$lvT8(7{k=OS$RI&XRD44Y__fMkr`&h{C|PX2tfYVve6HCVm&(P=*B@lk zhPC+g4@a|kMnWR|t==(*bI$`LDx&N1AJbj;S+4Rl2hHVH1af}U} zj#RnkWsq0Wd(O#5$n1M8ZsY)lNU+F9>+B-0w?pD+Yur4(Cj|@1dybIM6cZ?dg@0df ztp*~2sy3S9?Ii5^Ek1wl7Ul)ye6;$W1A0CCAjs|t6o;smKT?D7$cY&*5#BMBGR3`6 zaI@GdMU`9HFe;nV24*-)Q}b{E>{fHEi`!p{;~AcCR*>bqa=k=ILg8HVLK8xbcOIKR zf?Fe%qtP3f6ut0ZmL11+AjiBh29o~k)kEq^PZ*%ZA}d=aQiNS~>!1{7d6PLo(;!9s zgKp~B?r^k3YHH{IRRHa&QC0WG&BDX*O7xA~?QBNi)MZkeEUae>0A%*=_OR8;vpIgB_lwLX?KkBP9x{@4To@rU6%b=NDgVgzgBb1RRF(k5g&>Vf zPNqs?m+4JNyOmB}YnMMz__C`nhiG?Mg|BTtC_E$im5usva~q2eQI+OF^l)5!id$S4 zH_-oYSnzJ?{NOjHei9-WGuIA^%$@G7hz}|+15kg+PB;o$Yv!AXg)5?v+&FzCgnqpPmeD_dNR>31zLaof1t;Vo;5QF~E7R-Fq=4q50j;21v!utZJ2ZTW$E>vB|=NPqca zN{jjO&fMSE2gLpDbLDsRd|flho9M)N`I>fa+qO0UqF8WW6rDLr>;j(eT-9E*o)+LH zA};@o7>|o@0A7Ple3QYJ9P4bukBPV6C$-skd`{sj{JO;gsj{CL7pi(4>zSGjIS_%#Eh~tKnR#;aQqs^|cRWmHohmmamMGWZTQHl?t0^ z6Zx|!Wv;IqjA4f$lb}sEG;sLShGqj=8}gcfFk}Y}9bcfE;r)Em`_UxJ`saPDn>T(I zumq}SdQ;ASf5OSkPrbsA(t7}>wFxHG!%#SKSlq;V4t31`#2kf*9d>r9qX5JgKQ+CF zjvu5uoKK94SwSmBkD302t}8VGHlSLjl0-VE zpp99Irock2OuBRi@G)|}l!DN}Ec~I+?%XH)j-4E3#$q7;(1r#jgj^>MsM{o5&MUke ziG}t`S87I@tyoA08w-9U5rNm1omSv?-BETmx=afU`e$yBGd7Ko?Sy^Pnq{_t8@Gr` z6T%>)qpxrP00RPY2zUh4TfJa(lkATFVEJ%~9Z3Rw@+t_(=0CxhynxzXAR-E-SMK3ph=Y_z__I6skuv)7dUhO zY|$~aRUw%P6na$d-kc5pbNlt<6J9L%RV}Xg<|eZXEsHJql~Mxr#7v1|am}09d$yG) zlNHxmPn=onSZb2wa%0_$RL3FGLQ#v@-RIi=#=i)F(rZ zSd0S=U5jjDJ>9t25@F{c3y;v|no=eL9;+X`%%f&%nqA!zYViuF00vT%981LA_f=#W z`VOSHu5|jJoS|gLY`+y;sh>$1eDH2ot|_dR!O7C4BReJqP!iVrNVIh%aon;o#Z$qH zm%FcQnQ$o6kIB=i@bB5P!ofl3+)W-g=fqz{bON*U6qUK^0_o+%aH61wsb7VvF@66@ zKR;5dD3e2QJw_3zSB{L|<8w#H4m^Y`#*V|(CF5@FaXdQaW#N{(l`cnfbI$$eu)iBl zP&jVk1dxf)2t!`J7LX6losP4q@We*ICY>ZG5fv+Rc8o9^b3}QNWqA6{?R(u2#foFS z8ZOp#`Ks@N6*<*Y0Cbx3@qesvnB71nV^uj%vPc<`?o1>D=JVrCb;buB`h6|ll9V{U zoBND=3aqU5uDcJ8*a!^SQK~EKeCQDRx8whTW&!%z<+pMxDXhE_QVynqd^+F8`Q8ZrniZZ;zGk@GCKv+0$|HVjGzS z&lP8?puuk|5L4)<4m$_hC;z0HdYe=t^Au{x&C)NF1 z?o%&z#_?d8lw2G>?C5V~U+#kt2V$s7Ogh+@14;aM(%i@`ak5kv#{Vi)P4K zkG559*$olXUZnp?IIcUYM4EDkBu*{#;jND8>}9cCNm)o4J->AS!o_$KDeh`5EFFen zGD+iX>*>k{o=8wcUl)2Rm7{DD%W$65TWSK=%?TR|IGNG{VW5sh0$#t zTRt*nqR%Q59Gi6>k9uU|K96%W#kH@)AXfGWS?{(~lRvY?O=p(OMlu2&F43A3<1mqZ zwVNsxpM%#15@+B1-QA2|jz^;?^EsD~zaA#L(U8R9=)R#sG?`7RP{{>=tiQ)99cw}I z!Ru9&9IO?JuLy%I>kjmAY`A=Es{Cd{L8q84D(cqT%~h%ygjfF-&0SK+I!xQhlZ$z%Rpv0a`J<%Dd5E3a+%yfB=+Fden#l?|)=I8%h8 zU*vEhkNj%(oTe5Xg1wC9kOoM&Q)pdX__vc|?^$}uC5jA-&r=r_7MvCkTJzJsC`GvP zf-J+tq+Y(uguV&*SL`yf``^X2M27-$Bo_vIuV3VNRODt$(Acri{Jb$mFT2(o#4fQv z*htcZh}g@E#k?$V!=vt6(PAt{EulQ^Pfy+nv2;{4|2;!Xqjg2)ou5w|>h)6;3?__q zZ_>F#4U2Z~BLnUE7|~Q+022%FQ)-+~l!)L4jV(`v*vL{zRL0WK7=Q9hZ%fu$1kSL4 zdaWVQvRboNjNRWzJ3exQj zLXDzYzGe7bA_+ut%oUu0%HB%TlfOs#@TeHG8*GnQP;A>Djhh{PJ}_u)%WZ2be=fph<8j&qJ;m}dU{@B zSuw8Jf7jHszV=!uvS)Y>SKgD@=Mgra+d;*fv~-VrT993HmCwUQafB@|+Vo;t9>|>? z>6P38*l0KT{sP71CxlcpGA@iFUS?|v^FUU)V_&#TdYs`Qv)my}?$YnK$_=kL9{8e0 zjJg|=8KNab@bxOXj^Ik4T2tFf3grnKqv*~@2J8`g!q|m z8dM$M5RhDcGT8d6MM&@bwMI^Erm?Uuod;2raPjUCkl>JlUZP5iJFV*mHg&Zv{uo3q znF*m0^hF^CuiI5Hsb{Z5QwYBL^Z>!<99bPreZ}dNAH-aL@ao*Qf#B!wletCO%HyPisM_3LI zlu<%5`qCEG&l+1D8VAk2VNzm9Ip%)&-V#NX&mStI=2E z`C1-@H;9iz^=P155sL&%hQM?|U&DbR10C#9VL=>~Tob#;1{$W>E>Q>l{iQ+R^pr9+ zhFa-lQPEgNEsJYqlT72G<({!+D0(Yh7-;?bWu&o*231*O;FP<)*brD7frx ziYrDP8+gLJU`I|&;3N=8VYEYomgY}zhCZ0*(PyTwv%)@Sl%>WmtN6sg%R!sF>n)Ay zqO=3+rc3(8LLbww>T)ztC-io74iBb)iGVMdGecr#7S+Gq5TsO#eUxhOB>O|(V&vD^ zRYgsQTs4&k?uB&8%+PZuFm_!U-k|)6V95@0;r>J5B@k6OOG%mUwmMRWA(e)Hgmw>mOabTzxxB3MS~MV|u=4+>!dhN_CJRh}%dtxF`Q-On zH>w-FG~BK_XueO-4nQUZ29OP(ZW}Xyc69iEo3k4WfzmcG9ZUCUysWeBoP>rRo3pc; zp(<=h{rzxo}dC|xEsC5Vi&4F7M>Sv2X42+t&5IfC+vE=Ir6Re^qLb>R-W%$i# zNk}j#FG;SU+k+z=66D->^5pcIG(3lrTFeMSWR2J{(R9XX3FZEVxEn&S}Wjls*=qZ8x6BD#NL5 zhoMxBCjaSEUZ^Bo0yG}gAFXrk3rUgYx9x4Om@*?g;`(0=N}tH}#VJ2)_ELD6<+GK! zz0GO<;#FY*T&vFDK^t)wu9qX0=))3Z>rG!xLb_*XMXpvF6&_D+uD7n8UP;Sfeo0>R zN4;SBx@SXP!vDN8?w9~SvOhJeo0A2QWrh&!4!Vlh8-6GFD~0lG+3BM%>(421uRz87 zaRa$D#k()(y;!W+g|ZWXmkYC@2JAX6KY(12o160kLD{z7Zz*fMY*Gv~aS1f{^v#`J z3@kD>8v0oM%;=|OCDoUHV2^=sk`^dFZhJsj`aCzUnIssmlH-O34gjlpz?E8HsRFL4 zVdvCL@?!C_oSMmC^C+-5bhyyge~uQ(!@f?vYLyMzYXocr+P{TU8M~Ohv|DkjU<0ig zphXp7KI;HF(ewxG%KEh24?M+25PFVb^MWxMBJflF0_~C4GRiPJf^>4fS zWRA5jw}B>Zt;K=TZ(Go(9Y-P0@FCzO!Lpz&1a9M$z1iC%^{mkus*eWbH!T`YpcMpQ zBsKbj4^>}>!uxS?hy^8qsG{J0c)kIlE0)tG?-~)Ew=@l#{JBvaodbp5+njf`2d2>T z>;tV!(~SX!RO(@2w{SU>Ee1OlZ(Da4pPu_78ar5pzVxiQ;&D^%99cAkt%WLy)6H|z zua$e0PnPGA;hwN07`7R=tPcwvXY>IY1SGT}9pqYyOwlxu^9V8RSnpz@;${$_<)e`7 zj~TmlZ{NZ1iq+?Qj#mG`)Ff0R1$8TbGWc#;P+6`17M7)|uN_p559F*U2?}X+MuF-~ zhC?FNB8UOPGyxfLtxcjBKx!U5$NqV6ll0-M5OkF0*8WtR}1{ zoX^bYreAV##lte&Lstv#pWrI7n4G3}_MT*dJt`h$gl2g0wk3E@u8VyMT-`p2$jvLk z(B(iZUchiU%DKaf%eL*gp3M_EK1KC1;?Kr~nJ99IS5~;mSeCL~u&kO7#3+$IS*F{x z$`yD{9HU2+ScP6R;eqsnOx!=$5QJ8PzycD%%_}mBEkTGSsst8|;Uk8Ji_&~DRPP-G z6qrt4<9NeW*@^lqI~`Mo|Kc86c9U4}HZ@++E{h$3GT&|~ETRPy1-DRF`Kl?pb};Ge zI*LDJ5%3c$McVt6-Z+LD7H2bOYIYFD?pX1#c|y0oE()EsXp$fN^!OZ>xV?*LZ)LN* zJO?xO0yxP3p;6TyOFwgg-vPDy?T2>|0#(_JAWVNcu4zMqA5$hj7z)e>A3X?cEe5NR z!?odxX;ZlRt!f;Oj$WdeO-Fb|2_fru5WuqkKw<486)Ug&aD@0!^c~P8j8F;;n4yH( z_XQ!gy7KpE-ip`#pPf2BS-y$QyHkmzeNL-GzFFO~Iqo1=d`!pP5@H@7Rz=AEa=5!4)VaBF%)nxZ?Cm&a!AFX)W{@pbZ&Rze*E+JDHOT-p1pN%m#Ta z{%=%mMHXyuH>Nzop^_Jy#IS^99V3zfSSJIf)97w@R-bS+@KYG za)039sL(5kj}bX#O|aIT*h&ksB|uZ6+0V~dkmq5K@1PiPpn0!B6@0gf$pp`JrS-eo zsQCqp#<_HXJIgv6Au{?v9@~RX34W=ZE5qA}6O=w_X!^~w2#E+yvDxG0Y@kQmbR=9J zPkE}bvym6wH+#9In?%prn`go}Y2tZSyVLj>Tp1VfHcv?JZpS?H{4!LN0p`fx44{%C zq4OS1G6!TqrynZ47muc~fC3n0vST1Mlu6iX6Dc5&mA__LlIfR3SDts(lnkdGmHxXL zGlTlyC_3TDN)qLk^Wgnv7E&YwhaGc^Ju@A6@X8y{|icb$_R{5nqY>dEW?08nLsWSfX>EX-@Os5 z1sp8-{Qu2fv$30P-=bW4h9Ck~=x>oy%UQS}QI2K`UL6B&cU}C->N;1DUWo%gf?9bH`HuVDIeALNgod(Oq}Dok zEXgXg?J3P!LSDDvrC?bm5TW%q&^bIshroiu!DAKBc%dRjt((mLxNo4R+2FuGluGwN zPs{KVXwHXL*;6P0%RjpHC@7&GpFIKbCPh}Udjr5%Bu*%kuEeEmXF5MY*skf&Ci;1b z4aEVwVm(xe|BljK3;5T&{gtp!+sElnvU1T2L>WX>mDfIpjw|Ff!y80}dCU}L6`aS_ zl1#MD6EHinyTwzVY35QwFs5{7-U`BQ#&kl3T$jn;lG0_`+4BaOh)ZEK$t3OBBj+mx zTF=eEBn-?g@+FVT9pYEjb++KS&mp7ND#z>VVTxxHL;+3XOX9TVH$DYg$eC!uLs{r6 zCm{tw!gRe4{_#A2-=_>9blx|CSM{JTQG(=u>{%@-*FybD>$s>0?ww%56>0S02YYdY z$GVIEX9&CA@?oRd=aq6odTY+_N?!#IuB~g>trTYW=j_M?gA7NE*YF=D|1@Dv%ymqF zNH(k`c=Mm#ztVKZ+-x3r2HwP7kPFn!1Vup6)SY*rIovhvWP(rJ&!BAd58`;loJ_h+ zO6@I+xU;~%74)~V`XsQL2INaHhf^S7xs@9k>!YELb*QaJg0WOvIF^KB2F?N(N7yf- zQOU}?TMme`O~$+<$bVZ?>teH)#UtK(E?40kkKRXl>COeWz#S6_Ya5XeQucjIR_1># z=THg17TgQLn8_Y3BxgIAkdn$=Bt~4^`p5zQuG_0746h@n$e{fI!2Dn-zAs(0ela##=o+Au5nGR;qt0QF42 zrEG~wEYmw&*2Sfta63G)NtA70C$QQUL(LI;A~Khv6#kAHV4m5KEq%(4bcsypvy*EudL z$DTE|wM02|Xzy}X_+r0n)5FA0DmSmJfTr2+o06&UWSOa-Qv(t#Yn$%dU?w3H` z6*f=+B03ksZx^^#tk@RBXaFZ%s+tf@v`cRM_(ttv`ex?uW-2I8Fe@lujM`z` zI|}0P6)7>fyn9peB(Tv&==vP>O8QvGl@8uTBb7|EpRo)Zo1iS;kdhX~a?nd$H3f<6RY(S6#TtK0Bm zG1kRqJ4vLZ2fFt*Gj^(JjK<;D>%d573G$I&@5Hyr<(cF2o`VU8_D~XTZV;V80<=Y` z`63buNZO@UW-4&!6@7npW3rCh=;@Iw0AZ6s&eGTrN+ozTy|jnZW{qkLfqAI18BFN6 zp`WuJQ)3PkoE1s4WIvSYt36r=XN7DtfNlM%3B~GT>>y~Dm5iHJnv#8;588xkJkg*U ztYq_7wWtTaGe-&Be356fzJa!TQ zHJyR=u}*97`nl9E@`#!??Z*UjE|eW_lFD&Ws|4BDXAcRzs+a6}*(TWmz{UiO0~2C3 zgvrJ(_A<7kYp;;e_smS$mg+@SC7bsCZJ`lFoQ9=>XS|R2vUWE@qD`Q9V#4R2YbZrV zJyT?~8gMd+bcjLxw=_4n?7vh$_O&(75W4YN7}v;i2so&@_H*_&Gq@VB}aQ zGl3~JM;3bN2lIrIYBpZ0SZ0j? z7&7TxO^il@^S{sSD53}{_+U9kLi4!vu7jQ9SQ_ORVvnY(LP?r$0tE00<`dr}++tb1 z6$xc~Q^)Je)YP;|Ddh4`wxs6MyGj3vuYKM?n~g<(W0pOHy-Yc~8cJ3!pG-tyg9`gV zPb>OvBaZ37mgPbG3Rrlfpb1q}+{z_}T17Eg0YJWmAgDHPCE4HPWS?Ou5`9cYgio<+ z<7t}y`A~e7RF=FRDhz$8==eA6?Y5|>yx+3|RZW*mPFh$RAwNo=6t_1iId4o;O9xzo z7q|Hj6u#X}d$y{M6GR3gAed7g?p?|QD&mRbuVQ5CdcFF;3;byP$ijiIXN#fSV7QEg z41IE+s72iZ>HLS!hYb9VyxXS9M?J$S=?7WypaXh>HuE!t5906?V7N2MY26ywP$;v4 zak>(Vs=2j0S=rBZ8V05PF$~G$^+;$b8=ykyeML@rxCfA+XZMW7Vj{Wn<%&0~6K+Jg zFDtu)-oarWMyzYe@Pz%y-Q7$aQvrN@y|WWHj!4hC!lySRSWpMZcp_W+i-dQz99kME zHbjO$`BzDK7p?gj+{}YPaFhoCb!^7}?94;l6JDO2=MMf?rwFI-+<~35>67(~b5iH% zDEJv_!Ok(G9CLKt1gPQm!BUbY_m^GWyM`{&Y(3(U*KHr<^B2iNl{VB%!|HXI-{grX zIu(CNX^rsWsQX;GHcEi*^2F)Ns=!u?lsv>7?ffg}aD!BOTR#UrsY%#7bcdnD!Z(wX z4mDXzM2?e>W0-H2a~Vx&bu(qXQj~(+(HpLJT;qy}j@#EzBx9@N4Rtkm$@qlJn@cFG z`hj-LQ&FS$lbyrexFROhD`Cd@{xaa7GtE(=9<}5wt&215Z4=IGr-Ik};7a(XyWKFC zF>>FqWPlBcqPU3loU8u-aNY>RJ{0nvG1(HHUe({!6X*z8anAT{bNI9*VxocDyD)l>v zzlBBI!iX|N(Eg5CxX`vEsvAs!;kx=)@7XHPXu#)h>rj|-1H5OiC|YViMz<_0SypY{ z6ky4;k{-5{R5Toe*W^u1|ICVga-7G+NHTlA(}W!Jy3+6etabN9ye6>kTG#cVFT5M? z!hW*??6ofGzV&K8D`Bxel9jrjiWPv(>FgF}kRmcu%v{vCJoLEp5X)A1Yni}S9o1At z??fvu3Gzak9V9Yc-#|P$ve~A|`0^esV<|6?y2TywwvXL`Ra>_?$H{##JE><|D=Esc z`N0scMNL+tK>ZYCF;=NQ}Gl<$iIIvHf$VgRdl3@e)wHXEaTaMuyk^+3T+n>#WSf{P}#T!1(9Vnn5 z3=i>XYMRhF32$T<`5fMJaKUD~$f!gULMb=uSBhTz9`5~WIun{_BjEq0l&7xocMDzyTLD#-gJz{dCIkSRU0`BL{jUI zy84E)Z;tOu+$m3BCl4JPws1*}yF?IXxT5qdT|>Wdcj+%_qy9)rrDBVhDb;?0dSS?c zgMUobK7w#A#BR-#HKW-;HEh;+&OgrNElHd^JERvK)JxB@M=R^Sec4y?&J zAr(!my~_5zkWi;Q)|c{N_N!ZI6v@UOP_8$Y6cddJ&;c#LjGR!3{Nmu%w-W zO-W!fu}M=3tUX=5O!Z=IEc~oI;!#Gq4n6?f0dO2QC2KW`dq(v^A`48Urn>AgKhaco zoTrC6n>J~${AZm_aB9$n3E0AJk=;tBTZ>I89zMSG@Y_2WDv>i2UrB6C36?qX=WiL} zQkXtx74KCxzWMl^+yzPqyg8GWV$`x>N0a0dn0qp-kv;sCdHE`_+vby}k8`Dz09Fv! zU<^ST51#k{C;jc5n=#9-Z$&YbS3<0n$DLGlMVAoaDM?6Z$AKP4|3vxx(0m{J=a8uA z$pv@r(LLd^_*6HbQX*xtKS&P1Z~j1!D5g%C>2aea#g*nQ{UCt)vt1fUI7IvNeG zI)Pq$A-3!3lkN3HNZ_2JMf3hM2yvErW7F#kz+40qb9u#eZ_NycMxFUl!b1Qmw=&h}g3(KpI*OOlb!in@M>mBx|UlEEh7B~ON; zGXJPs&5Y=Ui*$-y`E8-qHcB2gQ9f3hPkTW*MbeoutK@oLB>h1U(XcXAYgq5n8HK3| z?WHycct?mOHdCdNvk-)sqe1uM7m-kOut8YTp`}K=A^M9q|itd zm&al^Z62(;_{3I0gx2 zg!V+jXx3nhc$5G`A@S*_pdD;aiIY*7W_ ztea2By?8Up<(ODIVTa`5X3o6}%qmUT$|xen%R*TKZLk(JFMUND;*oxXV}+=lYaerqs<%YsF1~ zT8yr`OE)r0s@{W3zrf4lM&&Y%Re75Ag-(Aw*`sE=$Nx3zV-;f0-!xA_l|(`ypZ`Qa zc&&*cy$*X9by+$P4|Sure=qzx2IMx~77rn&;sj=55O^i@{?;G+OL*oW+F@ z=JSj!=$Ogu9?%ZNd2f)fM%`$xNHv9*21sx=fJ_#8TCSo>XT~VNEco`!9!ZXeiXW7N zlbKAbQl;0QgsQqJ5HBkYSgoGWod@=C6SPVI0`#(;da0h}7t6w`-rej1jHxf0Tf~mE z$fROsZT`g}%9jC$RmG|8eTYBazlK%E+fjeg9UCcUxiP*loqzxU2xS4EwP_Ha002*q z9IUhdCFHp;CgZvG0BQ&b)hYNV@5N`{ZEWJQtpR*w*I~X&0Ba}|s+%qs+#*N=VdG$E z5#{O@m-v7Hf;v1gKAk|9K?zz*JGtS?soF6mBu}H{iwH9Y&)wgvQg5?;qv_&82cILF z*8c*<9FEJ{_{A6OhsI*D8Q!F(8-ibKa*TS_(w>Gj7klot{_OJ&|0$ATxka=|mNm1B ze>5O~&u^eJkYESo74$ZzfNJTpLCAG9m=Y;Th&5(4P%jSe63WM3m*k%7ZWSJOvq8(y z+pymnnpu-~&LqSShGCnUIu$pyQdTDiO;Q2CQftLR*Q*2#bc=xYV|3I-nIc3v9nYD1no80JN8dgAq#ywVekkvW29ACEYqi!j#miroxIw;${|CH<%9+ z{?ptMh#PB~^RUtlWS&|SPjYnSB|jA6U!50J9;nK~tiH{rcL_(`uNF zRQ#qATAEsJ6Z++IFb~Ojnm7ik-K545EG>_zPCq(&YFGL_A^;qtDIORi>p8W&oh}N? zw14$LSlN7s4)vbE6os2tVY-MrgK6AB$#!I9QF0>Yo(JyTLW#VL`_78Wc_VDJc4#mD zHQYBZQR*t_T5GjO?VcHVnv;?l!Lp-*zqN)N`*Po~IlB-u^bg#yF0Tgu6g%V63O4t0;>5QAjyV_4B|k9%z~q0W6b)Ta^yellyL_9Z+%uHiqV9uqo$ zdkSrL=&Bq^OYB-hrup|dLh@lA`qM$6-LZY}qz}10*FC}P%|{y3tDZp;*||Xgy1TaY zbmM<*OxX*G$cRp?n|!SYFDnW?^E?N3^XxwGNod@c0fD@F_7AFo!y+fSqGZ+$_@`D_ zGdE2zo2$sbDbZPde4lnj8cSi++V{B$a^#jD`kJZ!tblAHHsW#wMZz1H?3N1RPfS>W z8AC;rG|hgO2Q!$+Obb2sz{o6{-PD(WNJ+%cDFOc~r&_WXr*tVlgbBdnBAQTrpID=uj zS2=YZ_<2y@XVpdc1h$Ak^hzlH$Pb!ed>#pQx5uWYqqIZ1pKeFb8tN+9c)x`=*r8ZK z+aujTl*|KRwPy7Rv;mpK&>f2R;86dV-S*3YDLPu!e)*(c3MytzkZK$v+YY@{9TV0G%5 z74m%NU@&1h^3?{brZ?gj>2Yw@^+m=J3X1J$$sxKCRG&q6D2a5OIY8r$ndl;l|PV?LJhHR#vQf`&`pvF0T9hBCSQdp1URhEeuB5 z_Xbb+Ojy&ZOXO<451#oH5V~8eOKR@o{g&=ItI@fQbv0jkjvT;?06beFoUjcKaBOduep1I+ z@RE(w&G3tbt*?OhY0d841rNU`&`VfV&DTF!oR^2cM#ezaqnsYrJa|R80+`1ei1B59 z92MwC?4?%auXLlsv(zepS1D^Ul(wm==bF!i9#g3W1&SR9arp*zqyp_2z29=}>ALa) zritliikfsFE#}~5{s}5`x?FNXnF`@@-A2AP_`%uJ-S3D8=lEN~aqV`Yqzm&H)G6)b zbF0#Tm?x2Mm#C`iM)cETGq+q;ihDCC_PbDarhQDLNJ-qc6j6SfBdyJBhGFE>Cyi3O%QR9K|F2~?5x?ByrAJFb-$;9uC*6Id7>_rWXRE-7o7 zIS?_3#--wfR!$7vqS_qDJhgLnIi>)(9P5+!BcnTR3HNFuyo1_Gu2DPdZG8mK3NUvR z4I!Nzd&ME+KX8}gjUy>3?hM*~xsw4nK3tQV#1D1U)D4Qfiit3{6WPdnEV$X)Qh@P` z%*c|7t>K+}N$013STpSNy8e*geapgS9kkh-|>A0t_iZ+J_i+#R}$LL`0BE_<%#*?u|FncQ4h4rB>mFS@h0>R=a6DTJxo|kRj+} zVSls$3%s{V5qw*@b@79#s)hOh?nv^y6eLbr0Hr+s0$bA6$%>V-e`k7`P0M~HrSHX6 zFQ|dg`-lD#A|)c)nU7qfdBr1gCPQNMcZ3biB;IkyQXp$j2P(E%6s9c$NsG+)fEoOn z`=CwVy@S8NXAqkXT^eYf9}5Y38?akm3}Bylj?hD*XzCA;4M&B@PKWw*w)aUxR=tnZ zS>Kl9vPW_X&mGW%O0%ZD>N8`31NbH5p6srW7cQRT%Gyn&!=sioVsc;({{XZK_=Cz| z-SE-1*l=)+>D1ynvJkbSiOZaDts7z&aFW1}9fIp{MuS_pl(5#+-z<$vU$G#%mka60 z^`pNQvBiB$AM9%5XNN(tb?p1OEDA-g+5A2w}4ytIW*V&30Rlh z%oy9a$d;I3pZ*4&w!=N)9~Rf2oKs200L%&Ozok9`aRgX+z9$7|dS7Gsd=-47x|p7L zp3zd6vPW>JSiVJdXwqeht{Vb4t%EK>|G9_Vs~NT{!_{K&3xIf`Zy1OoH*KJU)O4aR--LhP(b@;F#=DYS``zv2}8Z>^ARH2(@h>NSi7ij}>j8&BZew9C+lIr*y4=!CQ^?_?tW6Lcg-F5To=TBa$e8b>34)$ zgL_l0DztJMJe5;%-msZkunV-2yY6Th*}vxpQuQ#~p{bO^!+zpz&NnCTEgWx52QIR{ z4|Fn%jb>5MgrZm|0KWr^PfTaxFV`F|$!~3m9^(e|9>jh3#(l}z%jj?$WK0Je@p{76 z=m4H?ez2Vx8|$y2seHg8*tydD@^40EC@+OMmTE0pqZ`v_FSSog3BWs3#inAuuZ*aU2$nC-ggwz#Ox z`H*>e2{fHsQQ8*KrI}kUNI9(6)wb3TTHl&*hpaq#N2O)h$w~K2M~AAU-d$wD%U`-1io3IB_Z34gaGLjXYkmF zK+^Sgc+||g7L>v(_v5Rx`H9Pqz4S5F4*d8Ory~YB0hbcETQxo?6_2^9fp>b$LWC4NNP1-e#f zzzht=h9^$by&>e}nbg9>ah<;rxt?e3DiQ7)G{HHVl4d)crDH)*D>D)kh+3&gw-z5@dJ`Ru#_}Ellvb&iG3)?F z8MDUFPyHo7G#2{E643?$j20iRc1y`nw@g2;0n1TNHMt>gUrO?*4i1bZy~+?<3pV*& zdm_hAh76)0O8%(l*Jg@h#MPHVd!PM1cak7c_;)CBlyIs z!fdH%A950p0f07#axV350$~ydDLP$#jO(SgX%b`=s!L1@v))!)#Q*={+^hT*1o%}r zki@>~Y!5O_LK#3hL>E%M_-H4w@ptC0&Ow?=q~DrSMPb1Rqp>ryI*7Wy$as~;C|g2a z%`SuRxgclUx9J-1v05XkAo2$JA z`8)Y)v4(uZ9-e12?&zAjXd?@thoZvTo2k>xi0iM3pV+si&}H{9RQNh8#j9un3^l4+ zH)8OMmWbG})pC+M{qRwLXyl}JZ7SomXPmk(sn+AtY=U{B{}{Upt9SiQ7dpUWb5cb` zcsA7BsQ9L#-rdxFehBQY-Xtt6G%Qzl&+|MO5Lv zn{V3ziP2S5G$oP$V2@-uDR15Y_ec%l1ahKN?X+VC3HN#e!fAMQ)ti3jmk$9Y9T~Wa zu3rN0W#2&_-Cm(^0JO$=jhtK_uF`tbbs9?4O^8JP|C-LxpiaE5Q56cqF4eP{7>dPS z#!qAD3T<2a`!kFx1#vlUPR8425c}ZECXi?mADslg#pGx8meK@^dYWv7N=>fMVk%ofDe z+1i}Sc+)*xTwWLq;4%>Z#HaS|+@Ae3!$Xafd#zFm>&0#QH>hVE)_Ona|M_i1MoB%d zd=w6w*fuzwCrP?Sa|H(b!WMqn)K`24^Z)>m(jtHtl6cm}1T=^*{e=yD40%CKA4t_r zlM&Vd5DX64000-DL7Tia2ra2Hm;^Wf{;E{~01i(V?}%`UsXM3vETiLPpp$Pt*l)PL z-`X;ec(MD|l`Lk>URf&D(YD2KSMypkn+-?ADq3~*IX{csN>FrjTJg+R%^M+({8;*0 ztg;=`Oqyk`3Ool-fzwT$A2S)^w6C;pqnf5^ics{CSpd{QEqsK*97ASU`*86kFZ7~4 z)sc({#Z=Ya_5p&;R8F9)6ZT2x zZ1u%`hVVh^Z`P*o+7D?FzG$^J@{MF+7ri?8v|!N~J!4bSnmta?LZ{2%;?-L&$YVs+9EK@PwH=)A`V}IECGu4n+evthAlhxrq|bJ5 z8sr$5i+;k=ax)}E61@>redEFbC4@JAUg8bg&J^}<9Pa<)aQ@Ibwnhp~-IZE?`XIIj z<0r*hWT-otB!OJV16@|U;u{#s!ogtx07N<8Wg9KlL25O7@lr>!$b-AY#d&BO<&0Ej zf@+VesQbZM_ubmJfGWTHL{cf<+j+8a4`8<#K(4L?i^Y2(B#GRiLnfdoq>3quht5&# z&-wY6=dYWlhv7nHBg{>G&Y6SS{BSJhhni2m!{>BK>M)n&ckIqV>;COqw-9J!$nMN_;1NF_kIez6I##ZBpncmek= zz@=~=COB6%_hToNv;4_TY+}m$r0AE0qVzX6$dP#>hnw}3I8PuXx()$^mM^vj{x%{6 zv(3Pa|0z)9r*D2js&vPv=R2=Idu@J^YaBUz`C@&)WsF@Ayp(N#A4!u}*SrvHxJ<$O z$oUf{fCbai%^+xvY*d@04z5<8&)!Ac;mdenU>}pCA{wio7{>c$1skjTaBG9VtCos* zn6HV7sMXmm#uVB>k+CW(X!ulV+g|0XkH*N;Pzc*nV%i4Wf|UAZR6jHEWP!T72u7~I z1bKkPtxGj%$g$m6WG|0t%hCo%)azs649MF0c0|!}={9=oC`o?K*$;tV4c7{+`c!o| zFNi!DW8pG9N%K>}Y)}(e5+<|NFSo=b4ppBY{r@7n0JmuZD!;}csa3{+6b_tI9217` zkttyjtGh?%WEJ(ILqd?5Y1A>&BBn1C$%?)tD@^#wG^!kJl5(aCK#R9~`QhEb*LlGG zaPg5(tr1v3s>Uk@LqJZu;?y48+01~9p{psITZb?|R+$fYu=R&P?)vYa#(=MbJ{;=B zLzKD`gMa^f(hg19kO;S!G!2AlTF;&mD-C-j)$n|9b?RuGoyLc5xJ^m?i9JoGdYE@e z=6dd_;?blXYQO8Z=kZ^*dkza_e-JkzJ=hvC1LMGi8eW1YzwK&@iaXb?_KvZI(D|md z9Omcynd?c8>}S4YW~5BG-TnMN*uI@=1_7H)sh-ZXwTmquR=oF{07zB^GB`$(N|3>d z=xhl7@+ue*3dbd}Npj~thrsg}-7pS%FYdv+oe7M^@D7mYK8eokEK959QL+W0Iw6{` z=76-xT^8AXVy~DpZunEt>+$s->kHh0s$B<9mpL#vUoi{TuMDxvckKMN88EVw+2KXYSLNS$lwB5mL(K85#Vcb9?< z{x4V$+3?&?1_Uz#0m*!tQvjOSXD&dzO@PMLrT6Hfwfn&cT;u#+H@Foq+At`uZ z(j4fD50oP;z>Yl)77*H`I{=g;Gsr9YftAG?HmKKezG0W_zy!kxS$yFltt*V0kJeoQ zBV{7c79358>U%8?iea(`a${1Xg+*}WH8!b8%d!m$yj69^ zlk{}C^HaCUCpraF$EgjB-)##{6!iv_g-4`_1;4%ON1MLJ!!i@@S7i^IuEvhBVr|9+ zEAb@_p53yhwo*PUEC%{uhgM@YY7r%~d8ss>QL`&1WB2mpLo|zr_~|p)sAg!z&6WRghvUMLz!sYIb&yDSMW3-Qr-l%3P?{;CL6JM zjqkZLlUgjy_A0%(&EpHl;Q1OEGD2lKDusF)!&%0gbgQIfH;}R^$Rmik9cXwk^Gi+S z!OB3ke*7+kbKR3V;wTuN;}FHV;9#xjji4lEZ~s3&=k*E-eXSlwf&s%@`lg(eOtc|% zy&5}8_&J5*4e@ET;u|#d>t%tQm(@qn@HkDQpW-6@09f>VKru`(UJK3y57?vM5=bgD zTcp)(No}j9=w!8=$zY=yY3ny!u=qY@1p&ah0fph&{1+%iMAaBJ30ujYSV(JZD(-18 z4c{HpvFzLP|h+e%TsCV2Z`~=Y3kwc6}gX-MEP+F zjH6y}-F@a`kICjE;sb;s`f>1_(qt7GE0wC0*5rwBixKTGfenrt%v0e>!9kkcwl^L~WT4n8t zMW3*Wg@}1lN78(-SXO`qUIB3nXe~odjmnaAkSfY7dR$}mw0Tb6>%3WH{%zlf-RMx} zu^AKJ`xEce2j71$vOoU|vCcBOAckjqJjN9?l13nWZkZ4Y**~bcL*wYB|DG9NQ4bEhv-*r*PFw(+V1a0P+esfZ1qCziH0;$Id? zi6mlhHR=W3kC{VVDz(w2qliZq@)<)q! z`vHF8!w^!rhMo%867&lb&#Vv}P%UI>rn32SZkQjJvCdEoB&+iXM+ ze5CL}eU^5&&?j~wEfJz+*OpNJcO1{6{riIi--kkLJ+WQgp6Pd%aNT!_UTWmrwYr1OLTg*$U>FGoI zWK!(4>dTWuD_X1_NREZgY`;0?sPniT0K1<5XuVbvyX|}X1}X``1NxD||If|fSg7yE zyQ5lRwLRu7y!XG#p{3&fpcvYMB)|&U-KeqJ*-y2sE019G;B7h8G?K@3_F5a1`N8`> z(i=Z_3qysu2HXapDpY^P&)mae`{%B-;~t~qW?r=%)z8izKk2VN`-$FiONx){kK8e6 zNM7 zqjE!j=&3Kf8WKoG{VEvWJYrZ~HbEqD+alb7A@&H!&sI24I@9guxm||*INn!i2kP;# z^+4y-V-{GJTMt`3E~6u{WCm++$2+<%in63sg)ScL)CADo(Ik-J+|(>Gw6M( z?c*DYZ!Vt8krtV&z|n*2LBH0*mV0BtXNm8q8I_AjD4qkWs#p|PpO}>{Q_fqi4qU8p zpjk^KsHCS|w(V1VYm7L%^w2H}@)f*ZG8)+5YUCHMnm`l@X)6NZGf4(>?;o5G^nz+G zc_sC;Z1Duc^rDysyr=8c)8^#b=xxD^`vJS<0uDYV(yZ|9F zn()eDH1|b$*={Ql_>9FC+h?`nCL_XkaPgZ0cK zMOFQ4D+i@pgoiVw)ZqDOasT*DK?}T@vTjFmmy6>kBy=+CtHlR+}8Sq|8C%|6Kn`DE@%y6C}z~EQV1SMu}ato^L?7zB6&|3-=N? z=>7r_bRv_ga1nT88=Xb({FJ)UF}av%1|%=>{Puzpn;-IeOlbC99~-eCC z5Yhx{GTs?0D#U&x^LsCcYwTN$@LcxDs9Tb^GGOP330wquy~Plv0ooiBjiZDqiEx#z zY}`W&AJ+p{{tiF`{H^zp{;0Q|8;_t2IYu+<0{8bmfFPJApiR+D;To1%=&Y?ssdr$` zb^l7X8%xv89d9JiUjE+;&8nHB{99xvL7|prlbLRyG+=qmEf#Z2I)XQHksRlhiac>F z9M(hr6GHgErsRp@R^#%c&bKfhgAbZae*90%Lfs|?Ci9G9iksQbr`gqVdQqb4r|8{} z8L#J$8PzSIdF#)qX&5g3&$|bY{=iQASS`-VLLm^?qM6lZ$KCd<{!@_2oH>u|w69Vi zmbaz9DzLB9L$nVY$awFc9ZI%s#uVoMYFL+aV&Fz{CdNSbFnuDz+aNrxo_wiqH(8Op z69A5uS&@enT#$;(!VkYz>rkJqoAn2a%ULc37y6ObNYicdFfi%?&bJITUpzGnjy_!} zB`-(Dz0@+Z7Bg>AZBYX3w-|641qGln_hMjP^?*`K;$RTHPvUGuNM(|U&+-Vgk^k~~ zH@XMiVSZ;&BlPd9s+4RHZEGtNvF`)vq#t5Luq_#JRDo#rUdarBkl>(T4Ei_)wMzhF zK%Bo=Sb3LXs-Z>MnMr)V-Dv^79Y2nHbazq&CNSF8K&~IEI+M6Va8!%f@y-fpqfzsy z)n2n2LBZ5Jo>$s&vq`A`#-;Enu)s|9&$l zm3Wu&|L?FW7OGS!(G_IEz{1WkzH4mQBd@y;W*WADv2^eX88%*Pk2is{80rbWl2W8n zH}qv?jmaX(P6iiWZ{ONsmUC5UB9{~uqB+p}xu5(gFQw46B(KEE!Sqo|U&bP!--5En z=@?{ycMD4aRQJ{`?9~{r60K@u@h-sD>A_>Xe6z6dOwzC(ocUg|wv6{K>;<1pZ+ks0 z!q$z#uW=~S2`tC{XS&Zqvq_{AwYXI!-7&;||GwKD~yOz9KRblM=q;;BE#0 zn5GRc7LX3|1AD}}m%)~MvoH9dl!8o*&08jQmM_p;>O8jRb}$s$RJgu)T*$p3#@Jr^ zoP0Dha}w6qNGRWDHdo4A^_kU0P_8*D1>FkZ8_-B+7ICfNG(RRRy@k7!GNp0TRJ4Yb zn21}b9sYke`M!$SJ~!gSA80{?*AT}jTHsJgdtd+?x`SO4?4)jPz%#>A_C|1f^GkrX z`7Di5amI%fI@1Q}h!+tfd(Ixf$b;-{YxtfF@oxj_c6H6s+AG>Z319vrgHWNQO)%G4 z^QX`Cy2;ET&VsS2mNQ$&$rQ@Jwhc3zhu?VnI1kV86jl;T>g~w#Py(qPWtw(mJM~>v_Lk(bE1>EN zmpl@fclN|I`|OH7a(`&6B&L@JqIBkqaOBwMqOA7{y?LD!aW4$|Nr0l@Y_z$?+w7c3 zswOphL838kUdss<*K|+(arx?(y5dS-SnEJPZ0e~J*U{Q1=vd5|)^0mtp1WSMRtAhj zmIg}Zw2{Pj?0N{XtXWxMbOnwIqa^4H-N@ab1u;6lcFEHyi|q{i4xp+Lk&Ch8*k zb;79iB1>(8&g`c5Ok^ld0A|?~9i+SG3y=BhQa-io?2AP#cqTgg@ovB@3mQZxI*sw2 zWbBJs^5Os2_x%g6>x;;O)56FoGRRQbQW249Jn?|IfB*moWI>e-x;LOgz7yg zVNfR^i3MVti!-|1YOmPrn&%ir>Rtt^-$^>HFh<%K}0A^z-gUUj8&|2+6 zq^8i3VGgNimBmF}^ms(cq>9g2S%{Y8Yit#SrtR@c#`6%qgM@vtG>HXb;8*qUGSGx@9DAj!o9cl@&xo=$n{&Ud`R<} zG#ri~I71xGToFBc2nA%|yU9g)a}cP{*#;k81JRrxDq8>pA|WY6HLzk@U)E&gmd*g`!jRWCgKln|7IzGQ z1tx-YUT-oXw;|9@o(Ip0r2{k44y)^Q`2?eT?f%~gqPCeufX_JOVDTR+T(L{^n=KF= z=D+%2Hum$_C5Qc6Jd0nW;roiBiD@RBHYVyA{-Ua;w>dd!E*W7tXI6BCyKF$((tuG!DWlSJV3xWYZ*FN z?O$y;%<)U*Hb)Hc>pOEZ%$@eM{VdIGMrB8frG(w3fI@&Wia6Ik5=Cs36lc`k%T{P( z=4JI^xO3nI6(M@hl@%N)DY5S!=$S9P3Wd%ZF-}eqe?ILCQtkDe9e}i`Y(H#0>Fy~F zMDUjt_^2zcFSz&)fVYpsG|;1t6^dW3+@G(%T^baAX3 zZPMJ;0cJOa+Ln>mb@m<|xBOO*Z|6BX_lSSM@lXoI=Eug9a*GrL33iY8)Lg)FVtSBC zxa@@OZ>cW|Mfe)z2r>qLYNG^)CtJbz8bgt6h0=%GDfWc#$j19fjhD6)XAA=Wq>YfQ(A8rBig$AX98pl!U-SLq;t zGHSC{8WEwASPrQs!~fmIBR5P`b5%RA$PoQbslL{L)R(5xdpKOvqH4jJwgJkJOEW$) z+0hkQnj)8|MDqCA)Bo`3IjhdP9037k_W>gJRfi@ZAW$%F%5>CG(LpzZkAJ;iFD&CX z(U}z|V!Z1Qm{xH2HQ^X8dAp8+5aJ=7?O*G^a<_!jr~|6|0+0`v^{LUx{8g4p-)ZA^ zUt*K6QjP-+SFcUs0@~aitr_L@Ih?hn#t|(Gdl@+-R z4a6xdhTH5woErU|+t;^%Yr<_OnXy!8O9V3pmjg>-nAOSOl?sB+`Qi1u4Il9wrYq} zAM=vkw>puu;NCup_+%wRa)k}l^1HkGl@Tr4Y3l@wFhnr^tMtIRmZ~^Pl0#AK8{+FukiZRzDk6E1XzY&tqK=HQM{a)vJJ{vloV`e0xOyW*=x z2Sd`F3Q+Mj%LALz3}L~sP%v&fR3uIICVHP3g+SKwE3|G<>&Hy(e60c%wb{c1fKMZv zdNq&&(@+3$@4OfTG}9Vz_=!sTaBDeNsA<}4r;hSpx`jbk2~bw!DJLyilao5!iyv(x zvxrg(2><{GECHYSX%L?P08ft`v3|9Tmgm0oMp?-Fr_-)m>#z?7aCK(o&dyh6)xZ!; z^0nhXumQrFCDea608o*muqf+lfjHEj2@{2&06Svc!*bws3DzmLj&a}{w9wzg7O4{W zX$wtKk66(qJTQMbPuJ>+tSH2Hl)?_&;f$yAVvg?8(Ubun0X_yfp zkK?6D(ii&EagY1KfcM95{$8QWqNKksQUl>^X?{w%q#K~rKi;|#v%DF$e9Tfv-6&m; z++pXh51RaJYj40}b}4z6CMFteaht_Dr%)WS-M>he&-Y4*J(otbWKg$)-B45C6JN4z zX%?bO=T--=<8JSjIx`p=H=IBjQPtvztDk9`56g^(g%Y8spI>eM*ou!5?_VXyq-fFJ zIhwenaEe%otVwYz8qIu&5rX&CicX_7m;FJ^VH`5(9SSrUMoYO*BlUh*y|tnL6wO#D z_!=p1Mc@JSw_2`;)G8904#vwKgz#;+PO$p~yu(|+qY-(3MkLFXiLWTtH9HpUu!Ro& z<2r+pdjijpAYo@Df;*(`0DD#k^D)p2vj_8Z6%wN1Dy@I*oXMD4aQ z3%=;p_o^xLyFIPi+gBUgPi^?nS`9DVJ3gu1@rR! z(!(d#Ch!nAPZkH{QDWe!py1tYTupw+kjb9#*rq~f&;*$KBCJ^l7_LdPnQq9D=^^~% zlH_E;rfWgVV5UI`2X~&w!{xYo7z(fc*h-{RXC1dE$pIg=OT3`!AA9YszYYE$Q4dQA z+}eY<*NqZwTENUH0dFnNX|zkBO%(7&-xo|t*b_z=K=fultIFqxSIdYmx?P_Gmh-$4 zLHp&PY7F{(F~JRp!y%jWp)%o?j3sZBQ+xJQ(}CWwjrioOT_fV*P}lCefcE)vE@3?Y zL=~y$-9gC-1k6ml+J~(lgyl(X3i_0P9<#Ccmj32Jijvv)vH>{;VlM#cenavcM7 ziQ01Ew>qrn8(GDfH86W_M>-;|14?2sF}bmXUdPL6*Lf z6eV0wSm7uRP7>XfQ;{ zf3Xd3&q3Z{{yO=Avb7eZwd6a1{d;^C&ke&$sOlr!s3Sl+%{_bjZ+47R*h%<-L?SL*}i*}l9&`a-L$-#Tgp7(5EIY5KpG$0n_b8qf;b1YfHUf&)!9*4`Q!P*}PIetu}k z=}_^FegOyZ0)IO%K>`ce`?jNu#h1@;#E2%rh{cPlA`()q%ExT=OeUrQZZz_8@1P`J z7FfE_)3w@kmrR!%F6J7>L!J#p$&+bY7jMMsOo7CKt|D%=4XZl)Z0GrY#1rt z8Yz(iAupNBqd(dK#WN_jEgIsRxP_N2sgW{4?fMEuVqeIJl)!}Vb}z@OxO4eROk#(; zy%ocq{sgA?{inpkTqoU8q2!JM%L>4e{BlSO@E3cmtkc)L6!A(}y6_osfB<*E0p*jN zJjDx@$2<87&75>Vj%Am|$eBLpp%(8vVE_OJR{@{ z@Teja@^WG15eQ5M*`K2ck`$P11_ERV)d5b7fx5b~BoIVP{fNscVbmeb@IchrhDCyd<&C)U1QGyNylc00bqWCbCd(3tDbk+m6(N zD2&7Cdl)Uk!F!lzzN;UZk!B@$UykF|fts84PWC#nyRk5nZ|)>__3nk|i42-eW^ptI zqC`|40q|cdS2B#Uc2sC#@@NhO7CVw^d++AbFt+h>{C&LSEe>@Egrsz*0`Ra@=?Dep zz_Krjs^6V7gtB6Z<3;`OQp0)ZUEvIt%D6{e82+`L2m3+H6%b z%1?5^8a*^pF8`juzIR{0_FaWHz{){*K)D4FV7Ew;ik-J)l&x9j5 z#mA7rSdO{`nsbYqKgxfD@Pu9=mGFd)GRYuQ2|Q(Rwwpai{v)E>gG5bS1xnK2@F6?B z!l58U%=(_%Ki4Z5<$*BzpwY-3pko!x6q-LetZx@vT?bStK4JYX=F--6vA@Ba>t<6R z(Q}t4B_dLws)ZA&+dufUU&rKXKvOOHoLAKqgi$Q;nN$-Zs;11JeLld0bg4wdGy;n4 zXVR^8-EOyg8#2b@Kt`OU{0Am4@IHM9mN{6D1sJOm26CVG>bUNp3(oi=Afe5@uv$}2 z{Xc#;4Nf)!=BivW`w4);0*qEI7m|^e<2$>irJ)#B0>hM`fw5ffqw%F77)XrvPKF7u zaHUDXZI~>-%$Pq2{)AZB0Tu%JLoVb+QS|B@YjrlBPN&0ciOkZ8OUUb&9fP+&KrySI zTd%^-LZ=nt_gE&sE!96lHm)*%sW2!HV1yteE0XfSe*V4%gzKw_B~IDdB=w`&>3d07 zNiFDL{kh{_FKWd}OH^2XLkCYPxI*KR`ES}~v5Gsu-;K}m%CTD?QZ*v!Cw$%fp0*xi zOFPQ&j56G8?KO9DdJ`Y`h3KAnfrkJ zDeoE9nJRG^iibzs_Ix5EE(%}`;eQSHF&NPpyOaT0QQk7Ro9@N`4;bsZa|huv>`RBT z)%1f&53v>sYah_YC%L z*cM&I+7oX3d$o@TO>O$Nv4g^6a++k?BrO~R%AACS03t9nsHD9s7|zW+0nUPdh8vWs z_Thl|HW|DX5(Xi`l{9-Hfo|O8-6Srp^B{|uwbu(gj^Xk4ZB7Aol_BRt!Q=}EYr_T5 zu@K+TyfM*~b`j)kDj(@oSLZsSUpgOGrB^5myf&oeVm!U$(ki*xe3+DvvKCBG$FEs! z3|oPFbD?kgkDuVll*=+X!fzma0S8G5+o942#XK}C!Dti&WKpA(hPU?jZ^H+klE~`#IA- zbOpg+Ct!Vk>!pf8*iwErxx=Q3nS~t^1dUI1ZvtM$R%3~@KkGTAVnPqfwpXNl746h4@m`hjNLnv>I~y4;0ImRv1gzSly?lJbJ3 z`|J+HZBwPr_qZVxJY#A4zB9ZJ7)3v+Lw;3*Zz*+&Lv5|wys9Uy&E~Le{erpeN_lqO z`J>95z`a|0#Fg&A-xs=-Fb>iN+_pQxKsw_pAs3qG##M?8Z>DS6kS8!b`Q4n-_Qnpt z{_6IZTh}Qq!N3R9Qc-z7|9t_zQRzQf4A6W9Mz1&@k4#^3biEEF)zeh3+@^# zh*{O{M<&YNT?X|QWKBzbj+cfcQu$AFa;dlaM!EY(?>D5YW zjV-lr-~Bry1uiYHIsYoDX-DeX6L^$|^TSUy$#ppp{;H(KM&b9Tp(ks;ysNYWi@GGf80NGA$tQ$;4ym9P`Jjw^Qc*+- z+uBP>1vhchpUMhQP`2NB(|vgPgXZczaq_H-(K@Ixu?Qp1!wWT&)U8G{fS1T35C0Ge zyXGoK5z32b$>oVCdf0HhfOB%yrEaGE;iL;DCDI2%oh5OWSl!?EV{`rlxz8D~T4V{}EN1$#vVjpis=`#-dcE^Qp>ID8xT+x3g7ymPmeW347_q@s2{k z^@JB!kT>^WQ?CS$amsU_S(7=0wT;E{Rf4yL04Sp-$xQ5tS+p@Hs;W@dm_dPY$pQmy z1z_Pxv7NqWgkz2K(6$gW-9xQ(peKEZS~oMQr9dc)YXzKH35oXkVfgEne_m=W!T~Sj z&e{Z-3jqbUCN}d7&D=r`{J-(`sCOnFOFA-+-7EGLq%ZtwBzy@zfL^sKE!VE`1?Q%z zDDdjsGlC$eB>%}}33;hqaG1WZ1OL9KK}K>{t1sQswPCOVM2lV*a<7OAHX3sttHH^{ zN4`x)qc$wvB3CBsAEFWAm*#yCDR6c$Ivg_d;=6y1GTe z(1aahUON6VJKF$Im2uJO0r*9K#NRyeAUE&JgX*otDBPXC!Q%$wK_<=mxm~8xMr6!l zbq3h(bBi!9$t~F5a5JTGigtr2(d0J7FjhTxZ_8g+CA zha$>PR=8Z|T^PbL2+B&V((|3>2;eSR1C|dOqh!U#AI+|6>VnM+kb8B z7>qqd#==v=(?+&`tJhga=_6cYYh}s9w@)MndkTiBs~8!_)yX{lcX<}IZtn#)+-SU# zI8}sN?huYvSri>%4^O;bRQEZ&bUT+6Ne}^;xcXSvJ&U$5+)COgx6a22Pt0ZC6A90n zn+ zOkll&MC2vsfA`O+`}ypA5S$gB$vj{b8RAb*wz$@^=jf-i5Keo^1GI2t2;v^E^pD2g zN|WL`*UWmQ{Ul*@u01-p#j!Q$VzJC%%j?H;ABS7;$?1)4hE4P0_IytE=(Q6yt{WDy z*N`vi;f>|7<`!w_wK1&bXA?(wCjOF0V^Pq;w}ia$k1=Orl&44>m>i64mjM}KDI4Hz z<5``EQfIULfi^(3ob}xWsnfJrQ7tNU>7SKt=LImhcBLc2DTn_qR80@E%EO*&-S(_5 zMyqP3IfscJ>0b+IGNH#CWyRc^gS@aRQRfl!(X^H=q66?E;#E^o3fc61lrfDAgR~x( z_J3pHpF^25pWCH_oTnztZ2>tQ2cu+A!b~^vSY^Z!{CGl00m~tmXOernjvnnOYN8 zL^axNQ`v|bMOak3_SSPu{eNTtq=2%(E2^RPmb(@^Wz&rHGp0J?$C_6** z!e>)L6HwhAjU1d^*yn2XKu4-YA7_PfKBhQ(s<%6M0g6zp6hLD>#->@$ z$st1H+FsLX@BgqfVhFxa!d4m2#?}s$`cwtL#jo4y6UK4M;kOr8Zfn$`McNd;;zhGk zwCxoGgO2eRB@j~jh#d`Y&@dE`+XEPz7FeTB5X)pjh zm`j$OhE?U{OHq90wiDJX#SCqScL=GFp^7jVuxRcvRHoByy#wyDg6Bj}0t5KokyJbJ zU-v8+g<0^H9&|ni3&o9R%)|#QvLiH6YkiQ3FQd6j$IG$wGU_?^(lyRNW#&xRVv>Z7 zQsmZS8!U_eT)H}+MSk(N(q)^mYuZAG-7seIQ3-b7oCz|6NmENSYrKv++cUt>miO4; z##vzmY3u$%KBI4ya6o7jUN5%$sZ9$6ZHT}2v0>+2WAKl;*9d)-FHUIHm1~ltBP^tT z#D|)X-@TZdV3^L!cd&2(T3n5?gzxjQ(!A%!F2E-NX%i2mjs83HI(phP;YV{0;qvPjrJHO@&so6qH9zt%8c)a&Rm;7cU@XW_ z;DaP?|B!})b^7w$0Ze9p@rHc(BuV6^lEl4^`;oEDPYwUd*;reuLw~arpf#W+RQWyK zK=&)IPvromcNQzgj;TmDv0O+ll1;fq zP9V{H!qX>jd%w>kjdCw93ZVb!O%-MNaAsPJ1|BiqHEAo1aMX?1HNv%41Lz%7>`khpz*;FcBM8NN$r|>bG zbI`^p?p6}`oI&Bu+KkZOsC9*!CnUli(eY?A6n@d}Bn%7hu|DVr^cl>%5zy-MwNKu0 zem!;y5W|KdARyc03aW}eKakz0@glfS>6}jzFIc*w3$ET8fnJyCAVqvlieJVB?;r>7 zj7PdONfT!RF-rqWJsK&Lu@5GrMM=0`Gt2w?(W=*+qC_;YyLh|tTBN{eIen}Yc2(yO zhl;7BTzmC4s@bLi@u#Do3t)3Dl|#WZJ%?<={i%@pC7wkXsmv?4CAlPbjQpr(m7tHgJIIP+?d_W^8HDD5ese z2_9_~0D+8k(+C6B4d(B@R^k0IY#`v_G}U(+1gRKq6nDtj_{{Di&l3yL(66`??>_RP zhrf?A83-pigAu7SQn>!4Q2)kd@=39evLI$NvModlXpt34=3SPQ6;h9-=G@bF&r~En z!DW1-lV;?waaup!6`6f^%F!h3TaBu5nH(|_>64CK*GY8?&vsKS1JZ(YaR-vgZN?jV zRf2~M);3R&BuQPjVQ)(hhVoxGXZX<=IjbAhqsC#Ik6>Os4ol=9FZv+?VC>WfyO@ap zx3>OFrmuMK3r8{*|T?D>4GErxF7)O)(mi8$DQ+ zhoG11n3oNd{)krH;>H3yx0=sF?y#<>ZKLr5WLbm-Vyzc!^P^bl9J<4GX!la-Rj|f4 z1E=N2_A#j)J8_QD6&$QrQw)8&tVGfqMiPeP+N2_-YEs0$?%SMDMILKn+bV4BF#Q)e zH99rqZ~86>*y_S1+MY#l_PFjhbdO9x zQ~F8)m^!-*ls_mP8SSXB={=eZfxkK(;bb@zBA$&PN7)NBX`q*Vp^CWCIzEc`N^FS<>kL{~(6~r)MOYL2?Ujg#{A8nCX#>z?zSfGR*Vd<{ zLg7aulLUX7|F=l({np5v`=kPJbje9(?dfBI%XIjT<=i!s8MKi{*c6<6$KV>85*MqhcPDcisxMhS&h%Nc zN$V5vu|Kae{&VgzZB_xS4eNGEd#5He+;;Zju$I>hiCid`CYf`u*R#taCH=By3M4vy zE8{zQGU6{19?W~Lg_c`4Bc4yg-dZA|T7T6PP6i}IdpWs`e~-G4-z@T8bovAPAT{Za3^)QG!cg7@`Qbe1t#XU*q*Z=DQECo z7$5U{>+0@r>A}p7h_ws%#3JJ5C&(c)o!0r*EDeo8{q z)jHOZk0brcgx=7%5QKEU8(TNY#`V%$h&QSTs#n?-xQN9@rVq%a)|YGp$ChGO`j$1R zwoJ{Y%dpvoErc`(eN_Rx#fe1? zZ{Sb8z$b#dTIvso%yzz*vd1%dZo?Vlu*7z4RZL=mCkVG9 z$RA_-SJuw%+hU59a(nuKiR#F!&M!2CKb=hSv8UosdibeNL+H73E zh8DqD2>$GSXlthFgn}o&z`Z5q0ks!yE_1qet(JGWceC^W!sqx{Rk_#oL85AhLNFa_ zc!pq*{)#UNz@=aGDn9>(?y9^v64$UF=U`U=jP{*`fXdvyuK?P}bWic5tIXl$@y{D~ zc{M!tGG4D4#NUi8S{i@3I*rV;9Z$-n6Pv?F{!E$!myx?1pcShSN@ICiBLREuLMm?$ z2Kj3CjsSCZF{dFqH@%}<`YvH(U*w(Nm!^d6Q)qj3^0Q5Hzv#~8@UAWPv)kR-t(fK` zZRBjz(q&+M$Vv&4f{!1VeHW65;s!<$x_yHv^AnR7r5#0Q zvmT!V7B=a5FcDX=&^$mpce@Bn561v=$LLQjYZM8+;>`$~o6lTqvBW;$Nr~E&#%?wq znpL=)t#gfoQmjPMT}mTe`f!wAVz(6L70FN3ibF0#bEJ;$3sbVLXN0_%%0nDXz29z@ zOMQWAl?MUuz4xJsGGB4)SzHEq9&|d&7}z~}bZqv+bX%8qKKMK<*1$HW}&@5g0rd73q;Dmk^OwxQV&^s#zr z+}_7BISjteJ4b5&(c5`MkfO(|v+>G3lH>(Bl?dzpRst+i@R^(^W+tHvd-7$D3ixgN zMWEJhc6-EagM3XzRBVVDLY$(c+zQd@vB0q*?LCc3*c_tA8xp6}fEAwIiN6$b?47mH z6{+LYxDSmLI!wJ}bLYvpefTCK8Q@-4Mw3$K)vDxAvDa+lk%NWB#J2a^`i1cG>UkVY zIKuZgJj2XPw47y*5yf%?Hg2DJv;{t4)Rm7!JQUiY(QY>cf@!M%wLY;|K6FDwexLNc zjlzC;WVzf@gY>(<#aje!^0VaX*1CZ#HKd51qejb1aE*c`&&HoHh_u!7nI__F3^D*d9Q%lV~)Ca#Jb=R?bQ7-;RBS_c3xA z67z!^#Z5Tk1oOe+FmWu5miC(7N3h4;P9%J^5q9x#A;)_p1+J@}%njsj!+mY_GAaL9 zoZXTYG~QIsL)d{xm@JyjC}dp-!?+7(6kQchq`$NPV^DsT3@`v z-|Frbn5IDFjhV(({ z`iqmFoPPO@?ZR2^CeF|QiNs@0j5{i#0G5SuqSlt9gaUMk#(UlM!mZ&Hq`qenB4S%& zgJ)=pR2EP$`(0=1C8_QuAY9XBH)&@=%}wl-td`JAf!usmxt~Zs#wnL{4{G`6ys!WBWeuNIl0Peo#Hy-1x{PWU*h-u8W9~kW8u)ebSBg-S zrKM+Cm|ZngJZ{ch-|KHU=0sIbS%LxM|JbZ{Zu;Qj-JJ0Yqg~J(2FP3T5Z}Kz_o@3ikqQl)*v&i7-%Eo?Al)y~RB#y|i@1x$MZV4G+6yf?!c^u0+$9@ik-6 zmCG9!C6J_J1lHGHSXUIoMNCW9%S3B(zi*%oBgPJ$a6;VI-?v}}lvfJN&$Dp>KF-}p!_qOUUYSc^|bePbMnu!`%{Pz$a!eWCuhq!62 z;|ltkbNXXI@oie9wTj3m9azNIJpYM8^lcdJxiHdJ=h zsyXA&2Y(uO0l}W868eO!FIkOo;MKG!<5TZei1(|0KnEtXIORWf`Hoo@CK@7I+-SFs z!;E$j_T*tlk<4zcAOvRjK78UXJ3CcUV^*Z}{qzs}zzWoPlvlBdv2?%*Y@w^V)|!O6 z9)Hm{3KHMHa+*8UhWi{U0MW5+r%f~jDqihLmwf)IJRMz!l*zzgp}XUCW41;JsnkdP zqPz9^X{EfycZkE7mDbd0b2E;s{<(?#jGBE6*t}~H<+wEOhtCz_Pk&`v3WnL5G4njd z#|=r7mqbDM8^S;+ z@!*u0d4j(poXDIQJ1|j>Wk?a~_Csw|LhBk> zO`}(WG4$$C#lzOiJj6cO4{ZwD0Pl*~1IH~a@-I5#49C}-)@c>m{_gojmL8ZH0~g0S z)~>Y3gmMofC3WTXVrX=RII!J|l7=6v-<%_caD1nW#HhXIUBZ#}LH1L2c&b(PCtqE@ z%}sIU0f(}9{f0LIMck&*9tPLRK||z9MeP#EA6i^gjxKWJ%$|NR2UMxWU?3GH7N)2z z2Haar&QZ&LiEqgpnD_iFvNMjoJ0+KuJecQUB4wqlFF1>Tl4Mws`!Z3l5bt`TikMm< z|Lf=Ccp~sc_ePfasG`zh8y|kypBs z9b_<1M-EI&tZVfP9wcC6Clj6HO?L+k?YNs7${0)O+)qE7jxXvGNB)3Gq0uo*%dbIn zg1rYQ_S*-Od@D>018CR51S_0*!Ze>};Ir`b5|pV(ZfrlY2MdpRJlD5!2vsLGi3@R* z#7`IfA5!+H=~f5b@rvL7JBMMK^}QZhddF7(Fo$^K7crb^Iz_4fl2mOhRwWvY?yyEJ zg1czO3Kcq!4K2tbu?+&e}V4-s4Hn$<_v2Vd?YsYz^ zfiOfd{p()@r&34k>*cAPFC~grDO8#}>TShwxBhB+a=dXWIivGmT^BdvUlpqJr0fVz z4XFKBb;+4~Bd=Ak0U|;uavcY2n`U4Iv3{(#3g(f->h-5TUmGFcGwB3;2R?{TbE1*= z865)gxOP-B*mr$V@YsD9DBLA~{lwN7(U?_sS9eCz0y@_VT#XD&-!=hrY0qF|k#*K~ z=}Q{mS-MAYQ~Py^EOh>YiR8E+X6B|+weS%6r95}9nhqw{I+(uyd+wqH#2#8bmj$EM zEk1mYm0rMkop;#$(!q!G&{yiCN3LHUUAL>~9On@;g&TEg>1-e`(I&v-x`=f9%Sstr zi3dNia*GL7u&4FC3srLwz6X#ZFDmzi%!)}~N5D(gY2Tlv12%bDgD0Ix{>=PC0WIA~ zi}@(ipkyt!=ME6^t%Ll}qI5Zb^vT>&tdJiusutr@g2}->J4@ZNiR#n2NC5h#WCBb* zYMgvnshoVlT$o7d|FC@Cdhuozjqm20BB{wJGD#Jae;ghD6@$*4Nd?8dUeKmJWcsR* zvUFoMF-6vnLA{kM1J z00U(WXRa-Nf=X9~3uXr%EQ6^&?cgD0Xi*Cs0?Vv=vXYM6B$jUBVEi;P27Y62b%XyE zMF>C0mco*$Ry#Vhr?PC}8cGDG&ett%>@ZTlC=|6DPHfT4=<1QP+xZJ_Tjx z2Ugs$36zVs@NUCxkoALoJWX{LD1fTQ=>wrNZtY@0%c}HwC3&+e4Y`w!U=B{c*nM+bG(|6ANZ` z=J2h*oBpDaK=utuQ;$11HRjSw`0n~T`CJ_8;uWB9m=eZcB@m~UmR@hu)7Z&_)AV!z5*5L-4X}?i1gY% zQ;*CWqm3hsjVOSrN54ScxNPbhy!ID=oCXVRZdUp*#rVz&&9z27pduh9Y4$sG%UMl| z81k84g)4odiDuo;CIIi4tK}fghs^(*Mq+*x)g@ko0*U|b!(Co$6#4Z-xAU}*o@4A6 z-t(~|#*qK`(+saTZ9c-+Cj?q}n8!DEe{30(h^p)Q4OYBXhj2wJrZt1#0;9d(@C;}t zw7Z{}ze%xFpS?38fl1a)i{?hN8?w3|y{QfA(J(6!U$UVk5*qvbCJD})+sO2X|0OeT zYdO&2t1Xk()+RHDC6*RS^#hcKU_yA{@kxf*%p%1vQF~Aq>*lR$T7LGlNB+r z6$cp|*9-NrRiBwXWbVL5d`Ml{9b&b)D4NvM!;eYbYm=HKylO8uy1ysO@$jo1?d~~I zACePZJ>YC02&e3SPX~x%JfT@UXcg#08*{UGE(zzS`O@zQw<3Sd^HUIyQOnNy17<)( z&y5L`5CAb~rbHio!`iColV0_Du!d_qa4BpRkD2*Fmw*SVF*+dE`->o3c{qQ!Y1^#L znP4ctaIDT!e_Ld7Y|!^u&OoC(4)5PRv%U+@*4YJe^B@U!f5USs z%)2N|@e^J!UoQ-+RB2!BzhIEx`;h&=TIN6u178CI^TH&`fH%$K35ciwNRa337Jg2l zdcBETtZ$(WM7Z9D1bgWs`GA9zEU`%JGeubc-J?C4XaQ!IrE4{fWsmDkPo)b9R}E-& zb3G@INmgYa_1wH-<5N>MgueMmSGHuTIb>LLiS#5&TsM1d#=E2q+A*_UD6z^nb<oE@#%zKq7N`L_TUa6U?d=5gGeH5)-Ty)dSnu@7bCW_FZHz z)8$L4zk)|XG@U8MwuduYYPz_ z2?q_LvHOeB^h&d;8n#*i!M?ZRd7}N(Iw5yqkI@Waj9oR}aA6Om4lxIL7V2aN+loik zpWS57yY5&>__B@ zZxf_zCV5@5ez|D&BYX2=ZhPulGq%jyNm{nUO*Q_S8_`7nnX#uZDkP7TicDK-Fu1N zs|GcUu{uUToW|t2>&F?sj{UrW+luSxO1FtU)NI8zim{-i>KOY!!@;d>4sJsv1(1`h z`1qSr;fWN~T&BHxsK|SGc&!8RuEvsZr<70**UcYskOn<7hTEOc>nlY>{h1n8L;g_FU?$p-xSd&{v%uSxcKWS&*mjLUnF9Tr>NoKa?l&l=!HXQGYBXjDGlS?FX%d zxr85Q;?=%JAq0KX25!)qz;&b4TRyNnsDZC7q0VBy86S_YS&-mRURKJS2;S?A1FNkr z{uJWig|b$UurpIL9zG+Q0D_oI>Xyx`=3_ku&|yj&GGeA>xjWaelpO0&r;Bw*~3AihLo9 zl1d57`tl%8YY2ayh5lr)?pQX%&Gt#xL^usFoST=e#Y(>4JbT^VNDyzo6E|K>>zo36 z7dKwqg31ldU#_2_Je;a#5*lq6NV*EKN0=cRomDHA;&HTwqicgZZiOmas8J2zm6Y{4 zR4y!k`+mSURt0U(*ptqfA?6n%hidM=PQ{ld%t!NCdLOCyX%eO zUQsF&BpF!5&zsR>!f5*z%N{@?#h|VqyCxO{WV}=#dGL&`@d!uV*ay4S-o%n*2Na}A zVpB+jK4KD+f-O}8?2F>jgS)S4dFMVDIpNh;wSGq1Tt#g~+0TAg8hmjbN?!pH%Qu)Q zRU$(;=oO%$1EB%idXd(x^61zDP{wJ%(RVMXI&KHnj)`8XZ<@vC$b3EjoAHHxcOc|$ z|Ci3Tt#aSUTy%w~R9EDkwOJN~CGvg_-HXk^voFT@)F0j==*(1cBU&^M`Y(Xe`mRZb z7+T1mH3T32+y#&bixw&JkWQpYo;WqX!L9D$s}9>3@|R1}fPH$VmwLjIFzgr%U#a$5 z)0{$;fg|^HF}xWsqt_h)(!_&G!IcJY>nC44l%Hc;45b%HGb_;ZT~Es6se-UM$qsXM zR}uNK(-dW?VQLklhUDdXp*%F~?g6<;9VCiIrJN_vt#)UP1PIYI*kL2Eq^8?L8r^gA zc2fJh&IDz5bb0**cM@y0(4_z+!CkWioT#Q)g++|RRd1B zG2`8E+S(zo#-bsP-H_kOK*7J*@LGL|Ji!jvSU-rs^+df$k4(G#AGa)geNnPrU}@a(od|H6g^^75(pSVq?!wsW z8N!JOwS}zY(y#UEYRW2?k3tL-Ct&OiEtVKAn6R^^x%PS=Q+7zt(V@494Xo>EIiRWq z2M70yS%KE*FfKptVmok%3?T$YfK%)Jj-eTq((29qo) zTnK=LIWvoky<&{jTwL%Z;&ecZ@W8Mo`&4=;HA<&9{+pJ--UZBl%BM!+u*QKuuc92x zlcrU0=*}AR63vTHk^8d4_l8t5X;hmX%IePhShy6-j1vBY2=xVp#2-eDM5FE!s<`4= zOq5cJtbkb9JJ;QHGpK5hl(Bq+u}&)&lMy!~lk z7iV8=kI1D^yLM`s^%vkQcIdP$BLIf>m#CFody=gZ?`H4@lDspWt`jJUfY!44EnE%FIm59eXL2cmY%*;LuZsXlqiX;qGR z;7zqjE8_WGs_?>rJGBi*mEyM|svbI4(eMhTgFHqI=$eF|p2F zwk1HVTS#5PAGTOv$GSEYVz8lYLLIt7+K0Wfc zs1Zp^69(HiX9&e+)&A zzA^ErUr58hl)&aAu~2QT(xZEd$d$)TFVkjNFbr^#(8J>2Xz6SJ`rX-{4y1DOQZ<@z z*|25ln%InV5S+n^UU6y?XrR8lo@-Oox!PGUteh9hcSgn-SQi5`S^7 zi(2sWMpd$ZF?gBcYZw45&J5A_acmG+K@d?h^1Zj=74<*CtvTWbd>r_bau=_Jv}rkn z$wT`x-<6GY09h4NKtrp!og?-cja8L^rsWn^VYk*MBD4No56pOj$gGxnw}gx2CUG~9 zywu>}ECHEhPR@V$7gQD3<=zlth3h_s+6z4rM?+3>dO7@z5ZK_BhsAC|jh4PJG;j{h;TR<@ z(bIrbH$pXGQyK9b+CZuTWl7c@W@}fS*Ypi33&r~nD19L|ZG`U^n>5G3Hw7YbV%?ya zpZqgZI!IYX_CSZP18F}d<=88h$FI>+sFKTqmgGD97rQ2c7X-zuqFF)Hci z@A8;M@=Nf^GqGF^o-VAvWNaP;xbF0p!Efrrp5e4ojfJg3fBdKf_)sJtE{%;bDp}!; zOL^CmtudzWmu^~$6lc)U7=dDWt#Z{yh0gAhg*Sn~YDj_8q`Z${=en}f{IT(`&Fd6T zsq!8`e?c>)B=NK-8I4Nz@Z};9w@EU@B>j-|Hb`x^qjKY9`%Rf>E++BJ)7d^iXOJ8U zGz?R$jGcrP`@<$>>!OrD!W-Blc2KS*b&vyFvmP74#*wR@5uelrr6{G%o(6acA4!U0 z>7OFAojN)y;3S2y7{d*vqxG#Kg)+|J(kP@~2UY1Qj$YN2zu-&xK?FomLkYP8SS0GL z5$2oRdu`m9u z9HHAoLfzJ_60T9vDmG6OmZ$yr2*@HH*yUP0IniO)_pcHLb-WVu2hc1T=3iY_| zhL{2|qXFduRg;?Z8w|2)Y?D$U>4>uMZ;(N2zZ-`JZbh4$V{1D0AC&R^x%womef6jR zbB;I-iz(SSn^GY&9w{l}0 z@}-sIGBBOl9-vvWfp;*goqt4r=A4Alo_Wf7oZXP)6#0_gD(}9w2I@zCH{aSj27t#B8^J3E)2d$){-A?4^*IM7D z`=OQR)mYL+g+U?~VE^Yy;7IqJGs2mFzsLq;*T#bG>F6I_CDs2c&zIOIy6#G##61Y- ze9)1Tv?uY-3f!KtrN(2`j<6s|+u8)epA1LYFft3XxH}D-H*Oz-!6SW_N+w8sTB35f zUXz&3mI-g*@uzT-Ub7IW-7GfFj?Z<8Q!9=|VInSkHwb2toR=I?CE?Y+yQl`HhD43n z0U$zpFa6DeGOcqP0-$-M zu5(XLG`j~CshbzxQ(byTxa?<%BC%aB7;;ayi%zwJDX|hlKRXD`O!FXKM$RbAYh1l) zm|21J2Uj8mvD;zuZcHvSFU;qI%>H#p)Z|ma3Jn!U{ z8|0KG{ReQLa+emq(1ngc?$){k9;ZJsl4=ctnqD=P4Ihi&01_?hxqIIc;)KjqvT0ej*=7G~`{@*0cxOo00AEp1?HGE7r6D@u#&NZTb z`1_htMbW~=lZYHgp9&+n{16aH=BQxA41Hd`<~XFvIeL)xU6Rb zAMK>BewB-|8@hN3&b5}LEZ97m{$pGTG%Sg%2S;o+jRA8kO(uN*3lxNT6^Axt`XQ@m zb2Cv1SuB9_uww-iP7lM67NPmi2P&<7C0#6%7Vz-{Ydvbaobh8Hnrr7oponwPY{74Q zk^b)l?c}w{@mY&P(G<>5$uJmmF5~r5y1*%G2#Rm4_c~F3{=BXhMqg!waj`PX$fuAg zwBAq`ZAiUqgPg_-(_AFq#f`0s>A5lo59DDd`bR9(7LfAucCZgA)-U(B=tUq4dG_SH ztUX~JJN6w+n@X-92E;TgAiF*>PC6M>UCdXmcHx&CK%s!#BlLkL!NWS*m#bkTmXfqn zp4*v2GK=*mv+q-F%q)s)i~j84S`M5(6an~;F})vBFBO;)X^CWR#Q?ZHym-0{_OV1fZBQSW8QNm#L!GmfG5-u73*N>w0*{oLe-#Ws?q?DiCWQU5``q&2)8Pl zM>I<8)Z0z(Ntv4IFqzBFnO1=o+*Y9;!6ylD8>$e;k}H+^Uwo>Tuz#kys?9wP0I0D% z+mBGs%&WHw8>3_E^(tw>SIu{>Wgw9b{oz3G2iGdp`hCd)^Ba3TOWLj;?1o*^mg4EE zZn%Z{3}f=M3tb9hI)^rV zK7#E$n%_5>qEU9?y%-}^D_|Oqu2EP;pIQ8~$UvB)sk(=^#1L&2Dc%LE9jrofZVxdvSpbhB8Pxl{*X1CG zS?;X0_PtoxRTUD^Tk%0Nc^f_U6*q)c7;F1K!dC|LK$;^?>^13ii44$4#qp3ky25S; z;}JU5VtOx4^0+5AT5RH^V1tS11ka=;&p4D7vF`DJL*8kJn(aA0!5}wMwQb6qrOcyR z8@$R~UI^pxhT7>uPlMwE4OW^H#MK*;nXQ|`r0)_WGFH~t!PI`C2;kic*#RzmPFGBU z8Z2?c`c$c#xJfG;Q!|7dPo=I>MxJ)W_znL8)APLgX!hbf+SNEcz`-lA7M%9uZ zI}CsK?$O2+Z*$=tsn$sYOyl`?+fgLe#=Vu;rFTB%E_pjF6ZPL`TioAYiSnC3#8CjZ z6=}eWwdmT4*rmVDSUbpNc16E0GYoG0aAmbKZc_hs3qD_EgPvG%r*O$eO2h(7*Do0Q{@a49SiI0aJ>P$R!nczCs?hGi&F3rv!YG($y zM0WPQ0`%zIY-HE;nzi(_0kvjSiG?NQ(1(pT^Kd!yf)Ebsp>1g9W?Y1}<@;ko&DnW( z{?FmZ1#2liF{BW>-%ZC3iE%KH3*Fn78BhBd#9ZC))~(Yic4$gGc02TS|-osGEKkzcGX_0g**C>ZO5BJc_+6Za@N+sS=F|C zP~F7XI^dyu+tPZ(LT9BTkoGI%Ks?MZ!XN}2TPD3r|AcXzu3w{KHFXy22HRzS*?mi* z{Q-i4+BxCBn3hNsY%Kh>J&{#W=*cKlpW8g_G+Bgn%f9swC0-c}iGzdUT|ib`-6j#k z4?c%#z2jr1rVJUI(OC@H@ns5F^bdp80|0dVYa8xk#fB(h?ihhP&GHBV`^tFcbZOVh zB8!^1eU=`?B;UU99m~5XN&zd}sw#=f9%wd5ya>dJ0#aGDRD7NQ8$j2-S@m`vaUcN! zo5%94yzYH4>m_9Z^EK{>=9gyL>!b)C8co~={ElFP>ia%YRNQcSpH=8Z%Z50>sUKe4-lIsx_W z9;pI#&3BAqr`KA5)H^C}|0t4wQXEv7_1Yd1QLQ(e1y>?$rsk3Hq4--dB2i%yNwX8R ztLI7H+S>h(AV5oG#J0ot%tWV67v z&}zIsiz=2qzAhAts?Qy47W=4hHW1lfU2DVq=lNr+iW;7nViQ*Tg0JL}iIxCZG(CnL z$MuP8??*SWph8Q6Kvt7R8z`i>=4Ee|^-k`v)MB#3{#OsOwR{H8aQh}ni*fpP?2>(V zHO=ce$<0Oa&pW!+@z7NEXaNsC!fPRnqQ#Fa)`q_ei@EQiSsKWH(n7jxCVb8%B$&ID zM-1hEYUhkcaszIieno3kl6uZFfh%-TJ`dC~FuAnGUJ zRiJtL-XGKxYcwgaDMZrI=GB}A>WLTx?uhkGKh3ruKP;x7W~lxAnjIvpyG5L-Bk3qV z^>V&OlsovjCl+Zog;*cQUQZy`&t9#Jz`ou7JllmJVAQjVeZBQf(Bau6Od`AF@-}Nt zwL0k1UIT55oRYt;)ju12Q8EcAf#p$zvX&QHLnPS*0@okfQD$dqCy!R--XkE(p+634 zV4SZGH{1xm!{*5YDow)2c2Q46nm4$ES>S4$NVFK$sk*691zYGZWMi^M#Mi{aTY=+k zR89Nk1U;|2Yn7=8?~RRSP#yWpM9a8P{4e*8RvT+3LkH$Kr4_>>< zuO1dvdw=Ykar?RR?KJ8D00RL}=odH<@Xwu=>s?I*J*Q4iPURwmfF}w0)EF>YY{R zLg9sJ0R=Vy1^jVD)=z-oatV$AO$BchWZ|`W&kLMhR)mk|jH*K2#WE?*x4}tjY^dL) z!La$c69(Wp?kQ$ihA=#zD0Locno!(k4l^Wv3FU6sQ(bZGcqg3=TlAzBH^+o#6b7z& z|K8M(ks6{!alFw_4jBAJ)A2O|Y{!j5Vk?cK0L`LBmmS<1Tnl5?0q5}E5er4??bTGD z#E3=9k0TX#Farv9+Uf3&WZ!;I-+cZfiN^mISd>#DD!ko*2|^lY0*W)~qMB@?tFOCb z5)^(pAC->=LXJFA1cjg3U}yJwfxn9<=~iLO#gW`7mr|PGudztmatj`48iCq}?h~sspRy-oODJ+krz*CPaD7Tgj$3}U&m6Ny^ z4kYt^c)MQn<6tHhz`%hzS}GSN2~cjSh)CU zA~BO}!mB3M7R@Km*?EGO-9N_}>IG_6qWB_T3^xPPl3p@@?c?CrQuq`iAOX(Pb`0mb z?n&S~4mIq_CnE1XhAi<}LMv>miA#FFGVFkyEkn5@H@m|8L}zV83-p_G6_)B*Q946` z7E`Gw09wib~VQEI!CawY?nlTge@gd$1j2+5xnF29@2FHT0-2{*~i; z*nAq9V6{oXwtn-@j`0sW`5h!WHl4%PXjFslh+b@OI5)!ubgfFUvS-mke5F7QBOm0s z)qx@|8g|$(Q|;Ft{D%v22vMTlgfbjR8xwoxv8_z2!JScUA0Lg_klKGr=s?nrdF#L~ zfWfxY;+F3kV0K8IkTp>$PdtUt=t(A5qD!`;0q>bI_~N-c*P}IL_Mj^WZ15ARemIj- z&RGV!aIj{RqOgLeJnvK)(ParZ_N_nrsmQDbzP*n+cSCaMeM9%m%x!Yvkf^@c?+*NP zroaGW^Tj^=70sJf<%NB;?BMQ3SK>~)=J zdV;Dl3-!rmhAx&$gr|75x9`xlNU6c!jHM>`*!@3J5{U>iF5vNIa=tjp_N0b)hwl+9 zUaZulW|uQwGwozg{7L3)KxzE%&QD?8lkIvTmlVlwdk>xRnwUycV=V36B6`!m{iU-v z&TYe6dVnT^y9^?uKkJagSjK>tGZfNo(%jFs;ITWyrzXQ(I;Zxe_yN*8T|7r!%YoY?49(162Dz~s-K$$ zPys4=^8;JWG|{L(S>b6jJL>r=lz!;cEa&7 z$?~-0l@^M`-Rn4QrWdUo1NIljB(y7D&z`=C$MbPg-Kl#Xzk3(m?Ls0z zg|AQ|rexI#7mF&AUp92##|$$Vpu4L#GPbx|6(=j865pd z?^{d3kOF_}Gbbp?XAdyoJzxIFxs?en8}#5y_d`P#x2j;MH7~%Yycx_w1ZqXTnI1cs z#2nSby#FMlzhK2e$`1UKbEe?5E}prTEEnpaIXqe#|H?fkCC*95Z=IlSU^N#M<_psN zEJYr!l|>2FIy3#$B>>qLB5?82r#T7EtM7Wa`iSj>v`N(?8^d->xa>~{U*qP*`qSR! zs$9^@KBG*8YJD=Ij7pR0AF^u!q)W+|t%*Z&Z(G|(=%v7HqFa0JDxXUL_>M4-*lJi7 zjYv9C=*mT|i1>NF&A1OZUQAAMb^F`9B3!qu4_v+ZcE#BW;z%yAkanXBn6Go=v|D&; zD**x2%>1LWJA?&NSx^`_nWVbT~n(q-u9mysxV-TuL zkW<%=pJH%7GL1=7B%XH=Sob5!CznC7pzOC_)Pve5&r}}%W9YS8%TE`fO%V&6v~-;d z`(oxh3<+^+>aC@GnBEaw|bKkl=3aAR>iqbcclQaa_ZkgvXMD;-<_TRz1g zmWLgoefL_hOH+#XqhY^ekWhu0dT@Q9``J23hh3gWB5n6UBJy8nv966eopef}(q=_KBrgOFQl>o~F5BKTw`;RIe|*?qNzyZQNXs%Z`r!Ng4dHW|ttk;Cj|BqU&dbknQ?gF4|Mm?(|0atD>jb2I>fba* zN@4V!5hBjI%S>Q45Ra2MS8qW;JvtyEF{ydv7aTAM(dWflXEk)bM%Wktpb(0ZDLtqP zRCz7IyjpeM>3yEc!gBZrpghYvbEWnzg-aWlc?>d;L=;E45^#$b!K*4KJi07TCiD$| zNb&drES&dzwZK*S0K1dNPHSFWHjp5$^_-;43U0sv06mD50pD}_XAsb?xGS7$^DAM? z2}vn;4Y?9OVjg0lm;e9`U;&;#ZbE+m08gMfK3Xw=8USu5+g+CJuTIP*b9#TI9I!KA z<4@vQB9nnTI^uf87YV%kqokssE+=R@r4QydErI2($il!y;7k~8g6ZZ_!28xCbdVYj zaWi8@IU%T4oDk^({}dUj>eujN=~*_;2O1VwD74yrABxgL6&n-JaW5~{GsI#5xA_D0OW0Jv?W-mnCm&Gh>`aXM7quY5WflmOD$E;@X5(qa z7YDOA?6+NoK$MD_`gtDqZ!?eLM(>cpGmTY)8N7Li=W)GpOGC}bx{T@`Gf;b>?hLVX zh-!&li<{d6O^ki3MClU6aimv*pfcwfLNi8rIzYUu^DN`(B8F`QVrGS_Io4i4-n}^a zAw0LTT-DO+r1ul3^<$7wq{+UmP}&QflCjO`=k7jetxU`_kqdn0MP@Vn)*_0kJYCh= zs}{OxqLh4RyTSDLMzRQnoHLqCxF1LQN%Gb&rpzh< zERRtJyDus>J_)9t@j7Q)=-{Qni(j@Q`{fxtZJ^1MidQs&L#pd^%Y_ zA+dJA^W%=#={0&-QDzLs0=A zxB-fW_3a7i_R6^Ero-SWB0l!$|8cZ`@b~AkbPX?k64q<8!bG-Mru;Wi-)XyIng?FD6)#(sK@=*aQV_GR~> zB>tWA9$!pQus`kaik!J>lZV?1jy{R3%Z!mQ|DCPSEM1A@06JA~U1$edGJo2_GZ z55I>%PInAMA(X5v<^w{U++1soWKB3v!TbrZp_YE@8|!{s2otOnS{~;obQF5Vq_n48SsG*ZhC2L>&V>?a3_Fy*x8bbQv_~7D@9m3dE)6%z zI2-Lrb8Nu}Aki0m*7cN1b zbt`I-CFD@r0pfcShoNX~15cY{voZKNt@;;9Ni;N8*QW%G)SVCneuR_nEr?OoI-$0J zzI)liErfc1ItI_PiC-(s2VKz1jIl@W*!%#w6=wK9wORIs%VRYTR<>a+Sb`+Q#*~@p zs1!wFAoi||aUaJ(0r?|Ie0tdU__E|1TzF(2R0c40KyR^iD3k77kT*?*D+*H<`Xj9N}z5pR5AS zk~P$a7SRcltUV}lq^Zz0sL^Otn+Omx*kw%xin*f~nSg2PE;1~Ko!>jgKhC+pG0uDB z1lRxZ=b>82jG4~U(nhcu(_okV2Y0Fn*#H3GBPf6PShF-9&dC9wusXL~GX5RmusA10 zL}_S%dw{}GIVhS826e2S{|X_1q%{*o#zAsb2%AGnc^`$g?X$N)wx$=FvarBe@FZs8 zm>eN`(>mg9dH#4o0nPC~jj9}ria;g0IP0eH(C#?$Ir5JVvF{p&@qqS-Y$L02>Jm92 z+nIgF4@bh>vvO94*gIYXU5*uS*!1Rzl6FfvM@iq)>Q9SS-nJIgBG#774<8^m3Cuw z+%^(e{m2!8Z+Kbr0%{-SB?i35@9q`hF}A|)aUaXQA|?(ce-THvvuZ6@{P|U{;is&D z-#i?6cve*OZsxsLnn&PdK?xE(L|SsMSJ zNF4Cjr8jVFk^xuOfP+ao;wH*Py2@LSP;Ct2RffHbuRrJ8QR3jnF%Q~dR&dCGCgkeD zsMCqli!i!kzM9J{Fpk>IynHl-vcBP73=)!tb8f)k^$4Z?a6tfV>9;R46-P3i@T@on zJL1zTR@cx{-J~hnxGTV?FA8G;0YrQx{@n}z?YG5k4I^!$4GEmME0TM&+jnwe+^zl1 z@#nE(C55^KWOFBgOSMHuP@-#<9XN_f=eschV!FK`(aefkX_0%8dlX2|mNAN-5T(&% z0@;4SV~<=0kN>3R1&&3nSY5ErxwORym=wd)We0(R7w-}S&J4zR%Ka|5H;NSRZl_$- z!~w~m>vGX|Z9V})WTJ=d;_>>{m|6NWDUPMp=8A?QGc{CUxjxws-u)n(f=l%(q+$Yp z#+UYAzN;QVJf@XR#$WQe{+`j2MH#u-@F^y!n!dX_ud1Ia1f_QpMqKv2Irieg0_NQR zsD|mNR&!F(dA6Aum&ZywAB%9~1yt?8w`v9fe}EJg<^-%-T`_3hb6h2zTvZkeVf=v- z-;5k3*Hec;OeOfTy5BdOB@X!bgqHQL%BZ=5X`)VqMqp)on3h(i-pz=H5%I=u2;N+4 zHkcQ`|NSSD%^qKbb>br;z%LProwJ%8{mQg7@=8uA`cf(X)taWI%6ZIagMkQMY_m=q z>+kAjx9HsVd=)t{xiNOq(B32rDCAvPIGZ;VHq6Qy$^<#!dp2S9=|FS3+eNQ`Ypc%# zthgN+F^D_=TB=ghKf>0*YOrCFf#y|27NEiC?CEPl!=3MP2hJ@RO2Y)&NI<{+12bt} z^=bH_;0<4bfNagjTwKr{k&WJQ=RC{5&5XSO65Z7dWKe~-B--cl9CD$bO0oo1f~nzw zZd6C_R5rG1(3kXI59EG%FLesO&7_#SlBlKl+GUe9_Ysfp;cjMYJ)BS3dvHki_^$cb znxYf0VhVu->gq@q@wTx~aa^}!^f`zuvNpkupy|SKc3UZtLUxtFs0=dE6&)@gr1zk! zQAHJ|yH3xpWV?uwj;t}c=1+EG=afM8l%2mR3!vx}q=9Kdbf-SALc#`{Lkua?_lC$E z6b5)Et~gjEt10_{BiImlb@Z{M)8N@oUUpdNFCEB-w|%{%1%W}UO1eokEBPCK4NF9d z7L?w{cxsrRZ0JO}f%`KH-`To>354WDH8jf@HqAn+$?#y|5V`(BfinS7*TS+!^1ss& z0z8mY;BXWs22zrYA{ck*EpMu_GL->b!S#L5dgSbZYq;ONm`L*wD?lI@6u9R^CibJj zug`ks4I$p;_|2uGIDcJ3<8i^H-^@>PU5wfG*WMYL8vSkN= ze$HROb7z5{?3B_*Ml`*Jw{BI@R*OMB?J$9Pvh}m+hf5@kAeZoa>jQjE5hOqDWShO0 z{ukw6t{DbFD6s5W3^q+!B6TmLA$7{l|6v4p5ER!`{|s0U8{y#d&yo%A#9U`xQz~3g49CA&(LJ{Twt|3hd))Yp zFOs_L`7pA+^Z|jGR8H9d!inIHP`0@^Hh;M>UrTn$BannrU)!PwJn(oOXeZ?JGl}i> z(awIZe1d4a37{QO6`^KUcf!}a!7|ANc$-W~;&-$>u#9)}0lrk>zWrY*2(dKoVe zKFgjc*i&C5PIFW2%T-KVfF4SA{IK~yBF)5QWiodRXlFPOE{Ac6OGA1Ea`aO&ppx~M zlF`-OQe8rn-c_!|b1JZD2@fIl3Ek~&o?+i>`n!g5a&xQ!sWrpIe5~p&5m-Pxp7mKp zgp27A7jJqcxUsk5cD|hCSk7w$Wn^W@hNP0+G+kd!h00K6{Da^m-T}s(g(dKvr!`Oh0~ZZrYgCS^sBepgo< zgF%M_Zwet%s{9ijT57~V)a7^idBfNrZu-L4;TBsY>tf+d-kgebHD;M?Y#mU~3 z{s0}qu{@R&n6C*YDkLFZWL2VbD5$ba`nc_hr2~Lw?~bk4kE9i&-7yYF5rc^JDhhSa7w@8D704EA1QMuRr*h^R7hgos%KzU zxG2R0+M85mY$Olb41Qf*9?%Kxt+X^m7LSro`GqI79M*j;Tc>7R|EmJH)pb|Am1f263V+dz>uPnNP0z5b zm#jeYTU;Q3iQ(8T-^D!5C-Mm7f=A*A&8u%X9(AvOEMu+WjWo1LeeZH*R^fEIjpEh2aRW$8*Hjo4k*CEV4JM?YH_`P^djcFb+h_Qyt;@%gt3hno83)AA9c z*xKy&IGGz(beVfin1F;#57U2wMr3OIj6NZGZW7FhfUwxHdX+^PVnMPmBvivEyhY8YgdSW1!we_GmATB?_X!%G>A7)n*^) z*UA3=A&UVl+ops~Ud5Pzl_2U@>;m%Q_d~;4mmAb&x)6hAU(Qn+C~hWUmep1>@bDKx z5=7G~7J9xd4WZJk-mWPB=)$my`Pf!A-k zby85#S@4bo50wy1XZNa*vpAPlMfqZsT!VOp*h**lUf2dnStvJhqT+D<6*LG@rh+Iz zf<*LvjP}PC36~}0XbR-^8T)C5K?2*(^vh7yuQn&)u7MGUbDn>Pr!s3zJ=>Wbp!78rtp4P0VY*V4!ntgQY@7i zP|>d%(j6j<{r+#JO{^cUq)`065WUJJLfC8Fzy7HQUM*zc3=fZU_X=&$d_;%@R~!+l#U!;G)#g z4YjRuqgyo^N4<56PB5+@ouY26hSf<_J(>4=*tWIu7X6EK_t9TL}!O$+<$ z*Z4id6fZQHoO_)GG*SY5`)em-*P&!sMzY`5o!6z1IcmZ*KLd)^8C{h*LgIY|>xTc4 z!f#9G&w<&DC9`UZSxtB4ZW6F**_|BUBC9}r9H2Z=7MMxz(^3_zOm>P4@SWk`q0jcT z0a4-1dlbjsxRSf14V!A~sY56h0J%yBuGRc*dicN-^JX}rfD3>~cue=y|B)~B-MUfIIk{%u>-_qmdChDQ6Y zeyC+|?cyciWZ*6!ndz<=!7KP$$J#;-o**@(R!BGt8_9(Vj!w^9P;<;AHoEbf6|{ig zUfWW8!xtud`23DEhQiC(YNgl!p-c@5X|q}xjtX2ooiGXjS7JxPj4ccX$3SI~zaLnC z_k#EaT$g=pGa<1cCUn`N%O7yiqAC1S;1y%BE=!VAO*G_w%m|96N&T?Rqg7vFZpKF&iS6Cxuol*cU=A)~DH~1W8IW4sQ z(6yS8UN;@(p0zd5VFwY=5N4(U*6FRzzxCF~>~+$$Cz){-b8|yc!b5O+ zK`g3quwHlW%&m3n84?@-)X6yOe?mNZd`q?gv6i$o@^oSJN0vdYT@yU48B0T# zTezAC!gK?;$T~b>@W`b{ASKN?9E>u|!jhxT-alcXY2Vlc8CL)e-=rMQJGJX(z?55v z@SMmSXeK0=TU3X*a|r?Zd@^2JIPV7J6Qx_b7_V^YsBGM{U9U`pl~WSu3wKx*(di_` zj^j#1Pl8+U51K+9-xM7A`0`f~U*m+v_1V>=RS|y~DEWZ2g3V9bOO`YGB*b?fqV~27 z*#$N?_y&8r*X~@47Gs*JKn;Gb=A!!dIghO?H>zQnqi?IBV~~C97ygtMa6KfKQy#A_ zlndo@cv;en&8d?}HZf@#<>8qT>s1+o7OeB%Yk8YOT|)}yIECs5<|lkH+zMqBF*t=) z#cLJWt6KW-Zu*uxRoN#g%8>R+m=Q-l{>jMJRWmYOSKjahcj;#9Wdc}E#_ zx+^S_zYw<^F?l~^eP+51!p`wQW3MEaTM;~&6zBi!*sMYWQTIm(}R184)MwNw&^}fXj*^rz)LS>Q&U|W$o1*1@buM6D@B75~M?{0R5LD zX~>}?QOhbrlxpjy9ZZqvZ$Y%6jb|fk;FOJfrI|#UQ=)@WhcmXOd1XQtZgnYwWzd45 zo1)@TCy~k$xiM^CSA7Qbr{^YO>jCLQRssWXzX-Cj71gk@xQ;jo0jOIG>=tIL-2GGT zV`Wo+YgdBi_`UA`;~gEWre6k%ofb6jURJ8J-`t=2H?XjDjVDGuL)_+Nj5Ed*h3U3L ze%a?y`^@{+y&)N9;h6^<1ZnGkFO0G9c7m7Y(9zJl_ zRS+Ll;q>Vp86c5PoX&`%LO@ii(Zv}1&WfqZc@o+=p78ae$x^oKob5GF8Yl@keVS7A z%Uwshn3;fvSQgAX4vr@)>id#_@H-*_uAgI=!|wS5tWNpyC47;mb-KHN7)Ex^U8n98 zNt>7&3qDL|18;i~7SX<|D+ZyRFH3zaffRpsI8FdoK&ii?)DHu~s`~*utR;_2NB1H1 zZ$7qs8$7_EcImAv^R)(YpsXb`K?ls6Vru1546*bX)m!O(<1k!3MdGW{os5O~x?Fc+ zK2<}D8TU#^w~nA0W5KD<2QazS|>80&EX&+m?p*<-1G$t@)MR z_B+@r_A2EY;m>to{rEsjQa18a>(8Tj_$dvD)JOx$tfk4!fU?)j*>TKl-D@e?a0T9L zDiRju!*8ahEc3@2+b}i~h8)eOoAc|UvpH;m^5-!*N|c6Mb6MZ2E&L)0r?rNuP3MdW zmo!tSqUrzM7M?(xqL*&2n44ZdQz_{c|MslUpHhxP9x<-uk;-m9wGX1Gx_3 z#^?MV9vg*gX3HV>&c=7+sq_dd`)!>(9zg9;^NTZ!{46A4{5RRld{+m;=qZFBh&4)7 z9}RaKLHLW&FpV>*(fqLG?cJV55I;%$2FDj_0qkafER+~)a9^>+GGDHd{6=vTDknNV z7lT-o)OAO%!l#PkO^GTPb%Pk20-BC;6``K$&UD?4pn72L$HlLX4pPjn`YGv|U-Yf9 zzsXWCk`ki>tGZmF-1`_=ev?2VY}$lnHTcrjIu05QKIGbozEXlSi8 zm@y0yq=VO@7vItU;?4Ie1Jpqqq}!PizG>=MMHzBY3x-`B@vZdxyB}0i`JXTn3cD+7 z^p@B}Q!6SqZFSwuTm9%V$0N!UM_Dz8;t@vSWNUl6vy-s0E{_Lt0~CbzICe62=ip{z z>`4?gEBMda#96UN3F19v_kQAVSAYb~kbdqX1mTY$jZ^-2p}OecA?O5#xdVya?Ri?- z`k4MRS%BCzq_R{7F^rK0rZhfPxrf1>dk_fWhVuR7v`rB9uV^8DHW9mAWmdf# zSu$N&>?|NK|3AsV4%$IXZ5*trNY~latHpu;)aC5v$(1hJ7I3h38SbjWwc+Y`q zn(S-k0y2aVNf|X@++T_5OTm6Ww zXSm`e*iZ-Fq;5oOXOP`!w=t-ru~h!YUMR1*jrMuM$~>ab;qdJK4nsRQzbQkD2{aFs zAzSwHTm!JMdea)C9eP`;UveB0Kh@!E>vFa+vfvCJmU#bW1CVl9csy0fI zxX5M`38PyKzq+$U#&JU1)Pe0oiLLMlf{|)E^b)IehP*MwMAQWWH_&;@PA?I46iAWmY_C*3Y0Z?i$~D(_*GVxNY+g6yx zlZI5Ai(FW;zsj4wC;*PpeYs>5%bt}IR8A~6?_T^L7aEP+@^qPb=GL{$ihBMc>zGZ;C!>1BL1(Pr7ftMDn7;iuVJ)v7xqBYA*llzDDD1n7Wf;~RRE!#jH-csk4Fik6wJTM z61m3K%gA49N|M1z6O>*j#O}^uWy3-^|EZl~GSmKF%HKHWMU_YcXVdAUMg`>9N+&jN zI5=#=DAVO)Dp1L3g5@3S*iqI5`Kep2msh<|cmMZ0P*pIFVQ59Ay%%xD`jF^51Y>?G z`hBEY2?1?$m5tNzl?bIvv8Osc@jEK?n%#&K5#!^AcZ`BnH3Z!uTNHO@(8(%i0!XY- zCfN~kPE;A9C&eS{!pA|Qz<_7f;Tep38!-CFEMku(XFJFPBj#VgH6$+r!{}V_K*M){ zLm5qsYr9UhoZP%?P!u5Yn0ny851&SDt5cc6$`Ml`Cm?>fi9q%qj>np6#)1b+7JKao!aUS;u z4vWT4I(v2ZBWNliP#KAd53ME@?r$+fl}yA~pqUOf)*pUhpErQ`T(UHeikKH@bG7OM zeO1vxvQk{671LoZ*Tr&vSHHUK)8e-O{IKybBV=>538p%|s1k(xZ27OS&G)0#i|yFO zPSrW~?g!RG@E*;r<=;rITm3e_(~+3@F1#}!VIdSO92f~yAmz_a(`<{LPHutt2#Ddn z+pbf|f1h?nFL6XiUfs$&m|Xak)&P(0XFnc0?-rSGf*cT`y)Ui>V{C+Jde8j~0CpZz zw?UfbN>d}_nCzJ=UeypEl7a-ISXoQ~gCRrgw@o+s8ot_f`wvdk4}>{+yXdW;Ev|L0 zx1rk(X|WkjNi-k!Qbj`72b+QW?1M-yh^;Z}*L@JDbdAeNpMQyqx_ed~P*#gN z>xEDoUX;dowm6hRw2B;TO`=~9C~nKIL+R|wLMwViJiil}(M7sFNKU6mFyV?SyUe+r z5C`a!o+q`cCImb0PeB+0NYliB4V@*IJ%O{UUpC#2GSVF>5*v(R7RMqX0qUm{t5Um( zS{t3@v7-$maD5#`w=K*8U5CHZl+$iJAE5J?7Gx#V0ay_6v(U1LYU_wMnixA-doJfb zAsim{<#G!IK;c-bW=lh42!#0@nlm2jh+Dm#c16(BZK>3k#wF#Tj!ZN^J6_>>;%$ya zm_U-_l%f@8M@po-SdZ-IE&k&OTn3*=lmd>v&w^LTe^!SC#Q%4M9P;$p=~m?~XrO3I zu>O?!O*%ed>+(x~(k7pJI`437R|=5+aV{%=Z=08^0|dY3zf`|ARA{ZICj!oIl2-C| z;Qqr?<`ZlwKAMDfA^>&bf}A(1bH&e**wh9|{$6!3XAWTVdA6;@ziTMdBF$SddJ6Jc^zkkfwqQ_v>loYE?#rgo;@?ogb7&o#rWO*95E%%c{ zU%db=`+g8ZBQL?GsQxS5Iw~C$k$m%QE%pDV!((?k~ zPANu_ev^NXSc|Z`MsvEst22isaQE_ksl>Fem>^JNym;yTke%)&SYA|-N7pu(fu{FK zS_%xnEzFY^QnJ3)$;b4OW%dIeMfeVEdd0>Pz(?_mZIVT;?n|tJA1NgL+yXA={%!4P zPHXYPs5ffyNN{ExNtjSQN9&0r9-AXK-}n05wSTTQPeDvCgor-HV?=%4yM>Pyz^iJ# zTHMnl@N(e^!xJ>rXOLZK8oIZX50w3{Ac$~$4ghY6Qk=}oEWQ^>zuDd@o{oU+67>Cd zUuUgiW!qsfjH(e@aTMr3wQ}iCU;-$Uq^SZiw+(RYj)5GW zxZq!2lMz+~2ODUG3S|Lbi+Ww+Iir<^;!kPeeeQ5#mUPC@89Ga$zg7apZ8nv4IGCb< zXxV(me+$~&AxWsL`l{$*w0e*n@YVpP^wic>C@lLDlD+f;D>o*gx^jn_lb(ti+CwRA zVLS%3I48}>833#-DrjKt>=odRPh?_%+sm}|!P7*6$E6%_Qa4*@cqC zM7lQ{>UJ&FvoMo|mq2mdey;L#BDf#!g_+KMyCA42d9vizN!p4EulHaLFy7rLBEhNy zkGh@W+*1$X1>dQ1P@gM}`B+1mM=ZDh7-l?5bIrpW^z@C0Ps()9a~KyN8YG*KE`AOp zAvQVAF?T|RyKC-CaaSRDKsB!d!G;pYE{dj#z=OYl`H8c|?5J)qRlZc;#oNm|>h7&8 zG$5-l6;9|r_fEq*@1Y}Ap6Ia1-LK8O+}NI;OBbU24Whdx$h_82v9@H?(bRnr9KadN zAeYHt?iVhW3v#efFwL&Uk<;q8HDzR(M#lG_0F$o_{(O)X&C$E6+YaoQC0$JhFi93p zWJ#Lv=t3GC%V0nN1NOu}0=BlO7<#>u+Km3x%8vGb>k*sG&w#nPnCf-hc%*rmvbTKjY5);7>-Md0??cfuavD|x$;9|M|_uE!?<2`Ow$7)56u?KDC zig*Ebb#U;x)8TxnCzKmD=)SQF{Inpy@@EEf*4CB)k<0aw00^`Rkfm(eF{? zbdpoX zuex`=aCjs_b>V6Tv`sRiYz?72!f9kE9JMSq$Oi(PQu01SccF=!etQ8zE=jeWUW;f1&(hk9viaYHZX8^?D(Qb z;1aDAefAJOBZp5P8(Z+e9WLdw=7P4;uad_yNet0%`b4(hixDUf7)N~Qdn5`$PoM(}6gw~q^x zd~{%U%$V^E0o=4d^otb;PiiBYUu3(b)Iqh2#Z=wfuj3q?bA%|BXrRmlL^i#s!c5PU| zlP(`%Yqo(NqI6(8&0Y#uys>9nYi1d^=|#LAkkk(*($6K6xzGay$^Kor!I2C}59j3? zpWW_4PM+^8frXl{v-9^@+_+Oz1oGnKb^VjT>(U$Zz=lL8XipK5=_FQI~}8C&A3F!jks!ky;n0AS{If=xD@Yvok?;tKcA+ z>feaKu*hitbd2Ew=lez*1qgC)NP_H_I!NS7m|gCLBoUTyZh-!U?2&$yK?16KaTl0* z!cA87WhXjX2NheLIE<$}bZ!=fRea#8EkOo+yX$KGM^N^o1gnb-6rI5~t)Enz-r@^hW@nA3OGR$`HEn|XpN{A$P?kw-%THZ*0_Y1#eKNQnug{+>NKo$c_GKhMrtXft zHALiQ030%HM%7O~z1oSys@^?UBLA^VstnardBbFR_?YGGW4>T@)2jvo=-$6M1u%;& zLUi(%5B8Q@Apnqh`5H7j{PI_TXwL^`sO-9}He_tk$xnxm zIht|!-nEIy>^I2&!h5^$G>QJc0 zplt4)h8J9}sriVDe?Yr_JIx9_k;{2{Xy4st$y&h`I{`XRFIiF)F&nGQN!=uFs-NH!-vZaFf)wjVu>>nC?Z(2&Tx`*P7C`$BqoRT!f> znPyb$p0eO*1dH;cdyX1db~0jHwjd`bz?zl=WX8j*R?odr#|v9Uw5y9NPS=$pm1HP6 z`3^wIFzbV9kW1V^sSW*zPzJzn&T7717-42v2gJl$?RmkhR` zNJ$p*IxWHm?{>~7{2|$nE9^@0dHU4UFE52o5e>PR-S7{l0q%gYeAENo?-5zmfU z=3$ceUzi|Wtm5Xn;%WvY|wf&xt*jg8Ag?3PHplASX<6fB*V+_CN-5 z%Ihc$0RV~ge!&_)gI}ksF77yyNb6x{;^)zRCo?=5b46#~{<>&?(J8|eOrXS-ixxWd zFV=xfpML^Glvm&?O5+JIH%?M$qYK`u-?IUO@h%bViP1Y|PwlvgU#`1H&K@X40VVfg zD^K2)TRYH#njN(_(Rr<%p1tTE#CKp)Ixjw~;L@~f$r}2&2J-{A!e}W1mCygQ6~Uca z0fr_iiUQ`f%!W7IPHkv01Q2hzxoc72D-T8HL2dNJUodTq*_TfH*1(t{;;Xnf+MlVo zJ!`>-@#P^^FTn%_e~JacRIQDjaSdurBqX!&w`IX9UCKpybN{0OY%y4Fq^FXOQq~4XD}a8N`JFI}y6%%U z3~gE$U|j)xmybV6?RzzpG!qg8RB&fvb^9!^eQXNPPiHK*XaZYMmAQ$4bXp=ES+7Ph z%(tvNMHe96VPDM{>(H2fId}`I?-W>w^%~Y@;acNNUG>9cRk|hw4fj6aVaAb2=)%t9 zH$V+N0q*wRGlCTrMoK24@zif0M7@JMB^y-E9Y-PCaB^%PK1lmi_YYqJZ2TdgQA%U_ z7|-ID86n_I3Q~L&9bvNqbt^&dF)qVbpLX1~a-u%t2Q0FOx{3WI8wOkp#>CM}E}J4B zcDt!T+*mlAg7mEEnJgz07IphwE?JScJ%o!(`pK6o_#|sY_T|<2V>$D^)*M-uot;7e zLr_95y-3SwmL)1<`g36#)&LQN*YbuV{uRYSQ-Ge>E`OTW*E5%f=XQl)Q3pU{$7l{U z5dSAGBT@GPz-tK!iLxl`;k}1q+e#}dxV9?`@*Y^?f%qIN-Yx1--ycYL zB+3S)QAc9j&ZCYDYK&D)GTShSP4an#5Lxm^eTLC#f?WbTqf$P3_i{#S$gT~NRvPFN z)UQCgvg$&zn~HMYoq8?`6{3-b$sn-`!?Ok05HO$^cO%vyn+cCf=E@!$Vh4k6ZSSd> zGRD4Zbu~=4*C`na)D+KFeY_Ojp~m&5%d|~9iBl8rcIQL+b(^`)c)&fT;2$v@My1LZ z9B}Wf2eS|(zqGC`K-|71-O8A+{&0LX34c>hpIgJ zyxbkTn}N?yHrQh34I*aE5}}+_ zhIKE7o;(7Wg_p_Q@ki#P?|yApYHLimOh)C=(m|IDj&{p#SbVdd9En?;;i_UQJWl`q z*f3EArtJ6tsCyhyRRonXWX_K`LcOV8nk7Q;B<nK2-%wTqCs{ka3L z6qtn{Ldd+J0tP;vv55_?tN>9DJY;k1+L&2x=3q|$hPJylj&``L7qcsiLm~UT zCl7;EE@&&lW@hDtqa)H_I}{&PX!2s_uv0>+MS2+Z!STfadM0(yN6O-YnJ*{}#b?3Q z7=2cj;g?O~@ZObayvwH0cWi3E1`$Dne^k=6h&GX`(NDBX&?Tp zka~C#pMcYmtcVm8x1giJySvb1f?p8IwWXiJ0)G3wav1EVpbe;4&o65758a0U{_es8XK|vo9=uMQ$`mfB*mxxj~*nWRyf)EB^oh zKZ;gZ15U)WzrBQ-7{Cc%W@ZIF;LBb=4rJ2rcfYh9tv&sW>0lFPH2?>HS>PqW9hG3+ zZ7g_H_1{{l0j26ifA(oF+r9+wd;zI3_}4d#KWAkJl&`50)*n02Wayz&@JCeW6_( zx~O}4D8Nkh>*&&$Te=o_fO@mq%Ps zWKBQ7;)&NEs6_)Y^-I-bh&XW3$FQr`3kE%lG)vU#kYD+7h5Ln`xyab#%Pp*gYU?=c zvXu7+${g7Uscl}#M*crT$y&%?5Mm^QJj0E+uJ;REREJc4F23!mBi<zPh7c6{c`-R?51y^j_%y3_TW<+Q}xgV)_HiHZhnK zdAgM_;LFd*NwQr7b1Ojng)MvH(TRuEO5*zmb(;>DQ=&D!X9Y4rf<)oyILNu&C{vvl z(ibpi;430mr)UQ+AkT&h@>-<|P5-{vBz(A8U%ojaCPHyqK zkkm%P46f$W3QwdBf?CTr<{eE-9UK1;_5QmFb4JqtCKUpfT7fDvv_)YvL{|ApZ8GI# z7%fgfgomWywb}U40_oq(xUA=vwBY_9Qgq&@bI~DkKfFvAw6L&nBm)`ebJCw?N7~wL z<6mu{Nml3grpbdGw5Y0~DXmj~|Njy-VqQeDYv0@_A(1N>l%0e~fC;De#nc-SIEMJO zY3$u-aRVdl8|jd`G1rodvCpr`zO@c2!C9Jfh+^2nwA+XBSkhe}CN_y8*FB4PEQZow z*1Epqb&CK)@V2Z3H;byO$z@&uVI=aDl)G9~5awhoR48n#otDv3LXp`_CXPt5TVj9L z;?k;Qwl}C6^pk-_P#5=f^WxT`JSB2{kx_fBrLZ^>JHX z+uvLrBb2R2W)Sh|cYC z$08D_AJZS8WCAEb4uH#o^M5gCtxGH>3NnM+cRu0Es~Og2mrQgl+&q{8G#*NNX11*; z$rs;+>YtPwiV}wF>;10+krVeY&fQq{*Uu{3*)1O80%nu0QkZ){d1W5!MHy?@J(Idw zwf;XQoa11)sU3#ge*uiQ@J_};;k;_Gbv-O)!sFkj2XnW^I*!GHw7~X_rb?z#^j7vE zj0+d27bNNpTcVza*Pc%m$1HzZ7PtGa-kdB^34KDp(ZKYXw^=DodBf(Ky#fAWQFz4^@vXDk zO;KA<2zyl+7Q!7{h!N9uTOj1M=@csFYZ5#Hny(1RhrW%*hsLi^u5k9xaVq`Yi@#oh zM#P*7WxDPrhTd;`^fEPLkL(lBeY}#N30TuRJ8q$f7_f&&{CBYI`bAqbF9-0kiH40|_$0+!sjlH8|jg zH=akk@Z3(lhiAmAU_M}ok@Aqe8hGBa;CMePL3hC641 z)XG9$TDK#WVw=goy-6YeNO0F$KM(S<~%y~uxZ#*q#~OO3MGju04tQEH#O z>9;*scK`$P2s}#7xROc=1m!=SSKNoPjs{h&%hZ!AfN!r?m0`TF02NgS{Y@-3SGLaCZCRj{<18;WU{U&~qAR8r{c# zr)Vx${2m)JH96Xa9WZCRh-n1q+;td`U4E)7hOEkzxLIKIyjZ^?-kz^&5yl<1b3w1`GhIl*5y0DA|CKb1Hk2uhJG>o4A&1l`9YKh3!u7kb6*hsG0c>H>@&tNHe%5B)} zMG4()QK*FU7|dUsH`{Z_)(vz^2oq|goUG<8kK^ipn(7Zws`;KAW;w26k&MkYX+VmO zua(d~3bQq7tkMmW3tri}X;T`(Ro|sa>c_6M6|cqkbR6KS$f#a!8Ks?2h;*)phKwT2 z*x5C$P3uo>7x&=eNmT}hD0%Djz`Gj9pwMiW%65<8kl8Ic*SfJ_&(H@4}1zNSKpu{zCjxH`_+dA>hRJY@n^0F|M+^AAuN2oVl891dutfq!5SH{ab|$ zqEQ=|+vzc-F07E>YM_PYjn;A~e|W4G>m^d*bQ8q`X5|6<$;*RlD|f|g}@L{M~>}NCVWZl58l(-EUxO#4UG^n+vgZPn;kR18N$AN zP+Mms2!Z-))mNnGAfx#%Gm|}vavhfziSSrn2eZr7huw|ACY{N23G!;o02Yh`IN7dW z!&Jv9opsmZl?@hYcZ-tLR z;PumA660~&GKk#7J5%u9_LNqiBl88fXz!ic(Z5}DS-^N$viiMz{QM0|>H(o5XaT0S z8vL`jT4$Jr3_l9${^rkWe(HJ86$l*?>gU1MiQq*ld)j&6+c>mI{!^&Hh#X06Tc%bk z5sV_A8&UFhJaY8s_E#Dp$b-ZgiP^1jt)X2U9kgU*K#*0`RCs`VSj%3c|1XDPwTi6q zL+t#D25+}{vp-TJFNgiqieV@Bi_CLO98_T73%xFeawd3Ai&YAeI&zWkLcW7{uvA1) zc#l{pn4=5yo9jk|F5MxFe5G|DvET2Lc1LewvRd2A9G3H>|536?t5)|n`~(vS9xJ8j z^Y}cy<1ktF^0Ti+D@Pp<2tzw071k;0Rb&>0hCuVSVvC%t_uK{cJjZ4<-{_ zbKk6bv>nW~_)!c)`!luY1;7Q|$eS8;Llq6K^b?Dgje?}GtAja23klG2UvL|klqJ#gmMl_+mC{^Q_HkOX z8Q)c46x9#m*+yK035Tif?J>fF<=My(O+I@Y8@6r3SUsepL<_9U&3?lb*O9=htzhr1 zi)KTxEtFDTH9JCYMRJ96Y>}XW=K)?6RvwtdBS{>^4WeVH)Vjk>A929u`@X%!oBHL5 zH6?kVUk#VUb{pM)bOwvIRhpF5?Jgxou^;|KA^{bxrpOsl!XiDaV?jf^yeD$nO|RSg za^xRAy(C|;T>EPJc(!945)c25*=qGA07Ixwhe_+`mPF=mAb>GDh};W~{944<6drI& zIR6(QBUPIiA|Hw(}Si{`%nbX56ln>ajL$vZE@T}6vW@q9nw>>iN7 zqa>#?J0Ww{^Op9EbFa#jSa$WVM$<0Sc#yK&h?#EXxW+!BqTkL-_+~F*W!V{j?*$kw zGdk2Y*)3!{D(R?&^tUUY&;a2^a;TXqu`zSjlW2q4X5! zsuiqNxPGCTqD4QIn6d|N2(TL=59`oYTrdt_fJxm&E%RXLEBv;APdd+ zv;A-O3WlOnt}xcXk7OHwYl`1CdNn9ll$mDnNjJFNvgus(nQ2F79~ODwASC&`*A*w; zJf!hN)gxC}oR^nvx4kDrY8rvhgbF;&Wrqc5sE_0i1YMmAnS|P7hY8;0=rtJSzyJUj zKr8MMw-XqZZAHY(B)8f`k&ATW(;y*o39mB-j(_(dSeP3%8;1^st+6-@$1$F^iwtsq=(e{ri^jrh7p`XnE^PW?B)xrX_;5?Ui`1 z%y495s#e*{F4W6j>As_xFnq3zfw}w2FMrxas{UP%-F9h~sZ+UCUw%u$p(sfcb`dAT z6Hy=8m&9fZPTh%b;RUf^UYhDw8eNz@+Vg*lZhnj?K)n^A3x9*-xhDa4VPt3mV-BO% z0R3~?*Qo5GQBfEVSNAyh3d1B zdv21g_i)}lK2j|d!)>+vlYLwFlpji(374H}f5t&?=F}5{*WC~RuMW3-JfO*56qU9w z3WGT~LH}bld2tKXJruhkhKa>p1{stnW5kkVRC$^#8;Dt3U*nnh=|!2OxH_=U&%yqZ z#%f@7p}km$4I*K z1P#nt7E326O?gC61P5V)u#t&fX6y7z*h&ByZOKeVGgj9Wt`lv6Q&oLXtq2~@{inZ( z*9-YfROQpydxPEKhUd#`&Wm#qAR!2=8pRsbpBvx!Sv4G=9_nm>E}}LP$WO!EpOcW$ z>U(k%|EbAMOI6$4ofVp8+A>=VLFF2=Djd|}di&DONN7bhV)2mB z;eDS@^_~pE1goLB{_vk6134XfJ3Qp8onA%BY^-wJxO+S92R~nc9)``j`(^$Sn1?88 zx%U3*Dl;eukX)5Z(i;@w$0t0(QmGz*AIMADQjf zmR0SK$WlDQ&yJDhBv>~eHJ?BJG$O${#$cv=e`qKwnx60zA%3i6i>>SCtz_@Jlg$vt ztIO_a;Xv#J7 zhFWIe^sw=w8_0Od44wM07(f5=N)R~-QCh}uc;{8v1_yrXHs(jpvBNznI}@%G+U-jN zzFPEFMvQ8+T|vNgljAc_t(4QCQzSe=>V){|ctzf$*~U4hC`+N7a>LtYxzKsEh=jV_Tp#yP;8y%_o@+5X`JU0+ z&w3?oIJHwPCPrK9cLs6`W$_hQhr9C5ky#QZyP=E$aeVLx1RXe5td}qQ9w>(#Z5f}1V#B95w?+nF`kEiVjyP>) zS8=f`%8DZ?)@#rx>(# z$iYCeTq__e8|U$?7S4+*x%;sMr<7E1RDShzL3&gT`fJe*!~08H`xiPIkpGINPG}L3 z13CDb-IPQFzS~yLGT3`*v6Z6~w#~;~sDMP7(~uBag@Hc^OpG~we}gjNVmY3F^y@!B z&DKk;61Bp=wo)VpD5vJ8iY+`LYI)d9vOFusUKY@bYucZR{i76%!2u>soLUa+ZE9~e ztBTDRomm>&5JWzA z&2&3st{{g9$H z+9NLM_e?f<48$2K;|>^p#u^tdO*mEno;|^k0En2|Lo0qiv*z$E$M&Xe^XE_FHLoR1 zd9O&Hy`ds8ln@`EoYThO++uuA2`s`KmKWWz2+aECx%AwE25tUMBDEqxeTkm5&~q2P z#j)AL&Eyq{u}1CXlw|HNU-|bfO>vTJ88J4xNG&884l5025VqqPLb59V7~ch3Vkua1 zU2t5pD(N*BU+g^xf#gRmr&FP})8mgBQ?KrWY)TlFp}>iPaCAw?lEdLPv07C|F0=M_ zm8JEG`uqUk$z`wxO6~u#tf9TukaUuMo0*^ez0x)K1jrw`O!bZFe0wMm5c*{KyXTmv zQDe^PjF8xsN{g3MfYXYVk^8lb)!Eln4!yokxnq-np!~sM@C}4&3o)2b%&6_$D4t38 z*43tu2U(E1D8X};JF-=v5BaoJTF!{ZXvYG_L6`;wPUV!uD9WXCA)Z131`b1>9BPoS z63O2nD66(V zxbCZBbO7Mz?|FN>oqk!(?1-HPk#<(<`U3e}2fOB=5mf?H3<#4?dl=_jhbIn)nQ z(I~`&#Bgd4109UQ;QwBwYSKrBm6dwFu0UZe1?XZjfezDz4uMi--o-MXlDbZ|qcM4G ziRvo~ZqLSUr4#>w z+rm}ORh>QqeBp%+zoKo{5Q7pEN!%xBKXhdd$RV_vU{jxV9s<4tA5jG}YdIYZdmzs2 zq`y~DUDy4VAY?}div23Ge1W36hDO_v=T0U2w2{2=z3=-wQ(5T~`vp-8KIK`WbT zsiB>4fpKUopyoTXyoD}TcRi?ztNG+2l8C0jv8p}ykCJxXI4b+bq5FiuhdTs?0})Dv zYOEKF{ZFM?ZIhGFZBoOX$bF|&eb}L}^7CB^bE__=z9U4u=+xLli4!a-!HG8xaYA8% zc$jJTUSUVIrp_&%g$b$UA$G6cfu5!)3WPE!jqV~z!Oi&kQ1V=O8#x)|S}(RoOJ2)) z@(R7x0&Er+@7_S;WP*h_keWF(k>MQ}A)f?~@|8f$z`pEFE{B%gZXGR1W(vDzQV+8F zf(|D!?SgBE@lv*5X&Ix}!N?$-)tbUF=>ha6p#7T-9{B{{2XjuP?s_BMN^{Kz^zf|y z7i>jlo1x%fs0-rnGrC)qjqobqn?sR}N)SqQARL#&x&;6mEi!ds!jXT?xfRfu;7f5= zdfq;ANS$}id^th_IUrAI7J&bMO29?Taq7`{y_It~2wc(dD;}h;?Iz7-?`ZSpPdZDJ zs{X$19wkA}cV;mZt|RU`IoDd7zqsbe`T~DC<7btvGaHT>a3G#i`jq}fg8-l&kkx7_ zJ<_Bums)xWVxVLCtBSeRkkUDD91fhTc01Qb1o?~u8e*geapgG~WLe6HptD7%4 zg3*?EB1%{=1sLY#iK8GH)i4c#md7~fgll8wV))PjX;s34KCg$^Et{eouuN4$)i>Yr zLm|jE(gB3P02fzJQ~y8DJj~~kt8TkhSE^^>M^T+3T8(Ey2jCfsufo@Qx4}!2(Nw25 z3#F%dQ#+a}khet1+NB_>ULzY8jBwj=CnIG?0ll*pk2Jir%>|bI)a-Y(>c^Qn)K45v zchqhv|AwR&AIQfYBg^&>`*xcNJ{M;joVA-6!&rHhQ5?dNaFZRkvn zJ<=y{*Ed;40IS{u={g9X2rCBaTOdj()T_u6i!MV)_`-AxZg&=%^DP8j{n1QT&w9__ z=17!;vP6CP&&vw(gbEOy763Alc~hzXqAF7-VyK@TCotTMj6kKPU=kE%R6U6o3I1mh z2gWFm<##(-R6LB`tiY3ddDxcugVJ|OPbh2=oW^#daA?0O&2^7)2%_|t7DqrEmLi%w z52a0N+Ra$R7vvK&$YPZi7mRZeza;RsI`ggWH&!?LC4+7AUc6k-egc0Z$#LbE^I#M< zOiI}^{W~D{>6f8(F!b=F9*o0(AxogIQnf9zoK<#rT;@n!g#>B8lKwz?Kx%Y%m%`WT zY`mxqJfPJJ#7cqbFVR~v<&oRn2~>5tBe4h4eN%4Fq^_(jnQGKFKVvblc|Wdr=q?Hh z3tf3f80`H;|D?dB13KE`)>}(s@qU?Kloj4*97L3M%Trrii zjW{K;YdB8qyEwUtXGMSBz-NEv=TZTL=fgBYuk^${cs_d!B2@98jJWjnd+8M8<#B4? zSf^#m^pF@eQ1D40g8C4>Phm)G6#I9b!#vx2>cU9S{`II!4T31zTK%d}PS>orQ7VS{ z*?%`lh1I5(*P<63*Jw#Gx~7)1agc4c8q3)5ShPOD7$4lIt+)Mvc6=X9GO3|I4uTQb zB>O$o`}QXyC}|eGJAoPl9Sjgp8!vTpENC1#PZ@=W)1Miepe4y*@9W3}jjQlv*hzBRJ9~b~< zn+^n?c9Iq59^$DJBaGSn#;yQ5kR1CR(-N1WgUO(H`C&#<`h2~;h)>K$d<4h}mzrcH zFt^)apPR)I*zi(JfUT$X2{vZX21ya!TQ$hlCb(h3CJDN+y}QwOX{sSfJ+*3^&M4G$ zl{L|WRiCp;I~t&!nX@;Y7FR9PgP0%AkfF)1jEyB*I$+Dkn~^K@9H)rmP_9%Yl*=~b9#zWu(_p2tZOsi#r<^lb_Gn1fog3b8~8N&M^3kj`} z;~$>mBKQhM3uCkv#4tqbT`Zu(K8x%g+P#{0GHD@e>ib!$YALwbY3YTCDJ=N-er@=j zFNlTLccf9#`S;ztSW;ud?Q1A1*Ofy z+i%WyhKmsxBcrJ-jPp`s{60goiv=JL6uO~m;X@`SiS>24e^ag6*HSndw(4fTZ;JaY;G@DGivIy{>XiUI#(&Kb8@t&&3%6&Y0@wY2 z_299qKWV?~gfx89#>E`NmkK|1QQcn^%tRAGx~hJ0`71J*{sWY_$EP6IMv;j96D3>H zjr@6XSoD-mT9J*kSM>eq9^}I<;`@NN47p~sl|Q)e0~HuwC_pA}WZML`q0bt>;`*Ok zo>AskxuYzTM@ekqbUlTLMsl6mu3YhyINjFKU(-8JSLa~ytZp$2!7;wtqXRkG3MrwT zR)eSLqLKl_h1%SB&*9mZWQHDegcks6oA-qLbQQqh!#tr74Yz2#8is<%Ur(P~zSmsm|AE z^e<=V22-hyjli}&QTG1d;4=<`HaJ>6JPKAOeo2ewDz(|0S>%WTk9D=VwsgRned#Q2 zu@l@sLC!fWtaNth)fI$p5n0jZMFVkJp$1|a(A+Lzi{hQmX|HC46OAkQR*pRW98jHw zRdxSfPx9}trau1;=#{Wu5i)P-JG@RM`i#wyB1yN`=2hj`?K7@H{lL3J!Td1I^eh zqo67}lAYC6JkoQsih2r5eBCC^lzXNx-tl;bL%G*c6njb26ip?<{6dlNoaOWu)!g^V z<|IJtC~Gz#(uzUaJ|@rT2{{FgvPQ`e**7FwRKrO*PgBF7F>&>ESE%iJSPPI{mn^3F zdNHr0mIN|uS6c}ab5xz4G~U8}!F%fxpeRwc~N&!5^c>^@K$(c8=)d> z%oRrfX_G_HH#eKc2mEjVJ59pH!yV=%T!S4LDF5t&9Ut?&=sx}Axc&Xe^#_(s2&(8X93U? zmRIEDS`r3+?)LAHe!qz=hT_XG57)SA@AO2*LkxB3&qf$7`1xrzjoC~>2NuKuJ>FG|)K~31my{I1=}(kmYDh|8WGE6L{-W0S6cKLcFfV5;vz1*) zshZ|Uq($i$Rk%(%dvM+X-BKw#3-eH}tWlrlBxx}tKS_Z%rgjpwk<^_a&6CgC+C0kR zHsx*7Ce<@gx`9pF4-(Ysc01Z(r9XjxMZT!y<9av=E;SHTcn+I)Yo@HjL%@W`h#`6QO{XSR)QVBYPYe6xOl@P<(Ae}ZT#`iLe zeeSnZ|0OM+F>Ji@TEvU@D2OY@^Gv#=eGZWf(4ey9LEFqWrU+-|9Z($idbd7X;Z!HG z+engP!ei@LZwv+NTf&5Qu%k0&X1z}I@l&P4%I1G^JX=bEj2}2eSlvBzHHpR~&f zR&)%reZc14|G!f_G{C7n^ECdLlE5|lk0{Olg`#QdYtLl{FH~}jF22)^{tcyxyToGF zVc9k}M%}C=)Egj~EF#UddhY z%(G2%vFQh!{9e zu%fA>Fw}V)23Fk+&=1%z1k9I&Uk10x7V~i}W@Q@`y2^s9*tZeNM%yh-1-MUc;WOKW z+ME~}OxaJp(0v6@zv`=)pZ2K>%fL-Pvd*T1Ha(}_#g))qj#MaQYPFzWie2GnFPx(= z|7n7U$Ij`~Xw36flEFB_WFT=TIq~#W<7}a?zFOrYAh!}OzQM`ezP9&m%cB}RA!X^? z;i$$;Yf0e$N+KAMuXMVxh~ah`r>Fdqz$$2BeSr759b8n%S=azx?(&Psmo%K)E; zpsxoFW8468Y7en)Oxtj~`jr5EtwpF$`SS&iI;da(b49Uqp;Kn~IKF*PCUfTP;av_Y z3>&n?8t%?c6Zi$F#^ESIK?{}Gaf1y+#0xvUdI!uvQ8qCv!3i9$7!UkV7-e**39G{_LIHF9-oypI$79^jK1fvn{==83Vf!p% zj$B`}Vjife^~Yt(%e&uFe_W$yBC_Pw6V!{ocJD$Af2J~xs%n_}R@^xS#Zn0n^H0@u zVAlG<>sLM|LRl!dI^OWgAJp#A*N+Y%0mXmmPH810*$oDVt}XOcRA}&-i`!*c^U#m1 zq6@$!)W`qdKDfd)x*kfH(@R(#bZ-L~(x|_5MBTeERP{n$DbNpPAAZ zMAT#m#50GBS9#ZccmDsW6DC93jr2CP@1@!Q{sOmtepHy%@ZIn_f7RjJw^pHGLQ_KX zHZd3GemyvVW;gT8DRbKJu$%OY2|y$g#fcWUKQ;-iHeotULj4n#E9TshTZQ2d{NrYT zPCVfjhC`C+-`N&@_T=ZKv(;!>F^wB%A4SI>?)YW{&R4L|ovH!*WI1?Y|iF}Eo)jNj2FOh79{skV0tTJN&Ss`8B+@Bn*ebbe&i#*oR{E%JI(v;eK4OK&7O`_qh~;F|8BP)Z z-&6y`s*xhx`S#`V^t;mS(r}He&jxw5zMXt4Xpg2w%g^F_`bb4=m0y$Mt5-3~DIISV z*y9~8YEa(Pw!#d2P9kDF2kP@ef2Fr1Kbd;Y`6-V-<^#Gqo7FbSfxPSIG$b9ko6IB< z(pgn!;+U-c>h?a@?3m_~p9!*sd+t~tTaHMTR&Uso?gVfHmy|22LxfoDfUUDN@)7_S z%NN5Z_x16-I`jO*tsf)6qN5$RWCHT>VHYs8ER{ro>~HzB;8P?HLj#^?Ni9H?82r*W zllD}rtdTd3476UYT02JEZCjz?q!oW8AFV=QI24m$;e zkhJUsmyTYl*a*KYeY<#E-<^Z{{^Y4vzxtd3Gtn=5C&+MJ7-QEhiEol763n3EjU4|D zT>l@Jg{xS~Z&SqOLsOJ(Ro&hA^B0j2z*od;qBa-|<2&i>ZrGttWdzaEBv@j&Z;ZKB zftr_HkWvYpZtcbUIBKH4PK)u(EybQp%As`9d{-0Z>I;Az;5)XJX|n#~>B-wGp^&r6 z$7(??0}2DC&Xvk)$-bSUAdLN3`?5FS+^6c(_J5hJ{xVeWX`|%J9(?DSdsBh4k|oyH zEeDmPAM9$f8lHhCSX{9}wEu2Oj0+)!+ zrutRF)>QdfNq0!KR)#96m&~O;jET3JF0#R>2^CY^kLg@)m53tDuT5~?%i<{*WJ+vj zGh#(4oFd`fu2`s&TgfKO$R<(JQ6>6sskJ=FqKMo!0ET?&vT&qGYgT<#OMqQkGO%0# zXB}wSHjzxmcl8C`b?so1MaRUQ;(6bISo}Tt8)}8hc)FN1F>@9Tf9io32I=LNcpTvw z%{_SvrjFT1QCf2G>fCSA5Uo_Q<-Cg37zPd>HO6ha#D{iaw6^aPQg<%l1rJfa{x8-5X=l;ZQ-FJd<4TQrL;7(jky?(EV5>tft zrzT_qG@zK*PGv)p_sbi!**BNu_oV9Y28n<&yH0P%_>y5nAPLng5F0jGcw)4Il;_sT zr8kYfwk2x2GH)HHGEz`?PvNm9Cha37w%#QHf_BL9W>kACLd*|pchesns%M&RfgAy` z6!qml9#a=5SkZd|l z&+|LZV(oQQ#v55EBGRsRYhKtIDKSHW&K>yNQ* zJOnUf^@K&~shLs1l~IlS$Ra&P|M4G-ylc>RJRg`5=Hg_Aq!7g=yAWCB&-#MSc(qDj z7(H|n>v1dNv3{)_3Y7`HEhNPTE>aMv@WgTOX6sV8y3{1^Nlxa+-MQf0B4~}oShWiQ zW71Pxr8wJpUk5j9()tsV%R)I1y1TOZgJjY>nBVf6_BTG zVB7cRU}W2<*p~(I?c4~$J%8Iy3%a(8Myo(}IyN{OfnR}V=eZe2^3=Ei)y)P(rgJXM zCoN0SzaD}?K&slc`&t9L_~OTAR$P0`2qwaYOkRVbj~&=@Xfsij0F3P^RX!~4zyclR zbqd$M#{kYjc~8Owz9{S3-waV1y9sZ(I3Eny)|dhb-YEK6C{h53#dPr!C>O?Xe7P*U6q;sU6H{y5%)ZW>|V&tPvPn-z+E- zih52I)W&b>e2)ENlMYKso|49H%i3G6rc)%Y?yB<#B^%^~jzs|;nHi0$)4;8?VK*}P zXCG~6OBL+I($jRmN9f`ET;RxC75IcnEos4O$Gbi4;%aQrD?kk~&6t&YhJ?2Y!|N#x0wnYTx82as~Y zQ=kjGdNnaj*O^M=9vS5F)={U*T#C~PD%EE$G0Evfvk2SyYp)v?G029@ZOMUL7{G#w z<8vVAlON9%RjVbn9e7n-`?IDpbLkh(Ri2LeKi2~*4LwH^0S+lvUBP5R-Gy_HgFfD8 z?otlji(||hMAH2B8k9FIjW?ApUe<$)C2s#GAus7|ZFB^^KpcRRpL&cE)57eJsiJ}p zTNt-^b)2d6sXX(C)$V=8tEm5s{A!<|v^J*0g2rDpb_Vl_%m8f@qo^pAfCwt$!${7F zLjs)Y4V7A#=F$1Sbqd9U>k0juXl-Vy36@VIpO5hInZa9iZYAnWs>iTa!m{LQbpcp_ zvuBi=w#Fsu!iE;uYq%H$@wi=5cSU1a5|M?e{Kl7H>K})J000kWL7s+Wltf%B{{R3#idI+yPSX_nI?T{T zcqzdDpY(ZP074_J1Zwp`H-$evS76Ws0m74}NhSVs@w_A1coiiMngB8b17bQj@&3pR z@sh`!Q>*eJ2+AR%d!zfl8c?1vS_aoX%K!y*ti7kLAi`(}Db6#c^*1$2A)vS_wy|rc zLhnSsh)Osytn3w1<67LFzQG3=r|_`GyE5j4gDpm)gXgHxjWO)yVuY7DIY4B^dwQ-O z5k;Ag^hP4%=}nQ}7I?0Q44vK;`WP(LJvEDL<1<+}r3r$`PBXshWv|7fT_?AH1pgDL@)LrlGpk}7Iw#3e= z8G0f`nz~8Q_Sun%A660*QCjiWn1)Y{swOggNwzk>E?mUhX7U6PrJ73N6y8@nIvRmr z6MI=yv1n61LWWq0GO`E#9YS}H96YDYM^*ua_aoG_8VdimAj&aPgGwI|nL=y5CPmXJ z%urByeB2dwTJd7yqY{3#=QfyNm7w(PXP+GOUskp77Yo*N|F3i&Ibp&?I~n)C?d)f9 zzemaApwgz@5q?WQ7!23`|F2PYlRb8iYz#fYsppT6^4VyRr{3w|fF$tghzHC>y?fFu z1G@c-h0s%tp^kPYGYap0y#gVNot!~`vHuwW1B>u=)MhND&J<}(6z*O0BL`zfwQjer zS~i%lV98r1hTe88k&d0 zEG7q`G=M^nTj!TG-a$$$(A$GuWt+KbV=nKqDuyw=8y^W5)lN~$f554TZXCRuLz4mw zVALV5ON(Rzc9&@T@U@=UUt}7bvXR)(&xomm_LLoYmRzJlZFqT+LD*S{Hod1*c$**f z>xkr{@Bjb<0n_x=yoaus?8M0J@#W4FJh!XiwKw4zDt(KBv!^SXF_z+nO-TQ=R21}( zSJr+um-rxEF`a}(QRaG%$Kxx5yW$HZWUaA$*~Y!xu&fNLAd>sYM54bXyZPN12&y8t zafAA6-Ht?0b|m$CWgnkAN^nZ)hv|zU7j%Ue!P0;wa<}_2kz#Jy&&Bc;ez+td2{xf9 zx;5P*`3^5l#>30|JmV+6!#mF2E5YM7a_Dt^Zj9=Ftnso&1UCe2NU!GW1Z=RpXjk(3ich&+JXq|f|Np(Dy7&KMDIwYt|?K0UR_hLUFv#*PIcbMZbY&lCjCH|h;NK6Wli}MOVV6KBc}OF zv#*1+-brDHj?xCG<9@Ml4Zt?;tBjwrO5>$f{z0d^bGVqOF5u|Hj_B{27Kq_$DJu)W zj|eP>u00a4DA7?SKfyDtt zBfamhdI{g~B3Tjj9GwuLKNxIA(njTH-U-1YD&4#c5lXjw(IP~?TRO7)B`Ekg)MQ&c zMvH|4&TlDB_IZ1ERK#Ylmph_R1W%i+7D2FnqSwp*O=FZsX?Gv_3hnnHI(-P#uvRs! z5Y*u1zzj~91$t#?-8ZyBC?E|IxNvyRbF}t@;vHjyLvW>!091gs^$5z)r)0ti{BHpA zkt!-&L?L?VP>*g>Dg$Bjv=Cg>#%#&i-^|innztLRd9zxgKoVDv&zQcJ#zq`RH8KIC zO#D-0XTTFOKHLV3xVpB0&ZQ?i?-Iq*bi)#M-*D;4z@u?RKoxYwSJ%Z?r9+Pn>i$Z2$uK`9W~ueqEyRF|*@6&krV$HP)4 z&V+Ufk`=NG&k#*qnw9JHj*0_PN|Qpb>w6O$MHKCGJq)ZH8L!1UfvLgs6yFXVd#mdGFr-$i;lQqe*N51H06$@NPBto#h)7l3HqTZBeaWu0oBzR zjA6|kl=$SI|0TFUx4_?Ug#192&g=K+T>^{xj-Iu{b)~1)`?GM&OAqHM+Lxt28%>tj zW_j-_d$`#ElWnwT6$6r9Pg=L?R$9D>^k;)cd7qOegq5ER?{L;FBe|4bCMusSvE~A*^HCvx?r*?|%+{;+AuuGxmnufEGE}8i#E_GChSMEQY=t4kW!Z5CY0#M}7 z)Wa9B%L7T0FE_*H&tZdEcN(m`5Ve1K&vz6H;T8VK4kQt~kI2yP|iveajFaFHtJnwINVJ>#)8lqjpSw5b9FLBp<%0WB-Ua;H`}3W19F;&% zX=-9^deW5Orkz@jaE6?zatuav^+~en6GX4JdiVtAZOK`%--T8_5WLk)k<|^`u4{PQ zDbD_HcK?AJ^-K^Z^-PZ07B><2WtPkd770qW%?oe=a@MXkFEWL^sXh*)sn+l(?J{$( z?Y?2}w#fZe-YfE33D@Hjc8pwuj56@eo>2UVMv2Kr0>M~AX}^X z7lbC)1%@%eJAQ7ymsFjBSb1JbRYM%A$>J^nN<0;pP?xsp8bue9SgzWpNd2V7sOn7o zi*KRuxhb4XZuaA+pShsUB|>?x=;VkOc+-Gmyb;BB63OcYkrPrCEmZ^ zytV3GLSPf*Qx;MH_>9bgNcDoqqCzHkc9y47)V?>kpj=>UbN%k|@g8r7_-hLdjhth) zZ#nkQh!RTSYU~w<&Xt$b4GA3hqk14${hRg5FW^ie!fZdz+B8EHX&^Pv_xM|W&L6xT zAv!ABpe5JqjrV1FuC?@6Q=0;x8@&+%TfbbOGB#3v6c?|t5H>|#UxK@{Y$2iVqZ6=a zt_DLAk`WRm-c31s3QtW~y|E_mAJ@C3%1w}@n3Bxpc9%b0pHdcoW|CH7B=EuIpaVll z;?XaNdkCA@BQ$N*C+Vp+o|2X*hc)Y(!00#vT_6n<+W-HY+ekd>IjH3rfmZ3`hx>9IBLBmMXa3E-h|OcY z*kDc`P1`nEeI0+nw;-(D1)?U?lWYy6+=r>DZ85Z`&dJfbPUj%?!|L1eZKs7QqnVc+ zL}6s4R=V5@Tp~@!O7y9Dn?@$aek}v3E6u&!twnu}QRx!%{qqG}jd;1nCB$>-lrIjh zT((R2Wy|}HzFtns#qSRdI=Rrv0Y%&k86&3+2|9^S1ppN9s&Gs`(t1MEb38qT zbVP`^Y)omx`L3<7P>cc4rgN^RkGGxNR>khgfIqBuMDIRusfmqNewn%LK5G(a)@Seu zahwuTUjQy0cfeixq3ZvVDuW$*24{kPmqfUKIlI;NQ&*3>LuwCO^5CzX@}%>Em%lsT zFz9v1_M~q~dgOAHKovr%CQ|C$Y@}B^=XU-UL8(c5=>+jPx)Q@sj)s2Sv7|xA`*DuU za^&m7#pAq7w;-%($!q4j7{>agfTYFNslZrK(92Eab|9Zlw#8aFwv2H)NTM@S3AVZh zTrT@;)D+|&hrSPeD{~lb|D*Rf@8lR8_o-4ngXWQ}f3NAX@?Wr~fl>aCd_+EOb8pl!_9W+)!AbYzLY^dl>@j53UX0e0P0pn1Fb2aqiNdwOA| zlml@VOAVe!7U1WUwj+=LzP(?jX9$KYuhRV~ZV>e&7Po!so@5M)fB^+)c3scD3l^eA z^G+aQFgHV&$Lneo=i)x0`YxGE(H^Go(EKFI)piOwvX2(AjRWl+N9tn;zGX7DF1 zP79}tN+2^Vs~79v1U}+6(o+~lxeMqqylfsNG!^L-S>TU>MVFZ@yv;kcTfE!0RX9#v zr;Eds>_F9&j?|9GE1Z(4%nfd}{B}wCiy;?9F#cW^b)oTz@UgiaeWPUJ^kVzVFg;DX zn*da~EgXy#P=3}5EvPQ>K`=zVl3z=Tu&hdVzZcE{JT@?2AbEp%#`PR_CBSmPz~nnn z8N#TTu3A+J1h&26OC7utB$kA*eBsU%YNJcCNMo)_aS|O-oH&XgF7#Ni&*k5>!e91_ z_I?`aAK)xp4hrDeG$Q?S*%}!3jSAx9eRc^OMMI~&}2kM+<#Qxu) zcSH%bZD{va7VYroksjNaQ-%bWuc&l?O*^GpQZDu3`gE!Kii*7O(cfE-FiPnz%rZqq z{MmrHb^Eo%jD{6cY9G@jWix3FOlW(bGKJMD$PKh8C@70q;eWPruVQ}Lo(Z-w_?H_27etE(HBW6Aj;e4> z;@(=ig-QV50(My6ZG1obfP%Tz-P12FjbU94*EOe6e21qn%@i)d`Weg)V*5!Op{nyR zktw}+N^d*TexHA0aLYj#0TgkMSs(HOnCZ?Z*smHdYC5kZ<6zM-eTCn_j=a`%gv)1Q zpS#l>29Jt#D)vir^=uGz0giC|ZXvE+KWV9sMAjTjSCHy{DJ;m^Yi=@GJsrTrWeG&o#Py>S%VGeJvbrqODz zZ-7y}P}}H4Bv^8$20Tvrna|m)f)D}$Q#u2SNTQB=b#=Am?lCx&KUx8mx5N&C&vN{> zqUQy1Ick?Qb|R*AHhotE4R{ZVHO*C<67`;(A#yNjg%IyK(|qnPwX6j$wQh20i%gh`x6g=3iU?KUD% z*cSF6yZm&MZ9=iH*%V&5HQl%(O4N(5+d~0!#d%N0;t+gK@pT|7Ozze3oKl&sOPsN5 zuCJVY?bj3)@<;y$3wO6q6H5fC$>vbQxqIV*5W+7N@nQE{f&iX#OIgXoWE?Pjih|Yn z+5&=wk6h(hgF8KSRG=QT6mX^L_tT0fV6RZ%mC+|62~JUaKN5-(2)>H!hsdyf*wfNi zOi{|l!WIGIUhAA3C;AI9)&;60a9~Bi?>e0UAt0rknHi4Jr8oXm9W<>ZM8}S6Cj8tYwsDAcNZGds)@3E;MRh!B^uJNEQT zY#qxcy-=aR)2sjjeWmNgr79cakm4?A5NKzMUCwk)w+KxAl)B=)?p2KLCes`GEo!Up z8zB!Ne>0r7ojp$vaB0HZ60JmGdtU$j38A(0q0CuhM2hjwo1rW8iYlDG>HqF-0NI0w)|2wsww^B%6!%u1Ba`PZrmo->9kRV!q?#_;H{6 zKIY+0SS`46S#@1%ovdt5y)!~rD>6Xse*Z*)%ib|Kq4ldO}#HI0-nv7wnJgfu^y;g|@irAq3SDX5`7`wa12u2A{; zY?n{_0{1-u%uETYb=s5&t#6j@bex>m2W}q_^1GHr)!(KZ>xw8vqm-FJyuvYp%@^5q zt2YWwX;pRkigKK-L?7Ax8D=D^hq@O~Q#$dilm>1-QvTviwK32nUnboNRKn|TguQCx z1*8ATIX@de38hRSnI>Pw=U)14Znh5mZ2?QfKTYeVR#=1scPLo0f1qeh;~iimUuPLb z^nxv@)D}0se7)R7kM=Kama)oQVrc-9lMMOJP1(wzq!c5I*0xr9aZ%+B;n4tz9U(4| z>u>c0J)Wjc&cJ1#lgIaMuHIj2a_3@O!cLKk4us%TDvP{p>HL_zY!HIjEhK2wz{v8y zxDcM*AW7GmMxlwzZjivH5d>f-U>=G{dc2!V+eRRD+YQR4;d_NMa6km%fB#A9@F6UD za2j2+=AyC25nJ5!SUfmY0TG+-M7pP)H@z0zZmSPC-@qK=eWc?Vl~KSsQPR7SHIcCO zs+cCW;%=9lHn5(i1&-a{0whx=*OXgPJrwQ<63E}YyCvWX^qHeLG?#D?131D1olK)3ikujdoWb^)T{V`OXn@BAafi;ZR87Rx+J0ziu2y>?t zv3W-7P>n*aU>|W;@O2VrcU~jWGuTY(R;HZ}%-!m7pLF-l$H&I})4-8Uv~CI}PL!isjWupO zrm+tFz3GuD797R0Mk<9SZKqa0!0XWZN^X|_j{DI~iqSu}o?ChjPw{%nZGaFD!N3;B z>;ci#$tWU54i|~9Amc4C%WPkck0 zJD=URcEf^@``as}{U!mh z+NG@)o=FCGYaO`Yj?PySxpF4eKb78dM}`YcFMP)+h#Q(`2}=|h5^8f+=R+g?p(FJB zm130A<9DV6me6VSgt z^}6uXJEoodSgokZz>+=my6LPOq=# z)3GdMKSLtPs{GKH!G4Sn$$Z`Q+o)I`2(2qN;wNaltUx_ptrG2+*Pii;EPB*KkoS%N z8iv|~qk4Y!fkK>~PzFNaFm1tLIAzAF?|I>1iQbm7xB<=$E%6}W_t1vtTCIaUQ5Qn6 z`C87f%+s3U|r*|GdvF$7F-bvG(}7VzAhpBnfg9bJqqGUq%LJlKmY(6ltG%T zH3%)KGMEH6|Ng2~000gC|%b*aaYF-&w~5lJ5?fgZDP-ZNB&q6Ra=#!ziUg2 zZ62l4acu}Z<|(Rb&B*}h?1CILEhR{(U-s6;?R1^aIr$-d?p`dCEj^#UHrszYuC95- zo=F#<>V8B4V`h?Z6oAzUIkyOLRyALuX_0G?yMwj5ffjqF2y_Ko85HVO5unE(ls0)3 z#L^>jrDZ8qL@mWPo`>AGTKoSfh%;OeHf(IRB>F{tzuD$Ec2!}mJHkEx#tQ*Y%AbFH z8;PZECLoYj`X6r+#fn(otlV4)4YxXCvHTr_Scy2nWY3U&mqRlfU&~h(BlizKFvwS@ zM``ZJZs!C+&5rL54bi^#+p$@D??@RcD9GMZEwrIbL%{Qx99KWoPOMAa3Z(NwS=fpx z?9034q*5M^r&q0fV0SbqRkjS8Aj)?q7GvG|N=*c%*_$Q!L%)pAlJg znw}s>eZ_ueA?x3jJBxWh^a|r@Smm}Npi^)9Za@izXF+;U5^HIGqEz7kP<=cB&c zBQM}}HH6D&3uzNMLEMzH%RG?%L)xh{4L(!#b)!E&fGSo+9XtDyQkWlKdn+s~M)bt@))iuJ9h)kdePbO8Vut+~SMu1V&_n^7+Ux??r%2B+y`{Mk)VRHgqb45=R zQ1gvBc$hEkbT%<%miKAA8s38@jQROlZ#(8F0dRCnWeff|02QL&mfzyf7KG|gi08D5 z?Gg7A)`tZn;aO6#a z4g1uh{-8(gIQY2AIG%$7PxwjMFl&U$gPVNP>ibl;K2nBetd5XV*!gVm1jF7Yf z6~|rE7T{3+|7mx7t#SJSdKM2#@QEC&$nM_sUM+c7OZ-N`V?I}4=46xrCfbP#4pvSu zV-G{wtiw$h6XB^J;g9sq=H(qBv(7BIW5A}f#mJ8aLGq3kSCPKC%`It}>atk+l4|vF z>l$@{HO;CMdROjo@R6r?X5}?t-&CvXKkKbMUM>C#fJ7-Je_BD5(D;I;&dHB+TcULs zr+o&#f<68}fNJ-VF6q@80B_a*{7$n5DK5rqbSMY_0}@rMSZS>J#l9im=SD#%p+x*; zs1useA+8G?ydc2UzyMVy*hAR*3XTa+SNN>|3FY{m76!i`=5YnotncS`qlLaT!NtI- z${r7FK%dSRfQ=3z%U%=w)zT!-dPpjwIe4l*>=<7R)__u$BzxtSoFZ+pObocn++OqB z>_zEdKXDgFDL;Z7Cz%I8jP`=Q)rGgHK1@kPGwWSWCOq zqW;rlt8|5cV}kU=ZbPv3HYG`A@4X`OaMaLff5e_?*QMhc2`@%1?ppBB>46NNJI7DujhmKeimThRs{S~_6l$4 zGb9F)C=YYR#W6{mv5O$D4HIZSr$Pe*m3ki0TddyxD(D_xr}Eq+1Or?ujLu>en$|c( zvpcJ__bODPT212it?M>8eVh zn&}6Vj}A2(j!djkX+`8Z1)ytNlNc!90_Vg&5)s3>Ph=_On=O`%G)j1PS>s^gDeJhe zLoF*GSJ0I=#SJF4=V^9b$dJ-680gQgO>ZNv&y@7gH9U?ujF6sKCKF|pB+%B~3!0pmAx8f`Qd%$I*q?HPGEl7W*;~{c9yC5X#iPCo+mNA1U zQ!AH)>sAa_`0GbR$3vw$_)qW&M|R^;>cg8nWsWu`b_JeIw+KIQ&~X~! zq}Fl^d=)E+@Nm10T$F>oEO|55UE}Wj!BZ5CqtNGyZXkYAfIh0S{dA8K9viX$q(75o zd3)*Bocs{yptx_MxK^;%*lVQ41$IR#vdVU$90}xvXx{x{$m&hhCOr*Wd?-u#koJ&k zQynhg8lrMrW5p}Uy2~zy(eXtdO5?o;k|eTZB9JR=uHDr=v9GY50)h|pLIeSa&rTjQ1QfVBQD zwK+{Y;i&77tYz?wN|v3KC7WQTO3wFTFinfft~jP56Z;Ln3R$oE#>a50M6@b; z-t9{ROaRWCOt;s|PE>TO__V`u+;9(${e|5oHvhWeA^q23b9`UakaLLhnkorTN_5fx zarQq4v7(%E+kM}-bQSD|U2>Chpa9d2>6(^Si zIx|bO<7Iijy15ecyZz<8w#fX3LV44AxIrV667`5=1x`876a#K=#H5-6nGrFKMLrn$ z_cj|sQ>7q1&sV35*s?bGq&;bOJfXPifAY|cBI@jA0HYZGD?h)TuOt* zGp@~j3Gl*$`mFM^BPDJoH`lFO#|o97M?hRhV1pw)^x1XC>jex@0O8sqj~~Rge}>&bT1pbRylubPS}(vIPuNOKp~7ugD`@J zzN*x-|Aag)=^bF2#pgNCZ2nCFl5WMZK2#SDWOJ|yXs&ap3n4y1gtPCum3Q~~@M{RU zkO~#}LW*r!LWylpMG`R8hP1j-Iu&HYjvZiG@EZvK)|j)=_PW<#UJgl(wxsK5C+}2e+(!LvuemP+c0Z4O3nba`QjofSOq|d>sRICu3hP<$)j#e7^uCxEi{ zYe0oZ<;6SegmUJ$gViPCZmH@przt)~J-!Y?-*m7`pu72ug8yb5Py@Lq!#^YA<@{*%m=tL-#-)*JvIyZkaSfUB&MX_tJt%!8a4N~%mW<$ zL)*V!Gx|?`GmKZWN6jav|nHeB=oPvfB(<<60@0_B(#5nq3KT4_&xz)EcH*) zem$GSLkgm@c0}q>HOqG@39`yIRorc%#h}!V3^RgnrWJiz`sCo!*SzZ9fA7j_!}4^C z`y~1tQyoYsxq#M}qy$=uJY%BC?**F0Ycy0QUS@{^z7t4jXZOG0 z?<&Dw&Dp?Q0af8maZIkws^Bm$l(H7Cdm7@HS96U!ds2RH~Y zkPDUdPyz8qcnh0>aeT~lP4-uDkwk%r;7`#4);kmR$tcrJu4(-{fv+M(lhIXWS7Cit z=)`;P&MD>_XwYe{1ba1j7sA89Puc)zte?3eQQ$g(2OGM;FeRN648CM&NPj{{EzR!; z^#t2|cke8P+&yuiC$yV=j$o|2hO<$DuH#+Mb0t_>EjJ)JE2q)Cw4JT`6 zJ64JF$~mHfdMF?p3i9w&4^1-+*kt9Leju+}%11C%VQ1+X>^OQm4l_H1SfeQ~| z?_!4S_SfUZLve0t@E${vV~Y!ni=MzfCS^8c{>Bbzibu!?fQP)%sewx%Z#)?BjLla@ zdW1;RMHg}|a=GJXZH|4`s9TpzNMjjE1GA8voa!Iw&MYgC9JA{VQb4YOY_Mze-A(ka z`)3MMl~17rF)Eb_u5uQbJ5D2CVfy(pq{}_7el`VwplD@ns`&CUr8uYe;haC`<=ds= z<=q&U@~wZw1h#ZPb@d_Q?QLy>H`v(w<45rbb}Qfi*gnQ5xF-8V(Y6om4c_|}wIJ{& zM0{v(yDCG4bLPOoj`7S&v$+A^1-6=(7>fm`%}kGA!2p9w?9?(^9+y;h*5ySfHp>GO zXtbd67Kn&ajARJb|9y`>y~>G)M2E1C3b5{5g}X>meeus&jQY1=JQ%bv(YN0p9<c8$^w5k25Y%dxN%LPZgQCJu%jye3idzwJA;z`UL6H}Uz#O^ z@0uDBRa4`WRq~?cT{;0c=N~@jPkH>Pgj98SN_-^bO#(Z5O;-z2gw{2so>o@xq!o|# zJRpLjzCG>{3M@J=Kf`LTu@0w~i~OhK|L4zSAqM%l&;^E}^KN8^Mb+N2;&YeIr3}Y9 zed<2>lr27cRHG#**PKdvmiM28PUEP~)c*+#C@F3{QK!7`1ew9DlsIfnb9W0#=-oVa zsujLWRbrn>4Fh0@zlq{ZARqXcIp;2uPkt z>&!X9q^?0dStvx?B|v(cRiG#96=pNkX}xw(q`O*D7OjB8J|8HVycgjXq6LeYXA_0H zm`7VYBOPH!ty)aGMIgPchQ=@}m>XM-2{(WT^zun{DX#IFt-I)o0%P4~avxkqtx4s& z8HS6*QHW4@3epUU_;dH$Z(8*1Lk?_$h_^ z@RVHGgKtM@#%^^3=eZ5s8zVC+%eN(TR73(e z{+d5%b#KL|^IRrTS3O=DX}!rbg}}rI*5D!wywe-2!$Wp`imb5YLtnNGQTW^2sv0#d z+gL^($1;j`IV$74(bb&?UcJs`n}Ad_G}y(*lOwBCWsIK!{nXVxR6uYQ#G-x)%xluxE$oaUb3IiU-2QmZQb-#A=qhiGyJetKXv3mYdZTh5MSv4;jS5JN9Og#^U7ISQL&jq@?$o%Mj5&dSMQ^;=FSQYQMDC<^lE zosz~OFuCXJJ`rqraR}vX4S*BQU<85w4&eDQXf!BOw)OSNUWE%ZW-fqz+Uwr=;J_zl z&-WH<`VCjt;Rs9zd>9p`=lA`@&11A;<>>vMtY)Js9U#M^9oCWby`zDXGf4v-fSCZDP#gy`vz=eZp+4nslh|m~BC?{67&ghHb!m2a$Qkyf|P(~LH zHbK|lWnJq>Lp8zsgSjS;!40T1mN`6C46FnXv33?QQI|v3J=BO<+}ro% z;4iCgU2MLq3??SntM=G1c8oaIXikW6vzt2gafd|5VZD%vS(rZiSw+*PUI5%Q&*yEv zyz9R)TVvbckQ`#^NMZKi7?XBFC~I$l8q18rPS0~aLfXEo*)32~b5gTGcADNGB|pQsymriVHn+HUEpjNfl+!>OmKZBM*DF7VHUWcTW>zryADOq;{GP0nvEr z*N6uf1|KhjaNzU(9#Cxa+T6p^3}iW?xY|^KtnkF?jkgG6oO<%Z1X0R;~xi~x&53?w~kD+ZcOG%LPL$BfQ>!2+^ z{%*LYeV2l7+o83@@z)7$mr8r?clx9Czmu>({bzRFhh);jA|1&myT4#RFu69fB4Cm0 zqjG)!==Roo#$xJbDlCZ7F!b;bsvn7fCB~7%Q2J9+$ym4}+L?_pB9fqAGNYyT{wy?# z^`+iy&1tfm6IzU(5(4+3oADBEY~WB^t#_DXug}rFRw&EZ>~%56eBb|V`T>jY=!hew z?C@NWAe@qPz&@pyRq#IVLhl)I%i4BE`TsQBk+^~J?i0>eaA%ei5zmROeYzCx+x z;AbbkSu&eTuXgUA40t^0{ z+lr<{B@vI}7bD(h@0sdQ@SJuSWew$-gf}u~7J{WU<24XJ#ox&zS3}hho^WPBECM|8 zW3g*HkpA6mY6S;mDxRjnJV`J39l^#Xy<4GqJ(wHmO-W`^FT3(PnawdeEHW1z(VnYf zw-dwct=FW-$0%d*!nS{~J!Gj;v~6Oq%Nu-FRS)?qj~#`Ty9N+K!Ma=-F7JCJGw(fY zy@x6~4*fCe3nn!k~Nyu(P`sN7ed?Z^D8?_2c;c-i z2V+spM1*%ws;f0b%(Q)!Kt

OHUM@FysxiPCthHSaUbT)6PxSUU1T*8?N! zQSoJq3Y~KKrdk(JspO+B;hxSUSME=Ln%-uqtJgwY){} zX7DZV(#)vKyoaY3i%9vD@qrJbG$4TTPqj&lduFzwpB@2|5)b5ri4On(48uX5%4C#8 zTr2+o06&UWSOZP&8WOL+gIkglt2LuRj3bw67XIC3=#$KFD6@bM{W966qWo4 zpzaomBF%m@0J6E7bQ)91zd>BS4;~x*7oA0;V#i3zSPALDM{`dzKjj#6g@$!)1-m0n zT=&!f2{ipHA!XcjqPGex6V9E@$v$Xn&X??fF&dCfVs2(@*f0!OEY`*IGki2jL{+z& zJ9t4^?9toch+Fnd1-|D>Ja%YY0RR*7XfN_$i4X_@;UK-qGL48N=OhqP z+QL8{&G`v;SzTD578l@P%*>iDg{DKrb1NFS1LMGXkoy2eq!W_~jG-;sksJ}zZFSFN zY{h7ITe3}LDLbR}F6kr~>57Pj}m>k7QSG>jWCG+4E#nPU>wJS*qhX_l9 zh*0_Y7u*foNNbIMt`P-3DAo_y>c>b{k&+uO@4jvK#7*sy>fw$N;Q!IUpQR!WcU*%6^*F9)Hiyz zfegw}fAol(A@3itici=_)Vslm9A{%EYSFs$IbbLPw&x8qbI_0q23rgA{>^AscO4kW z$-j+td+=A4rY|HHW$+VqH+nUTZ2jpmaMJjn513SekCwQE89f5rm?{HLWz<#m- z|B8r3Ziwui0||%-YPlNwT2wDVt?xShJ=5KgI)2q0PEI?y_rkB>1S5%5;h{?}?kkJk zj+S;XwN~X6;&Kfr@*4>+WXFNfFV*EI0S<1tLJY@|0V+9v?z+0*>+Q}p8poKZFLA_B zm>tAK7WF*Kq0kqK&&l+5Hvlu?3;9i^JvLrrh$=Zja8>Lmbu(d0%~eN4-M`^S3))%* z+26miMN9I)Ler1UNONg(1g*SuDNaeA%Wi4i27isH#Q?wIZ?qIv39p!@wk!n*-pxwh z!R5pyPSt~Z@}eCGO_HNO`QAXFvBNL|l|L;r?rn+BhTQFO*KQ0BW|VU71H^_W(~F7^8orNVyC?Ym3T z=0V7Sn}q0bh@lXp*I82y-nc*h-!~}~pf9{{Jl=@v7^+5@O#J6goQ*P}w@Y1NdW2s3hLh zhNtz7o>^U}BhRfxO}__{!0;YNIJ#tm^Z=<`W?zGwDB%X_FFpE)`DI9=;1VD)^{y%` zM#LM0dp%<;EjP{bn>W5trpVaI5AELD!#MIO$DN*XR}<}=Nk5nDE}0pODz>}SW3m+p zl7t$ZoSTOtLP%^Vl3zM&0y7M%;7P*Y_9JMU41T8iieVUZWGVi=TPjZ6DV{HMh7o7U zQ)d1CxuB@0pgSgeH?`#Nc5*$$d7v}_Ile$rX>N~@oXw{GeXuLeE{e`YbT(VO4NARtPQ#J_C2twJY-@HAQOWR?JU>%D@Zb_GYaS$Ss~BC!FYl|pmu0uDc;$12+{`^p{T4ERi{Ot zq=WIlEhx0b<7~q0dz9QmFqgJk2|7KR(D=)>Y+&Th2txpb3LJUv*E1E;a7OZrV#1|? z0K+nm3-h{|F)Ps?UjJxA7G9kilxb9lcN6{ENt@#utncQm_>O_*!cwu%?G2z5gC=SR0%aY@u@^?eFlr z0G6u*51_!gOt^ORZ2~s6HVBuhoF-==>G^NgfGdKL_Jn}7Mw)ZXN#H( zgd~)C^j>obIQg=RQ|LaP>10-c{wu2?4!RZhFEu|UN_iSh!my;4bJxI#$;RaMc1+<3 z9SR$4g*x)0K)-U<03K9X@++CTG9Ph>-x7&%cjb~~QRUn?!Y_k`Y>I!QxyGZ;I?&t& zkDdD@Y>=}+c#JQ1k8X#5@U;4lR&U@s=M5VvKFDB%^E6oi^}yyMHSKC}f9)?Tcn1^M zS_2cB5y*2I#Q$Hgkb-V^^tP2#$o@MmArc!%t4a9q-Np17li?1P^~`LMj|`On=f zE_dXEr}w+bB(J*p9~rNtyy%CwqDQZ8*E|I^Q7wmi@`nfofb6nJMCu0y4D*H|HUkod z(novh-n?gG6!LWgaB>|-*3)KAcyi&rwjjMER}0B5_4U+;E~Q^d*P=aAE-WoC6!7Xd zB$yg?y^hiajtF_5F3KUKMa zx@v3d0v^?&T<>h)s?v`529DMUgcA^{7ZHyeFuZ&PlxfP-T}e|Pa#0(MKy?~`DT}rF z96T5JiMKO~0FPZO4AP8yI>HY%e3#>UMv7TfBo_jXLZwUZn-WIop4%}0 zhM`}~U!EqV0BE#_DR8yV4?!E5_n)g7xFH^rRIWaG&s-*lW=|TpJ%G&0?peZp4T4NMqF|0VwPwhq9G4Z(CN9dpn|psU=}BVpiKq&qEVquYB!9U#w2O9*^)%3ny+- z^Z>!3cK1ae^~X*^SroPkGvTnK2`M!dJzGFQ%4&x?&tw2y$^**?FYF@XF~oM%zhv= zmi`LTfua%JrDMtMAVMiEVyhmKedg{iF&2K-cB<&nQh)|RgR5R@S8Jj zd2Wm-&#Qp;ut^V@8)cY*j=(!-XmW0)DXMBo?^0ot*ynP>=G6h!kU8+~$T=aoYPdxz zbmJjlLv>RIB&>a8_t+>qOqkoz-FGtN9@38~E$&U0bLbS&1zj{#`x4CuLyW2D);sW!g-{$)?#=~-(LA&w)-y~~6-um!y?&pQlv4BORgfirV~;CpFQgGwEdyj8 znFwb{j5jMr$tz`;JyXhMjx`Gj276xljOWWW^Vdu>XDAg*? zyIZQ{fgGEeOJ|4)Bf=+Wcci3U{abb{VauogeirL4Lqb|g;U2M`&bzUcEO11kZap5b zqpQ-E5vM59x$$Qq{n?B;Xz?c>sw;26=};balqS7)ySD=&_Wb{cg1i2l8X3D594_Db zUPxp-g(Kr&V*B^&ZOhd(A#QYw|E8)B1*X`i@O((%vz?ct*?f9J zmcB{xtClL%SqDY2Fn9Yz78A~n1Ha!0qbfyCE%w=}f)mXm+)O-c@o8Fy+nG3Yyp^r} zi_IQ$zu#iP*$tfGT7U(N-enUwPhg$y9Y!jW_{PU3Rxq_AvK-2%IBqTaRJmd|rN@Qs zis8x(zc=ztrh6EFBxqO+)FaD^4rp-YO?=1jlQB2C_TYfZZ5`dd?^cWeu>{R=#7#1` z2qJJK{T7Mfm{zA?E$YF{&KGmr8&Wi&efB?bDlj>YC4yFsodN~6sI?C_@s3=BX_Mk3 zkQT1>D4X24;$tN}a@uF>%2ZSg8N4~>%&`mAwq+sqU zFJA=|b|+$I?|OnD9?ShN8XTAVk#x$dJ<}vrGu@zykf?AVUQ_1Z1A9_|@OhQd^lY|;x2u{dW_g- z_J3*rHGi*Vu#gV^^=)0VIEg>321^`u!#T8-CUG#hw?DF=Wntqi_D0gU3X=NVuSoNd z;|y0bVympHV;y?3P>4#!c0|}*d_qk?T+@-m#6P6wW@V2Jg|Y}FkWToNj5?c|M%cot z!yJo7a#;x9RC>P^+WC8E@ln!lix=3-rpz|M;BYVWnWNPk%$?oZF9a*X?kshW!bW8? z2$)epn$7CPHLd}Y_=y_}?iCRSd{~Q3sf|ykn%~=*-*t25-zG?`HcU&-8H@8_eJ+FF?qu zWqk)^o%jpr<(aS~2IC;(aQ8waPQ-WYetu+OVGRIDfc`lla~@%8Zz%UzpW>DhfW^hw zo{vj)LUV0*v`CDV@ARcl$XhGcp8nkVBOOF6lz*dc9!*EKbwAYs{-mr252wqJdu>uL z+8of$l3ns|l+p>Yar9_bZqn5w5)5qLpJ^#zRV7M&ImUFjVXS7Z04rJoyubT&D-DrI z;~W}tWfJpbV^=I{#HyJ+7lQfrjD%~sY3PBdZI;GG+gn9eO~!omb8H9}cdl%R?Tk3D zf3@VW#KJhmnAb+}Axh_@7Uv&DSHFx9Uz}DmYCKEx-0JHJlcUH4fvlnHS6hR8*<{>j zO7N~m&437-?#0E3aO-;_GZ%4$jMr{}+W;|(J;M8e73Q6>GG&$VuC>mWY`ctHr0T7t zyOs7Vo4;#DREIKy71-R+=|sK|WA|rFfS3`~`!kG5Fje79)qN;n2)cvQC$5b5J(|lX zI7szA-fLW)13UwQuFQc}>(Z3tZ)%R4wu)BU2@$iiW5aIk)Ld-Qbl?VAbQ1*Y6EI6t zs+H$oZPi7##Yu(8Y1q@By(&#?RId%BIRgoC0cbrxq8()MHT1OOhf7EJ04-5LqiWwT zmS!H?b-+`npDmr8yF|7ig#|e&X8-(BUh;W%1OHgSvzG+#;G7}`FM|Bp#?!%WaYJ_` z0cy3M+XljV+;)j3gBb7n!5y@jC-1m|b<#PF(p%;u+|j3cG?#C1@&6%88sKNMBQ+(# zf5#8%R}{+&ve>)9uuA80Y<-mfuu`M77lH<|pVB)|x2k_ECg1Gz8TavFH?#BseO@=X?RM1<6-z#NdN!?0~iMoOl>!SGgKgq5=HQihXn^z*SSej zHkv-#i5>#V000V!0iNq_LVo}NPoOzP%i@HyV~k@$mC3qj&tFW=T&Z7nCnpT$TJ^-a001xZ$$$kYnZ>MM20*I?>LlJDoBSB@tzUGia zYYjrwFkC4%t)Z4==sRZi`)>CTo{A}x&+@(x z6205!wWE?X93q_WaUD}&2E92MYVgW1o(!-=Ue!rB?vnJZP~OdS&ixv zQ9hTJJF#kFrx@f5F&KGpvYowo+oL%)cG5~U2`o*}L8eqBgBaChxe<0zNhXSgsv67OI-3JPl7#I7_2xmnr6hL{pQQ1o>-v0j* zSH}}MtrJQ+qG7GIj%Zcr-zw5X_8!+}rT%5Q{zpZzmjxQvW+Iv*@h05vHIeY@37Bew zaS}8%YYPf%t@o-$auLVJ-R-Tm-WHbJeOZmxAWZ`27@oV^is<@YFyZ`IjkGu>|90&&u?%(S#4SHi`!`^g`i$dUI_YFV; zGdTS6;St360%T2J3=r*XIN=YM-@ImX-$Hr8n|RQLlE1&=%>No4v0b89>9xw*mRn>G zi|S;SR~a4&wX(e$bg~mVT$B#?%@1!x3*6!XvZt&U#kU{%MKfr#Yq)N`Ru<)$nxkH6 z5)dU&zrhGIw7|DT<*3|H^>zlWI99#MRa1~tt!CM&ria*l3il0w2!*3tT~NXXRxn4G z2xii6O9Px@@wsqLc?S*BPC7KId6ETbC~W5@|2y&GcxvFNkx%@Nqa_LQ<+s#dEl2kG z&j-ON`A@@WBKY9>j+2g>sF4?&B6aA?ys#DR@9t_ox}Nwoxr1jC5GsOfi+>oLF4f>+ zC_Ysl^N32m0!3ajRT3}JmyETM<;|PR`ySz+^#=d@3xR6ugh-j4aLI-*qoN~}-(VF% zLP))7)AkvoJvPJSus^1Z&#RI%&$euw&a4~1-4;rGdA;941xJ?vn8Wh^GCt}sq&F(O z*KEQTfSkCBnN1O}11D|@6wPki0wbkU*M}G5n-R{y{%nd)U!F~1u zHy!88NW|GHu1rh_)z885le`$GE&_5(B<@J#JQuy|c0`?moaSl*mDLQ)Q1{>&+RJ3w zH0Ls3`?5Ud@z%WbjX3-5xkpwJP*SrNePe2luyX2z`5t)%xx*4#X(l*-a>q~3lc#wG z*Bmj%3W|Y46=aL!AaHZ}9B2#BPDtw$ezUf*er{5(9-RdfB{K(+NzVZQi|g~x=pUFI za8R`-qO5ea%B`2#;?AAbky`H316DxNCE&qlD<>eVgnRwh+h!ne%+BL&bwJa#S0pxv zhR{Dp%s&mkFnOe=X~Uf>q)azih2fn>BusTULZ3G1B$Xxtr8w&lHt1c^Bn=*&+V9%wpzFtH=&K-p|UthA{bAD9of zx^6N()FrnliKk}2mB=6~d{a!8h*JT0)W{;)>RMslCBetBm<+&cgvU-m4aaXYC?rEn zEg3@sCS}TY$)a$2G4LhZ+0Emft6&Pa89~d_7S5ZQlJabIh;4Z0!y5|_Bh6qkjk@Q< z(z%UvNK%o*&L3eBTd~v59{=up{{FFxs!|g4xSAP>#lTyR;IJ|~WS=Kr&7LfWHpEsz zq1myo5CazG628)%c&F;qz-l>82}4XtGJFWVd-O}!Mv;a}mH4GY!9kUVCMzgO;b*bt z0Wdhbs02xW#KbxL0C-7P2azI)@m&cvi$29K79=CXA!w?@-R|VM)p7H7Xwuvxn)ShN zQpMF3ou-5yu`sXJ?>nIgH;861E}BcT*#7ccWYn8kV^pYnk_YWxIwDRGe%l&J$ZkNl z?}{Bu*#?|sz45Op_PBFN`iw5D5d~bf+`O8W%ha%K0yf%mS|kA>9G0LclAlZoAmWn= z?Cl?5!2}%(I`VsWS&lxRwPAH+e!Dm|dg=D5l+ur;GF z6I^*^RBSF6Am!tC%zU*9xEP!FwAC695rb4hL0cc&vc_K%8I5$i2^Nn3<;?q3tKJpj z6qQY;2m(P9Bt^NklS?_w29wSV>gbZa2PHUB5>+~`(pGi*^|gjBrd$VD1>Wpn;b(@x zvTR(2gpfD^VSvWfq%!Y^c2W33u|OF38~v`kWPD_YSjn^7wQs7MMsQYJ z443@nv=#}Yawh@z36_e!SX|W;PSj>}*z9vj9b5z=9qR^!bOkSj&>!6`_0+lACl(Xc ztHkxF(RcpgKAOeVtet!F-*&@P8?YT)2#hk(n(*+c$u%aBR(hWclOP8vmsK^#U$NHM zGXuSJiN`wWmcA{G-=h=7&Tw-bPAwcW-aN0ZFSz_+xDTcw^C;Jg^RHgwfmAe4Yb|d* zbzwjMmnp>a@tkH$GuD&cea<@beHet83oT9&77V6#&n5$5axav1l{>mR*Go8 zJz3m|36>KF#92cBCwJTwWvFLat}FxX<8V16=@eHbeT=41BMlYZ;qduu4MGs`^tF)e zGm<%1O|;{d{q0$<1*3wh!8L+|eO-Y8hw#;)brlt8yS;(*(p8v3Je zrUdO_=vtOoCUmmvV1q&)oA}c=5 zgJP+dvLxTe_811zF!zIPt9BQGj!g!dD}}jelZm?7BRpYEG`D0&i@`M)?P2aQ^=d%j z6P8TjGR!9A-7}_IYI>?5MN)Tob%n1rG*VWHdKm9cH8@UR!)-!~+H1I>n$7cLD|?K? zD`m=8V{F!ECIjDzY2CkJ^@dcQvt>?$lCdVuYo1K~+oH&JbEf{{aqIB3-*oGiPXLxU z!rWtsi?m3H4V5Sqb)3cBc==Hx-fM(xbx6M>P$XqyvvBWeH&1@F5>bSU^;eaNVk#3fnylzm zuU~xE@yBGw4pbgKhdxM+T?y)Ek@wNz))C0nF%54Kr!$IucNxC};v3;_?UiOQ$J5Oc z!e+{1_^w!{H*X@gy(<1j8wEHrLr~ah8dZAU$CcKm_()+-c%_!TsY>}?WCU#fwz%5M z)NvuUP%b-rO6BK2BLYkX_R5Jw#e;088~k1$YPZI7{^i*v{4D*NC=89lGf&H-zY^wQ zgl8bd$Qb&d)qa+l-`4IK;#E)zwZg&>Tfdf{rTZm~sMO^E&DWaN@V9+z*Tduf$`LobT)9eRum`IWX+Rrg;4FB9wHQ zL_e0^*r4U5=c2G@PKuRt%r=Zp|Wgb2g6BS7?oC>7p}FA`A*ltIOa^ zic+vCsDiXl^1F~JV;ccIQzu>aj+Y(8i~%bIg^5kbMK41~m@$~_O9Z}qazTnhNAF9} zt@S;5u<{I~P%0F(P-{PGaPPv0z%)o?fUP}xOMWYpf@=d~JxG2OWiBOW4JUnSPEZgq zv!dO|w@*PxM_43XVKsin4s`77qU%v zYx3T`fwO&815>B`HUErwZKQbT0%E792}9KN6TM{rq$ zX`7Fu*cm=SZj<$r5=#$@+KUNPs<*mpu5G==B%jFa?P*>V z(mA3H!#}2j_szWXaKH;q7$H9Y=M|P6>~T z4Fqh!yQ}%o0y*QULyE^5c8|&75zZTyFTmjeeSCUNFNR_Bs3Jycbr%Y~{SKiw|1M86|1q!=v^9n)*BHPFgK=5av z&I~j;u!O!T<4~w{Y?)Lh%ycr}smVwtj95a{_s+!!66LT{{wsmMr#x4(-3s^%D@Fnj zzWH`mn>0rOsTvsGU3k;U#mfwDzT6n1^<@Xa1kXGcMdTStws1)Rzj*hI0Csw5BoOZI z@jo~EX82u{L~L%e$qROi5?+cGwb@V8yj2%NiMyjeIb-v*NE=0=lq)vydA5`l4jDHo zExEJs>?g=5@uzuUZg#p*-h$OCc%N$yruQ86FSx949Dwu^F5UU02>#9Xy!uuaYQIBZ zB*RCq>QmYsIvt>J)z`et-5|eICJ<^UdKPIC7M87?nw7Qlg!6=QvF9|>iVHBAquB@< zIO;0-96=0@*I8nvLEPa%H}4xGJEO@JvjIsRq>nY#+sE>eW#u&3Av%$zHY3kiCJ_HJ zlVMt=vVnD^@r)y~2zG7e&Bc^SL61O^_Q9H1;r@q<1v)}UQ1|BKO49*#?(k2#u}Aew z@w6B??tvg$*hA%Lc<%+BWU%qBAA%4?R(iQN^!SbCTEyHJFG+boGa6dwX;tq0AIEw}@C0bBLQz}``T|Cst~+Z|#QY$x03AixjlMIm;$$4%L6FPR}l zhzOKni(ca`Yw!wkh6|FhGa9e!b@x}AVWkscgo*0*02~z}Jc9Ao^{k+z%$wX)UC7n% z%Elprj;Ie?ju>a6%z`$V2HbT!)x+N1sE8erS|&p{}V zUiF+!#YlZ&Zn0sfG9a1IGX!bWwj8>Qf%nzWn& z)*d-Wzp*WMjEaFY%JLl>*EVW&T`G8u+_JL3Jk z^kw=7eDc8Gex7Eckn2TgC$%-EylFYz&K)X^V0P7EHB~pY%$v~oJ-BT-4jWW zwhag-QW;TP32owu&Q}g7QnaSPi?q3(dS{)dkot<@4H%bMT@_*!rDE<2~L-F{{&(w9w&6Ss1HIiFid^01|CUubHi z$)kcYB~8$;jb|m%9``bPAwua%Gv@=&8L&DyHKMpW#^%G%u>5#{k^nbH)}O4usmBH% z!c9<~GNc)EeiejyTN^AUaXE>$QM*(Il-)^f0M6$o?FMy98G_PTB_6IRHDfpPy*3m` z$t(nnQXRkm4fP;HyfQv^B<7`y?BHllvLpMkzYN*O`hb%nWm)-q#>;_neid~^QNayR zSD*wMzfPo`?rfc19V8BVGdm6tK1&MxTLDQ^4lNm{Vn6|nA=hcV5mf<@ZUld!DMu=V zTAGXMFwLomCKh!3kYHEjCOb~U6DOiYAi`AkY#sRz;o9KnaW)c`u?j0JUbdedBfu1A z>JxPK#TPU=PRPZ&aNGj?Fe-@wm>Usj)le1i(_E#z=k>`hMGAun(x8Cuh71|1Z^{FQ z%*x4Kn!O@$#@q)$Fl!ThSWfZ*`1n+eE+LG~-CI#wUA&*D(^h3RmMh;V#=(vB&))yq z*8=+QE?Z5>!fmZaHparIHTfqYEv7`Lufn~dv-hlY98ICli{3y>ToZaLPJ}B(loaNL zhEosiIF1{U?SkeKu9|Ej@YeTz()f|v0ivdFP~#435IEHF6EB{-wD*l;b9|tjrg_FaNDepI=j3h#w z>29=NoN4rsfvBQU*ytF$eKgQ=9vSL0GQ8F#B*6pgkVYnYV@68)VC>YCV$C8`ol1nn zw09IKaWCyFGQKnlqVuM~vb_=DCLKK5u&3dn3?mJzE@F2?fo2m8740EnrE%6=-urI7 zYjl3q_d)tB$g}tW08|`vH}A#XI(7MEqm1MYHZkyr)VIW6Q;CJX%a0@=78nAz{wI*%6$gU>7n6nGsg7iFK*wV&R zCq1Vh)==V)IrMU9&&dN0JsA^}fTPS(2{6<9l}ZAeNR&hopiNpl02b={C9 zN8IcXHvup+KgOXvf4E`2NMNySn#p*&Qy$Z^MkSg$;pECac7d4UdOpEEEB8NL_zBHK zQP}JWS_ks^=h;byx`#>51N$#U^D!$wa+A8#fDGTbvbhER=D;yB`ax21&#wgx?FAz$ z>bl5*Q;_+PBzv|Kxi+WG3ZMFa_60r==~wHR-nrqxaM5e0j9Ba9c zl*~@Qph{ykSqJ?wz8SFPHzPT4xmm$ccNSW^wfTKx7*fV2#V}zC7xfGKXoBnGG6yy! zHw7B`3v^4fell!eTr)o$Stw-(XsWt13$WID+rw?wR+Y}Q@TQ*5l*Vej?SxO)LWWiB zK-%bVB&rV)Uyhpk%SXa`nLZ;ZX<PuH7>vs4$gqi&_RkAF0 z`K1w!cpOnk9>(9EFwKN=_!QOVs_iY*laK{=El1GCbBfgueiLR~;ggE*EX*4ZiOil? z$uW3IFmD;6m7Zc@@jf}!3KumiaDU3cz)IqBL5ZSDI0~yFRe4ByFGQ=h#}rPBK%qxU z;kXAH%Cl}qXpQpM;lAYLTcXe^OLw++$oabw$hAkk(^;B@Tc(eAt`ml1(%_4A;=qAk zvW0tkc5{^TcDJo!cZmZU%Wqb+(-#ue!zsY;-T{eHd9pxQPgusDbN1o(*R!fSC~Ym+ z@oA3?Q{=1DPlK;lAhzzGe7fQE=jnx18NFth$D4ad?(k1$WN+xOYe&yJm8sJ7tP<9; zPl-xx^^I4uu^(WG!B0P9CS#1cIhaKe`8{lSTZ`iqVYQS*5!CrcmbYuS! z02DG>S>PxMkIG{Id>ZpX)DXW{EU_c)3jG|Yi4b5`q-{^RyM z`~8A|Ta~YlUg+q~5!5_M%s^_AhxxkI;QHUx&*t~to>oIs}r zq{vK>52&)>Zs&!w3HJTrzGJN-(*E!M?k%D=an-IMA}gVpI&9;d+J+&?8e==!UM66V z{E9o$#oO17AlfS(mL4A+hCRREY^l`hB59V;YH5pZoqwH!FC}+VZwfTi4HPCuy|$j7 zultq5e46;cOolP`KfEWHpS$QpMxV5#OQD{8BwKm20OpQ>PFO%>c7T|w_AGe5rNHrF zFh9AnR4&dfzm5cT_J`B7*LU)g6Mq#NILU!dWnP2ND$^EIy~b9e>@4DLcH5&5eoP-A zyU}4&@4xmf=~y=ZWW4S@K)1LNQmL0ud=90)c6mS16I$km!AmPY?Z(bth1emQ_ePwo$zu2365 zJv1$cOy;a_HtgN9f0kl6$Z4Fp5Gu7@&CPDc(A=g!%`(P7>dw--$P@6EbM5=~*xT9((zV{HeBHv^BF0&4ll}NR zzq!r$a-^Kp`1i+^n+2dwgE2e<<%G(mE1yteZ}F_p4Y{8ruAZ%dx9RkHbxE65E*n?+ z`P>1mjP_+cyNA7zWcH1#E z#inY~Dr-->8s};^=t|Hgt3yTIo0F%Ji=!Nx4BVBbS6&Z>7CRCC6NgtH0RMd0%fjW$ zqH2HXG(6?@OGxg_RG6DxOliFL=&(u@wYxAVkW3ryu{GXJz1<(scW!e$BFLPjEoIC4 z-WWO%9;aV3_ucnP;}a+f&AgaByJopejFShcu2CCqAx6$zC#7R_a%}U=!&+x6=FrvR zv|4J{&&ma~Eu9PTX{ZX*hpNOLG0gS@<2WAmzr~9V{E;d$jruznhuy3`JQzNb)=qb! z&AV?Kxg127L;9~+&k^imrpRgXFC5@dP(6;Fr|Ya+EiV>k$Pi>|qS`d&Po zQv2Eg6db zLJU7XaF2h(0W~fQkMEqFp<@C5CSujAD{r_PtzMZN_A_g0HjY}*UHh`0C1SUT-9&v} zZWP^BMwaCR16e2^{<<6|U)3w3?~>{ipB<)CdIr5~X}QZZx&+#Epy(YV2;5vuy8?J! zKFYswg2A=bl3db+nsLgkR}o&Ith02h$}%dbI|d1r!EqmgIHZKz1ojwWd!S))iKo%7 zGg#2G8^0NRT_ggnM5^x4h{at!4!=E{ z^z>5%j+TgVM+S}y1p!IIZDh0hV~*Z-9mwLn#=52o8+jEV_xENEy*8<67ncBj=YbxjQB(Vw zL>al8XTu)()i<_F44A)eh^Y#v%*b?x5NR7FrC^ex7W)P|E8G57Y6`S>KY%-+5(($B z!f(N7%f%X;Vx`F_A1)kM^9~N{f9kuEd)`L!&gWr-lMNSv&W6al>JB>XH};OsB}I$% zXOB)-P*%eO69KSgULJGiM@?jkZ*zGzwf^Z5xYiN9Z5*hK5y-HY?on14_7BBK?~S`n zt_L>+A{K}-jm3-THRLt>-nJkUPgFD45kcfgz^c#78b~r`;aqlDyC|I70eSVEke&Zu zBR|cK5CZX_j~iBiP#ln{B$f3+dWq!Xpx>7lJ%iCWpByi0ST{~iigA9us!VLHY=ZG! zmQ*`IUw6ek-gAc9=@&6#qI7{}lgzWH*xpPxN*mU0=K(*6>n?eLC1!WY*7Gqt-=h$f=cz3K0 zz4&2xhVvzr6ebLr6&%fZz9ou1!jQQ%M$OxvsvN)sV$9Aq7SO>;wTOR4Tkxp{@=o1v$yw?B}f z9MMvKI>J%3yGXpe3%kF4jOP&|-bX{Vuq49trFlGZQB5BDPYlY;2jp7` z@XH5Usq7Lt6=$D)q&C;HDZ^JVL|W~bU|P#<+v?$Lew61x z3gWaI6`eN)XPl(g@maX5zw?F+n&hKVqG~IR8A!lym{k`y#L`Et1g+U*n;a1)TK$Aa zkSd208rWTxG(MJCS~a(K&L5JJRigDpav73|P*#nt*#59QpglVuguUBxgi2Loqt$Gn z)#db_$C8=b4I2OK5QO;@$6gxn6~XpIEDz{_onngC2xF@pV`s4N*Zt%d%$vw0censB3>8Z z+GGPo@wBJ`X;bP-j#C*xAzNT60k6rA@dtbZaGg=P$GNTpBBVIFjZ(4q`&q#5;ZKqHm}`LusSx4Nl_h|y+v*Q<;mW8jCPqm z1XqPLaXE8yDoIPpRgmS*jSc|aN6^+@`GIZi*06EPWPG~X*be4)F zZ1+ZNsD*7Pn%-iU=@WcBaTuBw+~|uoU9F@DwQx55>0Vs{xKt7b9%nz$4p^E@)Rx;J& zK&+p7%hb-pH&|jo|4lvJ)sp6MRChJe=y- z18u!ALVXcWN-z2$mft`T)U&@}KDfyVM5Gu41L;FfRNq{v+58cKI+w<(oRt6FaC{(W zH13#~jt3G(AJ_CWi>@lYampd)oO1hjI@XFA{~u6edD)c`_V-H+S-#5n8H3eMkGwGg zf6Inf>OB*MEa^9bxUuQ(>g;yrM|W0k3u`Uzekz!yy)4)Zv+yM5>=(q!ZbIl z84}GjkFhQS8Mp!SV2_O;g>P>2lg->j-~WR){wl=tesf%_DS`Db%Y%yu6&YFCAKC@Z zYtW2NnMDgkgwsIDfY3=hm|3Y7KEYSQdH2}l=+o~%FwDBEe34EKDB$IArc+*G5#WY2 z>Y&Gryb~g>_^hJ9vg3#mQq@-S<%!R7pY=t#lHLbeec`!!O`z(05YdEx`ZIc+FujMk zF+WRvX!r|{vR&)IDGcw~_q$_Vt3*Wg%upuau#f6z&moba_mG*3IN`nZKv=cmh6VMc zT5f2Sy~WoVA?yBhRQ$V4r>t}dZ-GFgG#5{_kRtm-o#?2fe+2_7Le1L84I5v2=c>h& zD8QeMQ(#u+FQ;>C0c0RAxvH4d{`c82oNT&7*XVaR*Li_Y!{jiBMEyH5FuBrTz?Z@+ zb{Q+UT-|XPC`8V0L`7-)c;)6IRQkRaa}L-Q#gz`5QpXIm#?{fGJ$|?F;dX9(njL9) zueGaM>tOk05x}=hIAAPLO5suD55U0ED#z)ecONIin}7#)0CUj)$!NrU7qZ=4#`YmC z5k$M0(vjq1+@F#47`>d~f`*ENZlpu~tQ7%kzo=^h$mUQZl1sz>!iv(K%rPs~lpUoo z+?m+k7d|AaoT?EkCu~Q2UrjC@0anV+%epXfa$aCOb`4#mkhp2DWX+@^vc6j zJt0)#^)ZSRt4Q13FRGdu z0s99Vi|>7*TfKHI1KA$lXxAI&G>s%qh8hIDL0xT}JEbw$+u*?}wn2>j0uF*S_jahfY$ILL`pSipp zZvyNKf=e}O)0Vi9ThXI4&n6+65K$fcoE$9qx~id3000h(L7xs}ltf%B{{R3#idI+y zPDTVgAOvJzGFmdPh!9(Nh#xtCMGa^N4xL@|h}eKeg?>RFzRo$9#`-FPHmw7BYiE7uhFtS=Yr}1l5tvwHm*Xi3ELG6VKIg&=r=PfvttnUHk{p2c zL=@JEOl=+<{{cMaxc%EjS^3cK$YxsU{Fhpj+0`jdXkahOli$EgYYX;42o(;$+Yn_DnflANo?>^NHn-M8QM z1EN!6#_XL`F5|(W*14Uv&OgWgwluPdDRGs?fD;UgGKNAqRG|UN_^v%*2Zx>o%s1OL3WFt&Xc!2Hv-Hxc_DV!O)`8q@y{n*xbXtl+Oto~+?UuFhy#r*RfJEe?~LvX-B*e&u=r;Mpyawp;Bstk zwv0=Qv|BhKEW~se=cPvuFh;Ws_U;2_&mBEm@C-0?KsQf;)b;wJ{cko6IsKER5?aIU z=1}U}^r#ZW@QysFM@pmBb4=?-$MN7J#LQe7K=Pto*McrOuypvFqGmy_s7GV~5ZfN# zP@wIarYn9fUgxz%Wf`3i>`kZ*v3X6h+^C#>tsK-s5gs4T0CbVygz;cU!^n|1lVxCP zWGkwN@dO{)G5-lCsjRYWtt@v0G(x;z*dL|h)RgHYZO{IALUYr?mm^ci z%)!+5{nSEAE|-JD!?B;GQ{x*>e>)9kY;6(O6h>@i($sgU{2xQB6g{8$C$%#glWF~5m-)Ff8D8QAExvINUF)_R`=oh=6)<2 zIz5v1@ee|oP{TliQB2FfOs%U3f6TxsJp?-KwHustPtkZY6zM~QnWhFm__0e3Cd7Od z5@hb6UV_nVZIT#=_-mobDZnBqqUK}@0~86>!@Ek3{U2maS%r5AhQd7Z9IV?p% z&Q!jJRgqgZ`w6vnv*mpN0TFF6pd6M> z!{2frLht*%8eZR;&-CU-?C+-Jh$3Gx)O+eccp8mwDk&Cdkh}d}c)@#}gJ!BQdU&(B zynSF_7KL-O@_>YJeYRL*H~Pf5vTOrZ&R%$bzpGM%={rW^{`T5LS`ARzKMO~gmk{Dm zv#&S>E4_2V0Q4qZ!7}vTFI`(bYpp3_h=YU|luUIIz9O7j?*v~;2eC(dKav&g#jO87 zuS%{AH(~yA-1d~o`r2B7lUIu1cWuyTEUWwt!!vjVrPEn@<&hTdx8zV2FVXm6C&=Re zMmWkELi<2*Tz%v-hnA0Zz?$-0D-*!8mz#At<(3G+9-pQ2^>OPZK)r16F73{`TFKJq z{y4Sswubz_Xvyo8ax*3Dm!YQC_NjP!F%0F*yB-CM$+%mIE}_B{+*B=*&TgjZ?q_sh z#+TmcTa`Xyy93UMA`eZI2RkL<_pv`VG9{R0q9Ju-F-7z0uR8t<|9yR~)`(GdU=qwh($`5AUd%7al|Nqiz-OAU~ zLMq(NSgWf~Kq|GveK3gF6*v)4f|DnJ6NL7486B>$K4hwfZq~D!Q?k^o)QZJY9kKgL z3cR7jz6vy)X&U7tt0Ns93-VPobnR!iPToDXL~ za^;RJ4_|luQPl-UT5St0;eJ?ag6FZBnfy1~OtiSn!CaR1rWtm6E}8WC&IC4fn+ms# zG&xL%0%hUr%D$waH}lT!^y$TDnCwqWhOFy#d09S-)<)X9Ey2cCn~uL|Z;gjh zvk*6-$jg@>@~d7A5tguf0YE>5_uCerl5yL>5w*b5dDjieO|_Ih*bl}Ii9CGVXh#@xRi7wD zdkeagz#R~|8~2Rh&4EVfRT0XZI^{aif%sVjdGrJx&fg{f4hYSW>fVGG5A`>W}G@UnnZiARX`hp$d&>Y z^VLepHBd))Q~ zhQ4(kLq%QJV^d+bM;;!XU3B=72|l>PmT^1|>Ps>S$cRa(K7KB`Uzaf&q!+H5+4VdC zcfZmo_grh?!_&?bfP0vQbCLmdJ0eKMBGND8@FSeL?PVCEW!>>6F3Y>k6FLg?N<)Wk zHSE<3F;#{2TqW|kTn4%V2u~n0`hR=r8kKAAD0P2IHw%gb36*VmQ~vMVD8+|{QoihR zQG_=*@KT=Mo^9t2_gf_90H+!Q0t@YsOtSnO?v(%lG5!B?7aUiw$Exq5wRue;&_LmT zDM+TJUf$dbcGtun?Iy*Hvb}LN7U@i+XTn0;?sYisiRs#F z(uD2%)5L<~K?l3~L&H+?7~tn~pQ7=oRrvOWDwd8tYw07p%U`$WKx2Xi4{C$|YjeYs zouL;A+PY%!xiRxpMq@U}J3qD?D33>n)*L|l(}_XV>kb*bM2BKeMrr&I^g4&8wh`b4 z8l~-742ivd_tm@VcKo$x;m){5p2HvHUJOZbV*v&<-1=}dq=JutEcvXEL9*0+S_EUm zhK>zX$+!h8c%E?i7(f9#+J;8(myxASkevHX-v<~HXLfs&;qR()b|GUz&1}2pXg%3; z_I|Kv(l=X}RmIhMVp-FiZ1_|3TAnl>)`WFMpPD3BrfQ$m?tE5`8C}uSmWwaa zWEspG&y_H?OEYgGC_T_E%6c#P-ln^Ix|kgZ`B&ud^_`tyuM@fZHJ(616ciuXOcRhD zK8dNTlM;ZM(YUXJi^`c z?W8=ISgOmoK}CF_H%Ki8BkrrEzVZ#AEah17HDOw3nJwkkJQ?vqoMDeII`cM*ZGmCU z6fAOp006U($}b8Meiw@5)q@gtbTbF5DC~%~!fVTg_I4<$ivNp2<=JC1qr0+5mqWa) zOq@mb&hWA#o+cgq;k^I=3+n-&Eol&+002*q9boO;M(LP?$mpAr!!wk%dDk($u%|~) ztYp;zsQLK6@fqn(93(;#@fR-QXghyzAOl1KIUE2EkD$Y=^6IB~dm#V>>p~p`Qb|n% z=_=QJ=Vyj0`r#BNoUTq7qT~t=SixbvIEvEN$m33X=WL50$viYG2T-o)g?H+BLc=~y z?9>_rwaPZRjP2bTJseF+tP4klBOn%3I_IxoqE% zL9pp3wq&>YUYOrgISx=DJvlrM8tHo}7^DhcG_YxIjm!k$2NA^-c5o0d+$fcg_f7Zm zG7OANo#Gf%i>Xc6(9KX69*fgyTtA`MRD|%d$V=wr3~OCs%pq6a_Wm@ssd*H@InuA# z0bbTp$_fDH7-U4=*l=m*FW~A@n8lV+C-i~Gmm%MOkY$xUskOkNZ(2p|VYU^3Ns@@x zozY4lMj{@ManB-?;~3yKck=Bt`H65@2NjCWVL}L z+W%5;uf*sJ7e8E;XvOtlX|DgM;i4&>hq3>$z~{&6gt~>)`!eG$9mM>dQM2)RCo;QQ zvXg(e_VQ!pXN@8eSIyu&C(|66CU)A1^8fE9mO)DdpEo$<$Z4<9l*KM)_=35`*iuhM zUu`pNaFrC@s^V38y%Go#WYhG*54$Wt{23@?24{Ho5PN&0psWB@5A5t0a!v_*H72?Z zvS_QFWW>?59~Zgl)g#GFyrF41W}Hg&IQYGG&~`oOH6bT&DDWG`P?j0`s`jJm=kb$} zJs2O;0F#81^*jIaC78*WpV2NVqZrg*EJn|rkF{XDFU$Z7PoQze9urCR+ivc&=x z)04!c+JzD)Mk&s6aso!0-8ea&Bc%#5d|`IZvkO&rYhoOgKQp^1gHAtY38Y%Dwxo0w zJdaxw^wH@uQtLJ3s2@+ej4*n++oG zJubx&!y6{~&+-m=3tA!~Qa~vLaL{EQ`uzjuf3g{cyzEv)$4jRP5*ni_!%R`b7X*JU zee_4?_5tU<`_2oR#1hBAl9-k@&lRdTheF1^IQhohDs?;P#_F}F>91}QS6?6yK4}H^ zao8hmu0CllKED>(ClAYw)K|`~Uh3Z`t-i1gv5nwYj$HPP&;n8m>bWz^W1g3?NiNQj z+UIh3;a;#ZpKRSWjuAu{rZ&*z{1Ca}(6x+qQD1p9`roHZ^zjqf{;C={T1~aQB5EhL zf26pfl?E3pUT~GH9lrkQ`^`NYZGIRB;(<3oQO;2fihDwWpJ35|za=Uc_Q*iSV=ElY zkGnS0x$O@g*}yVS9>?Y@pq&g)TqRkq^K_4&(XRh}h`246bQ^8zjy)`6HgPJZ_LI6q zoo|diHTH_jhfh4Hge!qVAH6G zbmY>JlzX8FnVulloo|OfxN7VRpN4Wsqh~31a4q*A4goRN;7okSpapA+H}%B!nv$hv zyRKRNIO0<~o*Z7H-5qWZCsDw}qw>P(;Z7SQshIe&8WCzninI<5@Q@a8 z3!SJ2PAOvOohq&k5GG*4__YhZHG)P0Qg|6;GB6-)7NZdeH#RNsSm!az?XHg*Ga=!1 za_l<(M0@q{Cr&dC>|WYW{?dg{HzutR9~p~pP$4o^03A)%n!O8qD)v~q2Xq!RJMkU+ z1nU<<44TEwB@t~P`|BxYBmzJTNA0;mU@(3+lLL*IQ-$*Cdb2fD{z90_!EK&bLl=a*98iV zf)sY>!m7FD3Gv{`0d>k1#r1JD7{CZ5ZLIUO1TtokITY*JNLA+XT!EYtyUA);B`BzC9}%?Qo%vlBH=ZYe~fWiYb) z7o!5?zmBPCVk{NARh4DtGR?;$hs1G4&dd1T)}!<5B%88fmgVB``w7eoKA7Wq`D9OV zwjWLI@y5O(@8ptSu$~2kTX!WvW*EGpCj9F&mg&yj`gPMSD$S}0HY~y!wvg0QLjT+# zU}Gh%R1h*jUP2O&1V!mH&nyWWlB^&klp7n&6Lt^5Kkp009CqfX{FQ0a+WtL4^-I|Y z&JFr}c;dcl?Ol3|r9R`OQ(diPvMi*edVi!Orc?s`wbzeap*-!?RD8!~nfFBy)~9h} z6X4Yo@wolx1;HzW*d4D5XP z)Nv3dfI5&?$q4-Daouh55@3GyEG~9rgy6Tu3{*+!%~&IM00Z)`%MqVOivC=hx3a*gmrFB&WAfE=SBRv5~aT# z;Hv~ILC?Nt(@O5?ZQzL>?2g{nJSqq*MgI{&b?9(kX39i_mdmFOvuTIY@p~s~NKF~{ zfjmZl3gJ3$U-N3r4Ig?60AA>Sk)>4WgehKQv}lN)w;7~0+{-5Na+Xr>^%@00fBgk5Cmy~K9Cg1_#2WL zR%}}z(VCz9c86M*O+Nj0>H0dRRnc`uaR1;}9uaoL4@iD%4iLi&{68tjo#TdHt=)dT z>ZBe|bm$|U2Q!}JV>HD4^O||+eJO(WJzxKI{m~Vq0jeRlxj@_^+rh%l07sG*&cmklIh^H$> za}q-Ar$S+-&v}_>>$nVl^@$uLnGdZln<5Kx$X%aiS}?tO?a=^1=W(>vCjCn#zRC|D z@Y}}SmWORGmuZ^?xFd?^p<1}kPX%S~#q@IBd0QojNSAIF0eXfa3XmAdXR)@&fOY#A z01(b^R_zj1)jN`ms>StfaQCWGt^~6&rvGX@Aie1xxITGHt8(o%$_#%jcy*8iNlPcv z+YZig@?Cm%f3n~q824_3?Jwp7ksXCA@s72=Vo22a67yNv8G`Ck0#>l}TPWJ@7EIdm9Z4Wv! zp8x;}0Rf*cZbE+m08gMf;kiHgtT7!?f&5OXJN<8EkW;SLkO$UpgMt7H>&U-`Cp;b6 z1e;{3PxEwg8$JIN+guoV3iptmd7?fVBqQ|J%MGK4ovK<@Rdm5?JOOFM02lX2wPw>H zT*kUn=gb4wL~fUz(A@FkKF^MQmjG=mTfE^kyC(SK$2d%0yPc*9P}qb7P!c3UAsJe2 zWs~s{-zIM*Cn4X#Eqh75Ory5NLj2jI?sU{DvTE?+B|!Jr`Mc;q$;FRf%~RI^ZL}inaBK3jF|2=P z7p_%m#zUEU^WlA(Nd6sQO6U~f;&P!Onr~W-tARp1*@2coR~DnZXam2|)|@ksd;KmQ_ycLCO>8T`Xy$aE<4OoQF?`o)^UF7_bU zst(gQC{rwSS7)`gK8S6qZdl1$q=Wd@V!+_;bN%KB7pPj_3SZqU?gg|}s3d0RBTB7O z6L)#ZPH}YztAUBI?~-12Y{iRuMU(JUuV@U8UE-SUkdj@(B*EFAZofRj#jFere#nLg zj!KHAopccBV!izZ`OFljPaC~guQGP+2PVM!hqds4Y}WemMols4%Sx8*xGT2V3pv|A zbM2wasifBE@i0_HnO8*QBr12%5i7v=7jl)BJ84x*k0ct@LW+tKk&&~`#9r4f5wG5O ztA`0`EXI)nTq7EFv*kk9PLwOdO}0T%u*mQ8c_q3{F<_0|_KOKwDx%_!-p+ZeDw>_g z4J-Zfe2GKTH21yev%bE-9&b1=^(T4rP37NFO<*d8O4m(T7%#fP0zsk9WR1AZk9BB& zM$JP)l8I3WOqT53>G@1{imh29EcAwmg|_Gp!TF}zb-?aQ`MlhE0+bl5HI;C!RNq4| z2>Q-3%;AmKwlQnrn%BkKTj#xRK`AxBb3jQitx_ zu^I`!)z>LZVkrZ|_1-%dXwGYdcw&AKPqTA(OwF7)STM6uCF?KtU?4IUGqnjx;V`+= zzs=`d{$1!t;5r2bd6D<%gJD`XW=R-W>()?R$U@NrITbeY4PK0-xcMw$si|Obm|;ZO zpbhWfJ7EhepE+aE?*ur%Y+Nl9XhZRoF8Kaad&%&mZdO9wiKT%Cl4Q=by7s>uRS%bK zVm@jcMNAGf=K3e(GE6;b+=yV!sgFndE$cn4_F=vzrD{k+iO9@r1Mzr8J0ugKi!|r+ zicRV^MH^{8<$cwv|hAr>bxFNoy9xzkiXrZXmH z7c)=!aVZ4i2gAPN760NK*S*xM6D(9z2k#X(@IQT3{Ne3BH*_cSBo5orT4D-B;kr6u z0R-{^T~LFI54}qWailov|AG_l)RaoL-!i793`PSLVqNjITw{;v_Ak)9J;1BPlM_Af zJ&xp9z&V^TGh%WEqXRRWn^PJMPR7(rOm=_@gZh6!_?{iC6tDq{=Z#mmoDFOL>$yqX zAHVe43^6rbGLeZ9X4L7UZdpDt%=bk{UUKUn;%>CwcP=8IZWWmVUQ<=cBOMncxuDt- zusbszwdle(PAMho66J6sM7+dBy}+qi;`B_F_V)Z}g!YgRK>sSD6h>(qPMd0iiIOEyXj)yl^uEElqNWmd(7%Grk-j2cv=UwsHxf*M?% zk_b>7pI*+EAc|qs?H2~dovP~4bvuTRcqZiPC-&GKnj1*qa+7qoDdc7+_k*h|0`P~N ze+g+qlss8S+RMYAWC<(>>B|pJsL~%q6VF{B2Oe3b&_H4uy6cZfDpNxW6c$@XJh>yDf&8$1FP22k)y9sg``7*L5Dp$mt;bSEr)pP8@s8O|i&WU(YtyJTJaN*vP&_tYeR5ag>A@a_) zbrsXZoWCU7skQ+ed(|p6q zK&8Sq8_(1mJ4{Tx<$Te+B2mLg_Dh1A5Guqa39+TLqSeyrUyw-ySdKP9R@4`A0`6PV z98{BS1|%{WZ*n`4O$tsfnMzB46A8}}=wIPvYIL4hHqhPJ000930izf8ouqRiH)L>h zrMS{B+Jp$qrY=n1hg`9AKV2g87D!TG&KksRR91EILLpyL|Fg; zLQ}$)OC}j)YwbgkAp|2=SR4M9;yA7qjl2L$fHLOh)3u^9GOur)SyIIkEdy5jW4d&% zrsZ2QY)V^Iq8oVgY!($59=Sk;q?&SY1d-g|ERSHdpGnNmz9U6IRQ_Y>!pNC^h6D=CF7hWq2JM@^jNW1()IxwT8!vuo^KybKr$> zI_UY&`Nc9rKW{6_PY;ho&#rb|&mlo4Tyy%Iv^q;*_UJ#_*U7`B1B&xLc&@s(8iFrV ziAHMRia4f_+!xz`)1FJ&?kH~1c2H-IifB@o8phy9_y=fhaX-M52QOjHjfl7rvG@)9 zT^wOxJ{gs?^TRvnAqaBI^^npd9gkN(Aar|bau9V}zAY6XZiv;Z+IhdxE1cE^of-ja z_ueB!&Xo2-x*Z7X(62S=kvo@6mTEI*YLz*%z+~M?II~uQaTEpmJMz5%NxY?xxCe*u zT@1V}rG#(g;eD}aur_0*=&|A|`@nj5Qv{#MK4XL$Y>)RaIH6~*n#>VCldDxJu7=`$ zep#(g5|t$C;rp8Q$erRqik>YV7RyQ(>^+Hl?)`E6g)XOBbrc!AiB#LsuC^o48;PZ6 zKCGJ35>*lkQt?P#r%`rOHlSVy8+2Sy8-E%gMhvu3dF8+loobQGtU*N}b?b=iq^t3b zsvTXtE>aI)MOqzy6s`uSx`V0OS2uy*_bWS(!Kw>u^pAgd$S-OhsKn)-BA*}w!FjkE zKj$`y`k!b;5?T8+DWlBhTA?&rG}k`Rik<8-WV&Z8(XgXcTII6{OQ#rUu5KWT#z>OS zuSECDYF%eo$S)@|3=`O=f8(4e>60to>?cTl76HO3YFFfch?<)!?#=mc1S!Ep0(^EH zW*&+MKLJw1&itM8ASCr5CamHVJj}G4P}%Z{8Z=E^$#1V3AvUiQMs&EIVzAUS+{i8< zTXss+kE%qCO~JIQY3V39j!-9>XFo&|+H;65fHj!^L~~V>jU9W}FD%vM-5FR~J4G*$ zK>Gy)LRpMXJ%`4A(yC)|&$e?|x(QbehqhhymaX7x(4~I&ed9Ks#M_m*wT!XJyOoO| zMEk5W&>^Bx|62{3z9(MhE&`-8A3+|d)G9Gyt1v_0%w{29W z%vh5_a5o9yML70veuroObpnaj_;^1@q6+%sUlym@MP?f;S)Nn}p`vBY-&Ak)0z|4; z8(#7C$C)!?nj7LNt;!k9pKWcp-+o9il>%XN;Hkr8ip-Qs`33O3V{iM7!`ILuP>IqUCZdNyUl^myE?l6D|8m`C7bW?2!as&vYKAh5@v-jQ;$JEY4Wg1TQU+6ULUw73K4kJ6x1XY`J+>+Vq?!1!d7$3` zH7^zz4Hp%5i*GmlD}g-^N$?e+O()bL_2>cW-p${Zt=7}Hk-=MS?op-z?!wS^9~w5A zehPkV)rr#BXT=_1Or88q$m#>kNeOoiuo-K^Du>1S2h}8OHvO+Ti;#r8>WxPZc--Q* ze7jcTpuWp@X*SS&$Xg4`51zRuX7_z@-cb_ zMfy8`Kr0QbO7Btj)cVxZnhYSgw3|j1s^RmHI+uaqgv;wvjh4Lbdmk4<+ts;A{3X+b zg4oRB20K#*-m8>t5b#w^du^ddXB*@sm{yDi;5Q&8GLdVWO)MDvop2-|t>*4_zxe~l zwm*LxgRYlKhsfAAe<=S5w!ZHqU2F*&)R6#sX=%b8&mxt%4j9ZK#1JJM4@(0zVSIMa z_}Qjmq7oEs%k&A_X^DVGBWGsdBF7NJENv&bjd7XS&h2+)i00C*__uYFZ&Ixuyz^z{ ze8sizP+619=!6EGq}Uq9rpU@=q`bOo8k=3ftmIZ|kkPneP^9hPKZd6l!+vHRce4_X z8xFk5+f5*{_3CDtu_8L}dKx|V%Itg2oC+c$bwp49n9+rSG1sPcf@GFhdk}tA`=~R! za|sMWwn)(DhvkeMXIu&9NuODN!f^LZT9Tx9f)%Xteq z7*m_k#xf@9%*AP_gb-X#;?si(qiv^<@d1J6-4xaOZBHk)6uZZ5C50TUER z*@l+^#VsPlaTlZyS5Iv;A$jsyN1DqAsZo%sWyq~XzF(}Zz%?`Ftxfv_Rvk>oZ0J0T z6uAl{$tVByz~#J-c?sF&3YuxA$qbv8*;ueCo7xMj7pyDx?0Wq@{dNu>DfHJ*aFVPX zC2hQ;{^#E!ZXZ{wmi^WJYCE#*!#Kz-b03zamwK8j+_os}As}H=t9Fx?Vp#Ufj!ZLT z@xmdW;!j2U7WSI(E;ZC;d){fYeB==jQ^-t%*|7fZL?99F^zb9^$tD%P=hsVv*#p(` zg@(Q`9`CIHBzkM6m&wmwh@I~xVJ)FUkmv8ky-DOrQ%_qXg>PE2WBF|r1)?bU$bem7OH=@4K%2j-e1r=`{(0x0 zS%Iy=a_YI!P(=ZP5|HuRB-J;}Oy`3cjskUxvaC98*rRU$p%Xq7qhiB)@$0aGIEQ>! zHEkDP;$~nyVDh`Ah7LBwuv~%#F>}8%{%(%JllU*s7}*#$D^2CouaX;T@mf5*^uBiL zOI?O?tdeU<&A6I{&1<@-Z5H{8e3Vs`DFr8v9hky!Fjj-2?hk+}0TGq|hs+^pj0@R) zIYET}%C~cpZXFNE>2(=WWl^8u3O|ePmfp6VUUyow(3zC05-=m`_ekE5V%%1ht|Mli zdn80gwx8$T37p=bQ6IzSUiS83JhVOUnb%ME2r5mU;n|$sd}zfIVu|zSqH0BK_gwD< z=6U!Jq6}Tve>>qwu&5~&)hR2z+EMgR<9^I7y`HkaPF2 z0B0QCD-$#*e`-a0vpq!1umj3#wGOW*%i|$|yH$v?z63ylTsmBZWeDukyM!a;+;*=L zmoEHsO&kpxX(?SQ%dRm&GrIN^qI_)1X!Pkf`Nho33%+y8D&%fPCNRcKJ8P@A&|CzH z5G65C6Du{~#)3k5FsRGUo6wZa+4zCzl3w!$AX>Q%KsH?V-gH{Jy&{<*C(SESB+Vhg^bRU7?cN zIN&4Sr`6y-Q!L^deV>$Y1gRaPOG~Zp%-^6WP=W(--fRzqi^C_#os9sDzyqMw&Npv5 zEs3cSVArCbH*WLdo8(g72NbvM@fqKQ2nSGZL z$b4t509Qpl-4>X)(k*qnO0gaLaUoSzqNyh>q0)u2m85A$8j$;VoB1x!bM^Y-_`Stu z_4qVLY-aD5Ba2cnYi>@_1q&g0vhMDGexQ`F2HPX~PWwy9Xx(s#5x(&RFjVrtjk6B9 zX?qX14AN*gZW_`*^niXF7!1AP-tqlb>ql4p(2D;@__GU1Y)9r@@V3suOKJT}1BR`w7(l7X2lfWTzYse$tlc;7OjZX5GS`?O1;BX|&pkTVs zihly2IwssthMfKW<1w@8zk(57*KV{K)7>R}=O8I8XB_o|C}h&V^)f(z{6n`X2H^${0~};R_}~ z1dJ)Q3lb@XEE0r_q7{gyw4je7Bs7y2+w~zM%^w~OipgW!_GgXG)wT?}9!xKO_wM8P zIz9s$diZZ&%c*U#H^`!{Wz=FN%4N3~lxS-S)#YU>!kv(E*>-iaYTlVAho^PlTKF92 zN_ziYgwDgs)Ok~jGY{nPKFXD`=#%yRXAPu46oxCmBY+i>>z?rGRmbmP`*BV)gM6_i z>l(g26AK;HR%P#wf2^zpjqbU~DP{=yvc;$g5F@f9$V&K5z^$Ky2IPPHyJ_ifzS$;< z)-yQnl~=lxJq&HfoMZDZf7lCPZ?U#d)19cY_-`6873(o+mEeeu#RsU_{Rz>EB$N2V zk?>O0+-k#u;5oHwQ+CWhfon-9`IC7-?$7#a3CbT^I%{MC2Ya5$!C^o8*`R>>Xn&Te z!Bc%X-W&}uRRO51kC=~L!q-;8kww^p#VfRwqJ8IOgARNa4F=@Uxv#xGZoDV;MfndW z)@r%qO;%EZ;5;mb*KC)CVpadpQmH$xm2s^5pn+i}?b$7=SMEzZ^Qn{S?zBS9gqApl zs?Zi-W}cF>yImtB<0K(>n)53?qqJnJRmpYVi z$Z4_t)(Y%Uh!TKdr$74y)Hgm3E%K)@a${uQ3fOSkVU4F5 z4a$Hc_I>iT#_4!f;Qz1?kAj2^-B3ozK>L312r@!_WXh|;WLcaQ0#z=wp-Nvc-GEXN zcRIxBHWL`gmmGNB{6rQ-2qluedNZzdKypev)d11yMkgD8sS^7tq!h@?ozBf5`*#ZE z?zn0${abuMIN+3JSEou70*>r2kZ)-*=nq|6w$8$w$DZ}e!FkG58>r+F4;|{qA%!Wnx`s!4t=*Ey-5Hp8x6<9))Pl`W>Y>;%MO93R?}5I& zn!X@2$A3vv5~Bk|9~qu412BL+U@XcK4YJoytb?f&a%g zIF;@s0P|OFp+>t@U+AuAtgv2f}a(vIDO zlC+S2OB37eHM~T{k0`i7!6-J@5xegn)65VcyV3F{UwytreAZ6n)*x|q|ASI??xSr0 zJFeg30kX&&t9QI&pSj(6dgtCniGf`^*<>O9|NlM$Vm6rJdbu4t_zWa&2)+v|5sd3H zOPARi`B`}PyeMQ;5OWW5T|*8HT$0WG4zAf;l|%<3*e~NI_!!>j&*nEt+b4dY4}Ulp zdpY!-LTcfqQp7;m$B}O6-BzdIHbe|Vc$PoyMzXu6T`Q}ZUAd#<9p>Yt3o|%g!uun2 zIdC(v7>(W9!wmksqV!M>_JhU9MsB#y#p3}WDs7b>)4$!Cqn~WxvgH#hAVs(+=OR+1 zft9%VzW%8fQ*e`c9l);ABT!t! z$vdWB^Ajd*6IhppADq3MlVVcKgsl|M;HX6zDMN+^6n>ru!VD9JuO*Xg&)Tuwl*}Bl z1BQ4Z`fShS>d}WDl!2^`%*Wl@K7~0?n!F=Z0}40YtyuEs39u&`p?*EMx~0=k1Ro%a zmb?KZM)aC5)Op)VZDLg7u*>21GV@SfRI&DcH<9rYdkD8|T)rf?W*+<5Qtgnoi_u9B z8PA@$WH_sHpKg0;#*$<2N{iCAyQ5bRWHuGu3$t?Z6a3Su;dIU$;nG5Jr5X=zHI8rj zxkzrxYHYoAK=6~saO;qax>IHEiUkBV_c!^2*K-ZFwQlSTaIc*J)Wx`8N~n-h080%j z&FmUqb7$yb5kmT2dfv-)2lAYUHwE8iXKZ?ZJ4dO-93aF3&r(p z=gZ4hOk9YM6502o4O%dni7U9k%Pb|u4nZtpuOaj4dmdM`8&fv%LvG>_EmrR^TX0@Z74wyYfS79%yoNa@H!F&>Yj6uk9}ze60MBKZabTl< z-%k8xFpz{g#(i&6ilC(kF+U!hi?@OkCrN#`CtkWvA&4V#t87%DGGkB--G$Rb*P@@} zU=#Eu<-48XJ>5XBe~{t*Wfh+{zn1H695eMMnQwa;C5Lx0jSi;Jz9}MP>n!v9cZq14 zT_CYpTrXZcRnTrmJ7pY>)LyLXmsTw?2Sj9EcyZZ`^)6nx7ho0Qtty-epM!L!`m0*7 zcgZ`N4;tC-Z3hOAUgQ<#5p1*%@4yqtKSg1axYQPr8YCZXi_+OGft4|WCv4mpH zq=`%y1^uf3(C|5@1Cf1eL2VYi~&l<(t>9SSN>u5tPgaK0>Gzp&w z{7B;KwM@0FC^v}QXAxBBX%+s~H}>WuMSC5_wOjvGtamZ)CZf92EGh@J*Po0Va zo+FAvq>8RUKl?JNwlngd>tc^{0SLLQiH?995=@vBIr&?&l_>z>4f6ruuAxz-*A!e2 zbUgyXqel(zWG}IeKBOZ^7oY#)!FFcujnT?ewdkT<>925vbkTWbCT39?oLz`>(`POm zc9ak83)C|qJZ(eYdVRDNV~{@V`oAhZaT&FpIqs=thF12_yoQdP-v04=y3P1VmT(JfPu2uSR4tPCHqqWTe zLytUS6?=ft+ln(=8E8rr?e&}G(&+xwTc!WSx@nYKCYHG)GZA1AA$o({4iv19Rp&*G z0>M}AI=EBoqTN@fuMgzFK}N9_BmhvdCOcpNPAw&RMnB<2&op^~!63(j>^sdlO*fGad>ttS9A@Fq z_Cr7@=drIFSjJIh=K1~7S?(cHnLD8lTe*a08e0d>ck(iim-}CfobD-#My>e*eU890 zV^Yd^OS;8fP`s(OdxeD!@bKa9_BKo9oRM{qLK*3mRgC}(M#stmcFVFcz@-TA*uF=; zq#IW|5PB@{pgKFI8%BHX;<%Mw_wBc_0%2i$ezca8D2kkE1r<#D4OOOCef7*UV9^zx9i5K}sEoWc7MBePR zuTV_(WI9~I2oKfL@DbT>g9B5v@=WKm)^UC5mb(=t0-J;e&@6AF#Jv0o%OCv&C$wr} z9z#8b+*BFZwveGG;jDTQT{1wTr2+o06&UWSOY{^_6^*jZ=yTc zB4MsERGU?o?jni>gb1p~CUqiSfX_C@CU&o19o;!-dM~r&&h}gC(GJwg zdZ2}Dr99cgc9WJYpti!Nf>*slruPLX@Bq=E z#E;ik#ddJ`^$f6VGiP>KFanxbnQ^`9H1c%;A3wl17-$JcF9vu?T!A~|@J^od58iPD zoGwT6OZ;Ct(LHM^1$bI0)yj`~v66I0%WofQ*p86qrE0%1wr~6Vm&&8$6^7Q*%>HJ} zCsV8kOJ_YnSwWd07k4HXYG`VqoQi4h_}8DH+i(opqkuCZH(tX^d}`-%_P$j&Gau5R z(1OVUmJ*|D;1 zqb0migxP2PZ%SEy3j;u`yE`AF4PTL`fO2ofVkyxEfH$;Eb4GYs-T-F~KAN|qac3UV z8C0stWtMfuUgJ{?y7vmDSD7QU#DB!Dc1plIF$M$vHc~;{q?Vd%GvB03nms-E4W7aJ z8Qimp5A_+nV?6=A&pcij@{An_1_H9GV3ge(0gCDD5yjO?8 zJ6$MNe2?6sqvemTt9l}Qg|m{<%BM_42*d!v3m9eMY56RKTsbYfFgF=}@NCJ8ez}`_ zEb}H{QHh-2kzu!1fX?bka`Kuhwp??By#6t#{(i%tJ;2{lGC*hyDqJnup7XWS+vt?? z;+rU`TKZ7AWUsHDHw)8xN?qZ&@ebWf@Xo-D6}ps`b!1wwSa@bnW{$fZs4#x(_@K#^ zq9Jek>4(X>l%pZtZ_umJ$I#Lz^`8)u&}fxcJtblY%>|nUqz6O&4mhkG55K3ERY*b@ z&d_x-BvCT*=rQRx(?=q8QeqKZ0Bx61A3-nMEqhxDMi!Wq?Mp_6f3gkN^D@9%MK1lnu#J(^!Q=V~-&zWQ`td zS)^%f$KpMjiY@ZvyUe2~zx+ISjjMeygVLQ)=`xEu4o~9Isy+C-UMdQf<83&B4qXDo zEd${yn+UnhcIn-0!7f-+)yb{Yx4FFZ=mFRTx}V`ULOWc;B!js;Y#!+`1OlYltteVJ z_ZP-!GdufzUVrqp(^qMt;-7BDWd>ny$4k~0LUjcR2nWrmL5uc-{e7xK1t&LR5?aCw z9G#OtLWKO^pMOmV#P*#5VrFB6!>aH(G9Bhoe#ZI9iAhQ012gkL&ttXIyI%HWRlqF> ztBvJxx9yef)zf7aks03MdC3dV?m`161&14Agu|5e67twaw$I8vCntSG2bB<$GCxu9 zuktWLh!*@@=AWdvgnyH$eON@eU z)kPl1|8pd%|9CV7HgA<6ZIhgwxS}8LN&{#T0cXy*U!> z1okVuyeTx(73H{K7GS__oh60l%Kv5Sfkms?{x3Z&rqPp7soh@DY7c_#&={X=hj;Bv zhL->`!pX8pb_YfVwB`1DzS*CslO#giB1m#ke;Xh5*+5Xrp(@dtj@}q z3%~?;Jl^Tw2F)5I-M*TEY3$9mW+xw?C{Tyx1${^GXd>IR?OlmX@P12CT1w_ulTPbn zB&Ko0d%s4spne4HMXouHX4O#FYN@=WFrQOXLZX+^@DE@ITP$9W@W~s2!tI0IDom8! zJn@)u4J0s@QgGXjoF{;|a`j zj;-m9m`z!3xShQ&8!zb6++B)Yr_?tq)BF|YBo*D`1w!z}F;1%6z^mvHl0NpCb_I&* z)E?_m5dvk+*!=LU7nmGaC}3x710!D8BCl`jm%&&P5bQwbyv8F^Me`#Nk(0TbSG`WF z4Tl@{Aklu>8wGmVz*ljwH)G!wBlH~W>4K~csHL!OyLag>60BL0Q!FIB$&w^gO<<-<5Lhyq}C&%Zea+y4jRr`w*ZGi z@yQt#UZ*O#6IWWxePSTLBi#{s16{3kXV7T-XYok;Le0;2&ubA+;~ERAJ$ZK!ubpY) zol97Q+&BxzeR3uEK4;ux#YGg%lgL8&FMGOuo&N;Ea$}wTaQ^O{w7l56)dQ@5b6yv3 z1YZgh(j)%VDf7^p=*vJ~EP<5GZIW2?AbtS${2nBd$!uaTMDxlhR`Y8o?rA!*GtDK7 zm5K3{rc*H|iJ>3^XAaE!(CODeMb?|2N4bC0=ANHlP}}rDW3v5Begc_ik51}lyn20@ z!H2Gbq%!2-OGALt&t;XhfyVAdh3*o52+5K6eQtph{hIQ&1QBth6Xq3-4;U_Px0GVX zUeEJ3P|tmv4Nx1$V5%|{drUuxX2FBfrXp^+J@hEw!}vm7xp<7)IeY^@ErH#*VfAPX z$ZfBQ{N$Z;B563i^`H6s=>4A`803IA_~z&2EeAi38^UPetw}`IWA--%EC#sB~WY=L7jEo=qjhwSH@tZ-;laz?&L zwTMxD-Wv2XWK1uW&q<9uxUc~24}D3TFha`MD!|dWI|6@c`73x7EQZP8HpUglm|Z4>X!4obQ3H5a@x#|-aSx}7);x0)ag+Out=*2nSC`+ zhQQ-s=Q=x@c;>=gGAN`bGrAc@GJeV!Q#Zc&!^A7Xug9B!wT$6sK2jd?LU`Mb?oQUk zSK2UK6|Zlf{{!_4(t;tR{CFMt39jj;+7v`g-NEK{Xs>)yRHKH1Of#g($M0DM2@dA< zT20E?Sx*?-klmOLW(3dKqQnc6WOo-Kr6{7HNPLD}PzYePbz$o2vW-Dm2i@4Sk z0jAsv%v)>cm~x5dPk_&}yk?*Clw2R}%8#5TtcAq@@h z9KIB%uuy@Lj#FiH((D+YUA|CZ%>ibWgM$2gg0=yjU5uvE$+DWa(5PFioQfaKM>4?$ zhbH+dIEeIl;zR9Xk)AvTmUID#xqt`H|koYIuc;+caA&+#f*9 z6~jJMW)IY<>a6vdsgY2firEiNkvfO298{Xcv!%+ zd?z$YAp4p3o$>lr>d_eOh9O0$AK%?JY7N?~9i?aa@3SGmC$Zi>3)f>?#4l_FUtr3Z z4%rxxu?EL02;&h8CEh!^T4cLdEcbz}3tg3p_Qh5d4X}@XjF0VO9_+`w7IMyw(ln8m z9VnHqXrkFt*Aj8regu-j9r?+5?I##=J%H*_s^dOsP-?HmnX*HKWr}eVLBsC+O(P}0q)aza6I+r^JvHLXCq}R>rOZz_z6D)O7 zz2kwpk?qtPkWOCTN#1)OGEYqdMOzNTT>ItY|zR--_-I1*cP2Dq`AFEUzFhriw52)^;4|86Ro*uR+Z~e zg@_pT!Yvo$bxe-9k}9J*9@owLZB zqR_$NI-o5u4~3Arq0ux5QP4^i&knX3w0oB$0@*#7U1R7FIOAI_k_O+uFG$uYfv@Hi zr0E@8+LDnDMm%Y;V(e_6n1AOpMVPoZ(Eg)$p=U9Al~mt?B_bDXgfiBFCsao++ThvG z6q5D$aaQk#Y2%gr51G2X4QXna)d8tR^OH(uEmMQjvFu8MZTCgTWV)g??{b_SHd{y- z^BLeF)Oq&F7mvdV3SJsI&%{OEoM+lMj}{c@M$Zs0~DgX9&^yq{)3c=P5J zWeF-IC2&zSDWzcJwP}-s+ZC~4NnO9;U$*gsN6InIhWD+219?*ci7wsz5KFbcZL}ZQ z)We;}@#WnV!RUyGujCY52HF$;riX9Hi*%Xnc-{G^^PP#6f$kNcnSZ!eH6j^xHGsv& zo~W zaY}E@Lx=;yDd03T_^ka)(znk_+jN#;dfLajXgh0hF}Z3;|JcwMOUa>B>xi?suG-;? z0pdPp!P2bpj-JQ}YU!!7C_GP4i?W&AR@eof>Q~`AoApKq1_+00_ur;1REdgmI8{hq z(kbDVO7WzpF~dMuql~u72%(1*rc?6}hkZ8+OEKkWl@I)B%rRB66DEU6hgkZ-LN0PU zT)Ir?l@_OzqsN++mC>%~J4aG^!<$emY*%_0vw6o#w2pL5_@ z&Hbdz1ONa7000QB(z8}AxRr$24y9nOjHJ|(h=8goRfh+k)%^8h000Ns0iSbjLVo}N zPoO!D$ua=8VAKf$6o$<8f3h$aV_f8d4lsv21B6 zJwp042$>{3Rs;w+Nc4{E3Wd}xyq68pO6+_nS zbLW_)$tZ&Dm+!NVrk;T0H9AvKRM#SbY#D42RYwF&Z1*%BP6_*b)FI~Nxx4$&?F0yK z(6_PkG|ktZ4- z@FYHp^UPu3o%ef7C{O&QU_~bn(3`wU%h$ovyKmNCF<(fdG#vHzdbc~s;~cz5^WB@` zOk>^Z#)f5N1nP;f+?npn$4jWyb#XkfJnlPd%nBNi#uASiOO}vb_vX{j;uMRqAN7-4 z)Vdo*sSeZ082>Dd&lMDBHSb{lrQQnM*IuNrO>FT=_NW6o_{of1#0C{kpY1`904tk{ zp@hr8-vJpZun@Gu!qA5r*6&9gYZd25EI&*@@P>9h4oq|SkiXRlas( z?Sfsu8JL=}^Ea%O(G7E^0Nj3;hh4H)(z%C-ZPGIvq)YXG6@KI(ne)!l8jbz=xghP;^*{j^)v*bbyp4f57gV*>pR+(sKdGrm#f0a z8yEyyxMmtIQZ4LE|Y*w2y=O1 z0zgv4VBjkU)+3{(Awzt;ZPTXD;}Hebn?n%>&z-#=e|Jms7l--nDiJq&pKb%4h2zK~ zEMUsMEG|!=Lz(1U34fQ%fC)Os8f5=#pmz)fBkcuuKRQ`eI#dbVc76Yb^j6wqJ@9=A*tvA$hMH66uH=L-9=p)V-n+lbyu`WM@m)Wjs#YyMh zh-KYlzK-Y{ zI_qRL*)#iy8T5DN{f5k1DN5?#_PK4MrEHfry!-GjA708fZ@B^Cw(VkD0rd$ z3v>MG?T>uzIO#2xpvFWpo$-0H>LV^^lYzUG>e4*?EYfQ8lPX<6RAZqS8 zBN2N*oOAji^jhuXic+Ezt}<#kIvd4ea4eSeHk>D!*A+J9@+c&Io2;98NpH27X>*Bbn3frW4*Gj{_%JeBfg4mI)p8@W)>i8)xYsZWc-SqgL?s7o znm4*V6%yR0@*=WZ>2i210NED*pb-PQdK{67ZaP>_RfC<){ya&jTVo%z93CJDhLxZb z?Nv{S{GGr)P*t+tSO1Xznmwy4zeX1l8ODv<&T=hwO-~XPH}Ee_bS=sf6|_y!gDN6` z<~dB>Ir0D6StSH)6D6XV6q1W+ujj5aNz*L=x^)>mx=u4V9x0P724t&W4b|i(!|=G6 zYmq*TfJS}ooP_UZfNWZ`%Skdlx1e6WHY0BG#i9re;5n?JW6a7SQ%2)w;V>A z%mb-gzf(LdH8E8xqPHiaurIkz#KlH(iKdMGufPW-K!RKEB&;9EZ+T35F$O!@5loEe z8mAop`kKTMW(tq@dIJFaRhY+;0dNhDWS13zA5GCp*Gjq1*FA5dZ)ovO$}8H3%)KGMEH6|Ng2~000kG(*7P_ zIsvRjI_`W5*vAk8$8_)S@AQ+I|a$18}X^bi-|*(*l?`M9xvi2&69!=aAlg z{k)~nQz9KZ1xdRw3{$WxSu_+?q@o_f4ALF5$iEWHOySfhbM9_CsaKrh14+J_QS&QPpqIhmL(xn>9)zoU0MDX!@vtcBDChf}h017yzX2 z?)W6#B?`2XI-cQB=||h#qp`bKd-@?bqw4EgJw{ges;6sO zuECw7p8hX|bg{KQ0ic(Vv390}OXnu`uXB5q1$xPK2Eq5v-dgptG4-JonpR}fMR6n@ zG=2|&zdFzyVhJ>~-wYFM8V&(A2KvFi*sv%qTfNBifu)#_)3VQbjnuu=#A`it)KjuI zr44=n^WabaD)eQtc^sCR+CLc+%_b39lONh*9aHlU0Sg=5P5&zhV$hrp$Nn~~I`8kL z-pK!Ol72V#&*k=oV&<7dv4MZU!*OWtCbJ*ft3{+bpytui71-~2CyE)Me)>$3qIrSd zAE|rVY*vqt=Am`Z?M2e7lbyYxDXL0yNFek;XfVE)NH~U1c!UD7Wi*9jQVt|QcR}7+ z;u>q&kwL&=l;J!Kp7nsx8OvHXtVi0&fBfWxfz!+@mj4Uw3gQl3A~mUR z()PASwhay-N8GjmC%fi2<(7UBOm}PR@-5}+x8h|YOB4f^{!AELW*>55N-#9j=INf! zqw1EiICKC0z#UT(|D#I1B0M&<`XN6w_5HL9Wq#;quk+2n-7&3yvs4oI*#YG})>a}k zMg6I;nG|I}_@+27vIUAGxj>J&N$1eTy#Rs;s0ApMmfBF8wkIZi!Gsb&wELOQ+^#OR zMWBQ#vmDy>+XFlksaofL=krg3Hja_ccTI%5|Cr2BWj<>fN>y z1@SH1yL{I@`HrU2eWMP@TF&->vbe9+;Dcg^h3IOm`eQN1Td+IkXHDc&n4NrzFTV0Lbx-p}t|43_s*T@*g4!r9< z!DVPJPN6jJTNVYb9InPSCsi7kih=}9>C;BE1->_j$bx0*m>l~`m4OB1;WLlpXH6lgt(U#0TUxi==UGrQf6_bbt%u~%)lGSV1pPCIn zoj^P5b-3TIK0QV2lCTa)H*LqL>hJDVe~Chhd1oNhLVG2B3*z@ylJJfev-3oWmO+sXlaiW`(T;>b=2bK}u4D~ebGh%RY z3+Wj_;+q%sF4I<-v_;EBQk?8BIO+_1gup2#)2Isj!8i|ppk+|oS+&Y0NyhjSUuVV| zMwnC}!pAW^wmCvD^CgHVtzIwPmkSslCo_+4R;;$Hi}H=4uATWxSMbAbJ_~jZjP)V} z?L$PBn$Z1{!0x?2hC`Mz)eYKY7=pw?OfmUaJa>K*xOUltg1yX-rKqf=1N1*{-SNP)g5}(kR8tuFbZ9`>B1z-)1Q# zjnxX%E#8`V7~6j#XJimm(N(IQk0p2VqK;3%>h-kh))NV}G*Gr{w__ssrBeUt*eL_C ze}xrl@MGig1CYi7X2I`DuAEFq%q{XFvH@=oSLJET(oe9w;cbJv9Z5MKTCi$21R6D|3BBbs*`SXUMiIb4p?OG_+@ZgDYVEX zSZ({|>+ST|v7Ymh5QWLT!2f+S+QSAs5bvbRa@?UT=D&=5k=Caf?k$Pg0`vN1+oV${ z?8TC?B7T>mbwutw0MDvQS&_NAGud{xo1E<2oLTOdDdQDWwa|j>m*FRyR}DWL8W?vu z9)8!ebtu=}Q~Jz#sJ+M2=8ud@a-y>%W>p4h`;3_EzWiPXWlFd*MhRAWg*$bDMh>{m z50iVkpqL~p3S+GpUV5di!k)@;xl9}zKX1gF2C_Pce?+BJUcoUivYw$yI#*dQca=HI z(>L{Mo}I6va|vpS=t6kOK&&Jn7G0X-)WUhqe48FXPKh0#LB|-nDE026L{^#fmUpgF z6-ZxA1ISwPdc8j)iQc3L92mdwd5w1?x^DcldRZo|aIeVfVvR7rd$9m;5apLjh_ZRk zsuoKy?6bM|V~2lRu%lkwTT&{EAqSq_1m4bfWma1;+oKTlqxUWE-hFKjy-O_e{66Ez z8yj10lo6OrSJ0al4DUeG@z*EaZy2Y#^A*zVJ-s{}gf9PwvH~^$Ru^>*Z-=Npij6I? zwqw-&bukh{3X`st&4CGiMHbPxdX*ag67tYqUQXyEHI2V=0Hfg}{Zkw~{#JRouUt$E z2&)@-Hyz_0gTmTPSy?JVk-B~yVxs^8o%pb%YmnJc9suIFBmfDb5yE`Wj6n`t-Q7q^ z5kHN4KQ8^sf{jstq^e^&sJHuR6u0TQZ-xB%b(UFDjI@v4KT|DUo_;-UX;!nbPF>yj|E zSCvJC&yj(+0tPl3)hObbrG(CG%IaW`ISXD=JBMKMPM@W*nQNDLuTI-2W`5an=EqVB zk1b7psD4TEPL2GSi755wFWx344ZD{ES$pE;HFJ=u8uPS8iex8-VQvu5{aH{AB;2w# z!;5Y?w99NdY@+#gHN@LX2GLfrpH9zI%Xh!^Zdn^2XZ>;;B2QJWQd}_vP>u}6h@9YM z0;vxi1=i1|4k>-KOJM3N*s@I=JF}iBZr;t2yeirp=mmd%i+^vo)>n?Ok1=Z~69C4% zNCcaHPZ`?J=!+I$4I?w0_hl#`TZ#4c@LBtiMJ$xhh03Z*$)xzWNM@WJQ4>O2O&+?}98JZK)GTT zp}uuN72LWfa;SxWn0|#Q#pC$dF$zZtP?6cG)@}4MLx}kjxk}wc{8RDwwR$bn^oSs8g>Y6 z>by4BM47|j+og$PixqUE(B+eXZ2akZkWd%5jbx*`44R^qb5tX-5EY4nMvoB!npyOa z<6kFu?fzUiZS*s|tC0rn!1N2~X%QYGZxj1d*EILwMuE9PpwanUEqZ<^vRs-@lac#}rmm88}M^)0$vHQNKWt`b`aQLxFk?3!P;mPvzXlZk4aRy1b+I8T|&U+O^&uTd^cu?I%PNTI)ljR%q z%~!`V1wQCTnvF%QmH0w4bUPP!*g5`PIuqa`5*s!#d@;JM=F|5-O1@2vJ?EP9@y-&x zHXqI&_E`opNv5GLo$O2&>5>LK*^MWiKp2&iBdS`csK+Xl+IqS%pyVCSf7eVJ<)52j zty?(8C4g6o`;>-eS5BI3T@A&)T)y1fU*Cb5V~5MvR$J!{t?TE}j^!hm*AIsy6%aS6 zDQJc(vmrVU)BM_O-IKpMpiXZ+3{+}PX{NLri4&KypJ70jZ*!-^yW6)wB^wgwzV&O$ z&08#5@$*E;wMC3W7VOVXm2oNu!4S_ zL#7Q_1_BeP=Jp)>dTmU$my}+jXm#Lu-Mj5b?V^?eCHzQI$}(OIT?@b-wRdfWXz}y1%*sP%)2mlDE5QIlj%#N!`6lg}5P;LppEyHMBpiPlVa1RlwWt{y&V=mA7 z`g@Vnfy%+VsoUs_m}3zJc%kV`W8Z)B2yzwi#qZvi8$I{Gs@=IS{BRT2hiom3IJRw! z@dx(D+tES*Jxa5wg=9XJ`m1hi3U1_rOS>M}Gtb|AW{XCBzTbEdFtL zQ=tgukU_2as_lzxlq5xZSooWAAfOl6J^cWSETCvhx*uJ)^?~bBW2=p^dE4dJU?eSC zu|WBY4j{GlVmfzatNsg= zo0P?B=vbcXlAxm^8h2ckl8}*t>8W`kl42qhz(NO$4$Ghl9@JW9t)S}c88I$6=4jC> zvsco7t~;wNX}sMIyUNQ9x#T7=ExAr50lU3rx9Cop zg7K$=F3RZIylyF$^z(tmY^5IGXtsX602L9d@l%4Fs z{@H(FJ1#R+V{Xu69k2p3T&9&EMl3!}-Di3iNz5B(T%~6va(4I<8ACV=7|COmhm->* zBv-hv^+|)bl4)oqd&v0pC7Pcj>6)=}%<@%gU!Osa^cT81o46eh%-%N$LqimVmM9r| zO7)j9jWt4F-^Ty}&MsLy6T?FTDt>BcNJv;_28v9%cT_lnDX*3wfR?xrGK1Mm2C$Xa zC@2gIF-T2fg$pr5aPqAs?&{8jigEETr2iiIh1scb!{^52qkWGD*M2$xT|lD0R$hS1 zsm6<@Zc;n*iI(VQITp;%|LT zfh3W($Lln=OAr6MU5Fs!1AMUEJNF>Ll6u*Ip0J}N8MV7|Jy~$}&=K{Tjk&{s5 z|0|l89Ey4=ApPi^SxwJ3A3_h(o=Oc=Rn5{&THY62uanqE-I`6G)RTiOB8n%ey~Hg@eO<< zL$4-(j<}Dv4kl^0BS3ZM#>`!liEAm3wkt>&QjF0NgG ze;z_ezPg&@ng4O_{Pe>bwYWev0)O6d~V^DI<(?jH(yJ~6qGfx)Kk&z8DY$b&6%NO*cuW{&&FM5HXx{c!2)^0_ z(%C;G81hohs!#pXfrus5mh@_Q-4o&TwM_Qn9kaX>;Eut~D8aew$-O+V@IB~q$F0G3 z+7ZrhWZV1Mt=Dc23Kg=5Ziw`7B_DcVvdxlHdQJQTmQpjt-DRAA9OOr;2#Us?{=%== zPF15edu)gpU_q&`sifw{6%+nZ3zXD?=nG*z@4`$k8Z|U<)pBus53Aj>Z#F;EbvP?u zdv(};0vF_!G`r?Z52x&rm3Mr+voiWRoORI)*c0E23)*qh8z4&U$pr)O+ZQIZ5-tpl z-?b=5U5uX*h?y_~ZN!fFB^XRoMaoA@%}&{k7>8`*or2E>&r!O7{QzDi{B72Jzt|e0 zu7eeZu*j!kOThlA`k*z&oq#(bX=NVT@Go`WMi4Zs{>uBR1r@dzNt;r2SUpVESsXOK zzDBy-KfZ(F7yt_{A`pyo1WM^{R=p%c@)hg6%SuiAtcJOhAF-h^$~WEYKWAfMx+ApG z82Kd*`IUKFHH+ab5vz?pQ-J=B>_A?9nqs9Z7nnulMc4i5*&RoWnRex1R@mn{Bg16} zL@OcX(J%W3j}VF(@FWEzl~&e}Es)d^zf|H0apzl@)hl)ldC4UuwcFi6P+ zz(Qs#!d#lhRpt>kg=M#mt6dQ!6UNcoVa#Bxli1;K1mI6jZSPS;4Dkau)`w*1qcS_@ z!{_yx$$eU55Wdu0S zG=Y{)etHV4e)$Qhzqa64X&*Ab)oj1tg_$e>h}0_NYhA$D*Y(8!$I}-PK#Y!l8Ma4Y zBW`LOO{4S)hT$vJI78WZ6WH*oxaynbGLj3@pu0ZTuIEbx4c^=`s^+;8nfWu;d@x#luZ$p-F$?+LEXq7=7B^HGBmX}#U zfoZ~`ZNfB`o;};HoT=$1{OqPj&Haxf9*?3C27O^-uYU$T9|eB0{2ckYelou`U{uP0 zG&>E3Wy2MSD~$2=3UMYE>L6l8d_=n}KOIN_+%N7*RGw?BdDQfyp{`Q@gp3`eys#=? zV$3tAgs#T5g28had-5uzHww#X5bcN?P)u~fjXLF8Dghc^1_8zrP7*lC%#iro*7EUv zmPX^VACJwP<9>rbc{7RGewiws3B?2BMIO;yL;#{hn1!_n&ZUPnjBe4O zCVY88_-5u;OpIdhA3tPT4XsJ0E%*b^R>*8ax29WZ<(2_M<$I8omEv0Wr$x8b(PbZ) zKXw4BnkzeDcG1w3Kh+%uyjCPd(|~Y3!r4fOV7QR#AoO7EEb+p19y3|6wqG&MNy_av zN)IZ3EF2_J)conHd2>Ct7vf=5r=V|FqkB^DXy#tTTa~^lLOiT4aXb7T6r7}+<1 zk-8Zi%4jGfKDHT$IO`}qqNG(uaHkDrjpI`WrSc^fC+P$1a8o})1Et(&rpsjH@@74L zd~0Ngsaw8SLZK<$lg7awg7}bqW{9cSu#pji=@SQNL-hWtE%m59&*k`E%wJmqcOD&C zQ*zIZT?7^T?})G@`Y6MNk~w3VKWSQ!60@oqjJ9Q|T?Ko5(9KxbbY0LupcMQ+ZBvt) zg)!VY+y-pJN3U>!SZ~RdA2L;Pr^RZ4zQrM-{)kL|ahD=PThJ#T-EEq{C;I|!#@2Fc zY$O8}2Z%G&8+}DKRCQv5+@^xgOZvGi#k#EFAGTQA`s|M(bxN}73<2@8wqDgam8id) zM`C^C0XoVf5IQEEHDIZ`5$G33c?GL}^n$4tkp@exN&;;aHQ`&Kb#<8u$aLbiGjOO1 z^Vl=or{p%ET_Xu*e$iu$K$py0>AP3i2&38-Z-{~;pLs#c`znv`a90T`v$XLU9{-xR zApU!)fEZ$WqTpl!LMzlFUD3 zqfIT)H&_9(Fj~ama~>CRJj!eLyE8IofCskB10S}ZIWLmHW7S9p-8&hjlPPMuU4iBd z)!M%Ju1MNfG^Te|>(q~2ltAzLV8GxaHxhb}(HvBrM%<>?8w3!@%V#v)R_d_h!OrA> z&5zP?mads|9-%22SIR58dZdDsxmXC2@oNa)crn@@FPnmTB4d3}d=#*l_P~n6`#l-L zBkJjWT3n?Q-q(yXn*lfjGL;Nb{>R18&*S_Ws2-sXZU#-o9gk|Bl>A@{L&0y>wpm<@ z$>#Pe&k`Co*1^^HYY}B6ix6Q8OOD6F6aBN(eYy}S3grL=aD0h&Ifiwtkg&=Io!NiZ z1P3uw->D-sV&&rYtoWZl0{L#ss9R6RLIB{%Wm!tb)S$S=f1Dux>OLEJjhC1GYH>QTL3sVVHW=`H?%P^SNJ0<4m^qb#BHQ0j ze;&9xfG{;w5QNy3#9Oq$SWx_S_PZZeNbl16=0-6EONZJO!K+KN3KJgfRI)iq#|sfQ$d7fseS9(!QIjC#ES3C)H3{%W3a~ zsYHS=<$qi|r>I^uzxIc;zI}YWsT=*Cj1NnS^^_YZZz^i73o#k;_mfy?%s|Y6LNiR} z!HP`QxgBJ7Bu!3xumi;)J(5OT`;LMM-u-knjEh&W@fN_SQVXnKZJ>^BrSaW!cG5%RIsjtM*d#}&q4V8@#Yv{J@ zKSk@AVYCaZz@aiRmk%l9`}*Pwxu&241m7YYap0<}u--S^xlPPoK}cBn4CiPw#smq8 zdp1w>oJyko(bcy8;~s%P84bJuRe|9K-=)5GNsO=w$POTb9m$DhG4mi6?{^b%-wWmB z;M1*;@e$jg2F2zj9irE-xM425>@}n=jkjo8;V1M$6u-ARKshT;^r}RkY_s*GMK>$N*1ksmVsM3 z?vbCt%m`n448xc&u`C#!WP~AnhmV_S_!UZXs3PxRqjaH&4aKY8YrL4>UN1nE;D@cc zb(-pU*>`iP+wq*?FRYVF7=LX}TEuP@Ym)A{000YdL7$dnltf%B{{R3#idI+ycnWTa z`Js%cDZdmQCHjZmWdH-#C2&SmD=-dD@`X?Kc>=r)O@fq{Tmw@wGSeRQQvNuIPg1pm zsE|*=dHrA~5R8=KFtGNttMM>&yXY7)^J!cHMWW+YssI3<(&4D-l=mK|;C9VQSlM^j zDDo>1tmWNNpcm zevas(ThLy6$ECRIX%=_PBqxVsE2LQ2P7pR$f^`3wsDd@(l=KlO?HxS_;xz4#Oxd?- z7iq1;P#jSop3s(u&Yhk8LL-VK^kLqZ_3$|8j$a&~>BuOv&ut+MI=^63D^QGhIL}Y* zI^^=(TnTrF>Vd{>{J@i^!MmC-{Y&l#%D(%>;7Ub^gI5ox>21|UL$YlQh?!@gEJ3|H zYpnJ2F2Ji?t~2AtAEmc1#h;l(Ox<$8G?|M8c3%&2FNJcV@ctm<^luXhG$(w`5YlV= zG|05bW{G;(38z~%J#zqU|561#H{5IO*Dj z*Ju{FsS)rb5IXO2hb0AqGiKUoSP~+o!YWsHS-9C8iRmd1EGbPjncaIy3N{3%hE?fRX2qX%!tub5?ROdWfJ9SZF2x~|uag5%6{ zv21F~blIGuF{R9-f|xl&VJ$H~YY?d_6bq5GDfBN{Gym`$SKJ}(M{@1XpN(w0EIbqw zD9YvfXPvR}bzg<4y4vX|ur)!X1U-XEf z^6{@19Ds>RPJcUN{+_)%h{TV0`tt;c-kE_tPs3}KmpRBPJQQAar)w_aQQVPKygXQ@ zr978STeM7P5K4BGxtB;T?zoRoCsA5=WT3Il{Ql}F7UeXRG&Wo821sI&JzH$wSq zDAg#{?^3ROE8>fekC|4hr1gE+o~x%$EYH-JZ7AqQvC~MftA2c9RjQ&(*YPO!;`jz+ z+zJ@zj0cRYA#b`Z^8z}r0jGIDDqhk?U*xasT)Apc&EcL^gQo5yWIhf~UQ<}@ zPN}b)7x-V6p5?iOSZQ_eBjR4kG`DIKgcAeadqmZ6+CJ!s94z7mnjAH2LM?6v+VZ;W z1y!q>I%pcq4z(Ej&ON{W83aY#+5ZZXlnY?jgF@bZltd87NR@@{xwHy_q@+u?jMJIy z85*=7)+qHq@DuTNhw%F+z96|iu276PpBQ?EGZSUB=Cxf^H`|?TXCNY$v5=diOAto&T}1T}L~seo*!t)&oGxfUf9`4v5Xy zuI!^6VP#Z1EpU!hVeV84ANv;_66Z=y9v2!7=*9!{t<6pt$O&ye4joUx^V&U-iXMf? z98=Am0lty$spD5R+rtw8{`PENlWIJIwd+ddf!X|hj^u(PBYp(lWgy=@luT3+z=T|3 z{Z1|^6#+*g`=A{hrZ5Y(3u4|rCdfOW#?6(f2(1X$rYs@pVC_}`#{kfUmze1q7~o0I zNT(XH-(caSOoIt*Sf8eYbn=+-xWcgD9B_=XE~)fOBUE;qtT-d4s5NZT3Dg*Cq$fi1 z9_71cmEYT6hCHC=>V4&*sN%Fm(gDJGL z4R8(LgK@+9X|*jY^D&(`JA%9nBsM8r+n0`vIhNzJ_sv}#>3?^&xq%*m&(59@pwe|Y?uGLw`{Ws{ncDzzz3Y=s|*mRoV4KGP|={qt3QWq7@jb(DL(kggN_n@A|%=Vgw0yCQgVrj`ZGUY`JX zDslq3OZW=m7c+)U8SzXQd{fXrA$UIUXE+_d`ybFS^^e&?q71nm>*DjlUF;7`$#kT! zAUIFI&hQ^bpp-=dv!nsR_D8Iu?%;oaRTPPQ7wawrg)&c8MbH&2_TOsCf|CaiCFU7v zwRax06xsKZ-`iwlT__^?$;WySe~4DvBGO|;!K6Q23@*w{LEm=B-* z$N04-LyDte;2<3;cU|C=Fbhm4!nv74ZjbS-rX%GCZ6Si+3C(UDLA^L7+5D!oCcGC8 zWe>_6KV3)8$4(5rlI3~ocQ5PDqIF%>ByFnKT5#AFC{g28>s-_Y!!q4K8B?!LzkuZx zap*T0gUgx5M6$_E3Z7KR0MWJ-{7iZwq!xYGs+i#uIGmG%_{fUk44L-74C=$5KF=2C^gIH=z@}(y-05hOjQ{forV>j>63B276Ky8USExO`*+O zIcKwT8~T+4l@DuafJk{DPi>xWiUJ4_CU`I^1c%CALx@%wBE?mGJY2l)oCg^c)1C_+`;$86pN@KYq=yh2$KzAP-X3X1Z77P=uZJ~#N z{eT3N(){jwN|vAt)uq2E<$xryBlXqWfc*m;2Wz2gP-{Zw?hue2CE}uBK@zSFh%f*E z0|HeK@advfp-!~XtCxdBa(GE*yHgg(Kf;NWP3+zCSftx{#t;BY7|@G&)F2oqq>aJ5xapZgIOIzRQ)ZEc;PIgE zO{W;#dfBK9YXB4$+C@0ioA1D*K^(u5@9-aylc#b%??^*&(-pbxFD&3j*f&ehm8e>Etg9;Cn>rnVTGR-D?3FiP54*`E^-LxQlU4acqOV0T46a!|mXYx3ra6=^ zi$vg>KY10nQ#-vBe!hb zJKFnviDs>9up~h4H4~F}%}?XYr&>(vv2i{$PdJfZs`wiWX;AyMzJun_2$ z4HSQ)JcQtg0>(N*@@bk-Z8m(PVgP2!GOl2>P2FhMo9ckE9dm;(HY7i*bUb*2+GA;` zLdkvYw#Qk!5P1RUgUW7l`ECxwuR}?i-r<66@{Inz#SdF9_;T+n!f3vB*EF?v;JKG+ z+7TWhFk|fPT?ZgdD%iktQ9R$w>DA=>V1Jy4Nu(BGC69B4xpY(enNtiMG!mD8- z;(ZgJ-MVQ+%Uzcb^q4RtqEN9WlfwvH#RGhNfaW|)f5*e_PdHky%9hb9? z;Q1|PL(rkJ@q8f@RTk|;$_6FQOQHZDsfD-I!Ozhz&eoeD`eJ8xX9^ZLw5b((F{t)^ z7~(PRWJ$m|w6>dTMn^BcOKF!WE zK6AL4nXNoFzB{k*QGrmt?5w8*!^jpYmKz_)EP1D4-Bc>T9^8h9Zw6m?(b^u`GyxhJ z$giBPxpxlwSI z|1l3Pwm*>>Sir5a?0QIOEQG3;M}B=(i#e;(!lUncP91#i)_>3xfk=Y$>t)WW1X2UK z)sV)&0^a7{hrWhorD{mCF8INPr&}NjIBJ)_((9cMH!>ubP4T0wwr`6AkJSr1*R+vm zakZ+1=2+~YUC32sf~hYn(W{^m=Lu!3)_GRd+n=gb>H=^aXX&GD9rE)ObD~EwcAw=R z54p$?NV*%Lw=UBcPRC015KbDqqq}J(-ErG$ld4{n#i~0rJ4IV_Rvk1jWlC&B>+hVt z^s!6qK#Cvvn$dUFv+KX`21S>2ta_6tT$#&el%1`BKM z5#9@*?NLw@V3c8zoi=j4we}=Vbxcc=cD~QoGJ0|hIEzq97WYp-)exJIz_MJn4LzE3 zTQ&uVJX3)a8A&E5>?$jN*#eo)#Zmdnk;aSq2U#3E_sXtO<17CP8K0AfyQWsY6b-rj zU?>J_h;)3un^WqhpNmD|a~WF{zn`Ele_sU!wWRK+E1y>9YGW}+6(vVd@yI3KG1-mC zVs>Frq<=AYyViPqu~^fc-z*ptGr?}9AHcQmlukokY8 zIP}oq*LGjwZGjLoL4O;;GvjSsfbqBd2}2SNvNo$ANdKGQo`BEJz)_%uWR$^IN@7Nb z9U}nso6Lbw(>(mwi(Ek#Fc>Z8@{Uqs(Ju23pr45f5L*GF-w91Y03;>i6G|pfqPoQ- z^#^dXycOKC_p7Uy(72VEU9(*%!vqsu?zT0q>EGDe3}$sfEg?@nwiZE=b0$YUxN^~OwBTx_r62$R zBx(RF23yOU%0jjiDBYT3a45v(Az)Xw4&ZoaM&5w{00&J0pSNy8e*geapgKkyHH|0c z>CM$GiQ`i7r%3I#Sjx4d;v9GrN_iR0$I1TzfCoBb;z~h$79U*lL)NQA#=UMpe|i8D ze_io6`S8J(e6o{q+ockldD(2!z+%E{{#3o zIyrleO}FPrx=@MC;7J^oxHkpUX=xP|evw8BYvZWcgVN4n_RKO@6Zn;YD!Z@KvK8J) zwg0lTA(I*rpFWZkcO!|Lt)t~m^fE4GGEIG8l#E&KL->|6J|*39K?21iMh7V3^U;orWARpA^tbblTc25LA4dmi;af>^UXAk$-iJ@Pr3yBx{xhC znj?br1F;eJ73j4M{6oPQh-{>6YX=OpPRrLrKTadD>B`kof09=TR>FLh^V8}&KZ1Ph z<;%q^@cGic8PX=7p)Feolo5BuP!389+x5KImltaz;)fa@7LbnMFj0wK_^o?-MqGR%sdee(jwwUIpUhx0N z`!N8yT?{V^COP(wX*3+zdgImfc7*T-G+~l@D{tRfPQMgB^A~*VGMulX#-k9tUVz?) z3P8jBx2h~o7r2`1n7Pc&3${b%zcxrQJk87zvrf{W_=5_09rd1@I}%hbe;!>evg?er zwLKEs1WUc_3Y7m&wX)=lD%5S!0E zxn(7~l#*&eGM+6JplcmEWJA}$vSZtQis6*V!;*(Y3n?2r*KO9b9TyY9=#BanS z3eD^`lV#+bxwmu!#4Nt|aphqY)uNJ_jBzP4_8&w9FcOM4B(qtp@7LA@0&@1Nn8F~a zSKcHfE2+}m{4|YNZ1b-s)Zf)T|nMoz|&vl;P z^mj0~(r8iYjhDIIi&mhKwgImt^3t!ht%?mpzPnFi_c~H7l;A{Jb0uJE+mEgi-0R3G zSWOK={jqTHG(3kj9Nb*&@m?vN56Oe9kcLS*l>g$#C8RM0Gu?e99wO)pkvZ(aVi>q+ zG4M4vzC)}mKYgFib>XnL4=fRIv7X7dj6Ffqd;VTvO#&N+ zGjIpL;avxa!)q~E)HJs{^LHM!Vhvl6F0MeWPH^Y(GG1h!BTkv_f;vXsfT0j^68C~1WZNN&n!M~vgQm%o$PU=?DAM0m{b>kGQtQlGqv z;l6#g!?%EsTtMv;wTd-*uEi?AZs>-J{v^d9!HZUh|CSXshf(084;QUD}&x#2$Csq7gK+(Y6P!@_7j!54A#mnOfgIX~KQ001g-L7Tia2ra2Hm;^Wf{;E{~ z01h|I$m3>z`)3~o*qQq+GB;QO3TXm!RTr_7RaGf+P>ANf*^tW2p?JnxiXuOI8i%&a zMI<;_IZpyY@0ODLM&+F3i{{xVa4Y)0mR|i6`^3M4(;8(>$+X}|@YP(7?}T^lJYD^7 z`ywr0!aWC!%5QSR!>wtVYs1pF8S=EwoJB!n)-=aC)DF*3L+$R&q{%|ha^YqxY!6JB z#O0R(9W*ZB3a_k4)^8}F79d9g1!c?E%LkMDS~da^G3UNz?|o`UwLr&s!*%(n;9pmg z?VjeIe63mCwHWTmsF>|1H#C=j>riAG#^>fQfvew`V7jieMR(-8(-V~9#uONg72v@52EE=u3a#7%HoAx)l>BS7hT`q+>u^!how5n%9S?E|P?xrQyJ8;P9$l3h zbMQ2GC=*F`3Qux|*@RE6f16pblS0h(;8C}Pk420dy?`G)X{Kp0*M8ud;iQv&@|{l= zR}68|3+D=`YQR~=QO`}WIPDQx0r@XJJ5smRq6kyj9kkPi8w{h>p>?^Ru_qq_)?7&6 zl<{CGHffV9oOtxfdWMoWW$^^*9gFbDI3i)oOCLU(VJRV%mX~W;I$sBg9PNv%-?~T1 z(B+oQgtRp5;5~tuVR^6EzAwuyPnH5Xr5O3+PH^K!ZJqq8nX7|s??t%b>fa5rky-y# z&meGPoS2!EY?m+%HJh;_K{}YVvkM!Gf}+wK_Nndc!FVq?`9Hq(1#G1I`+pCWV?V$& zcj5+XO9+mmAC`NvSk8*$tL#tr%qIWc0Zf<;JgfDdKH_jp7i>r-if0vvAH&(-^W4Q< z8!driS=zu+hrO8#DgD5-th{hGU*^#MwzH&Uh+WWPYcg$1mnhjLUWApV9=act)Iha* zPfkubS`tsk#=4Y23h)UNcb+ zJ6(LTP+Otgw5 zb1>8WTQ}|>9S^;G{kV;ANb1rr4?7V>sSr%soN$U@*-?FCR-r-OT~Zl*ueVl~t$@$a z%CioseAUtilNf*xNQ;b%yReG{OYQ&6|2dwBZqV^cw~75WVU1=5MUnjj@^JYe@WWyB z=j>I+y-Jdj;X2kz$yjYP1{?i@ty-y|fW+jB5BTcCDMBqV3uq(N!~jej@VOwk|0|-l zaq(0-rf5ib~Ue1}vTh(4eQ#cnz-* zRm2=>SuT8sb~RQ4*pLXO?FI2@lJeqrd3_qK%>eI<4ZhH7n-rHiq5CBuirDSDy{J;- zHy10W5Fp?2+6n;q)&Rv2PJInBiwh(DhleDB$u;+=z_0RS+rffi5DP~nGkCqXd=ayy zy*IlFKazZ&#Sha$9QDc@!J?)FXArZ^Ax9joudANr1}eKm=vcIWun;v`S$fDVrzJIr zswC!OlU??H1l$U?5i_OdVj~f7(W0!8d`^quQm*okWrmVb8+H0Y+Ad`#Snj1mbF4dn zWzElt_JBsT3kPxSJ0{Z+-VLP$>Mc^Stb3thT!P&d$FdXMWcqb{>u&R}U7DWwS#vohWg=seN#not{&)b;Aewl4ZYZg&hba|j@#b`?VCMp2UHZ_eV%QBH;*j2H!HW@6X zZd6TCSD{$yaTJQBU}OEY^4lS^lY6czRAwdNf_C_D*ttn{U&u;$tHzqUL>` zPq0d8{sk$y@hW^e0zr#YM~tW2aTn4w**&vJ%Uh zhJ>@Cb^(Fh#sd&<4;B`gMBINAcI*3HP$EM1C})E9Fu8?+B(41v!64ZA!K!eS)l&rk zjAA(7_rse<#7~Y7qi007uy1wkQTyon^5l7M9&32Lno4bw<2S+1%1aa!17O$gNaL=b zaWGFa?!1IfPX56=TF24KF&mQ$!~>>_V>nYgdT&IDm7XI*;51dO+fqWE8aJI|PN5r5 z{)Y_OzBi;_&s20^6VlqUX+_6sP@`n+th(hC1`-FU-(r2nf57bHWp$p~WAa~WOIN`D@lEbw&ShenmB>$e$(5MVz_ZR?P#K4) zcfPL5&Lxz*KdW!2NJ2&T2r?3LfhAALqw6^Es+OAG6V)-Ugvnlywn7?}V<9za*A{~3 zp?Zazj!)j>gPsu##&N|eUV1l(89xBi?TfWJgjxLj6KhM!LYRF|W}Zi}kMi*JDrLZp zHcaqWzzoqIF8s;n%_AsK*U};r$zRegfB)2?eCJsgce{t{LGBudtmV0i> zb`Tx?TZ*dXHnk{nyI4-^NpcvFWXPK9l1{F2T}t#-2ZoKesv@rT_oi+of6y`t!Q*wB zv}QAkm?9cW(_|hkF$}uKq8@p+R^QYs)nCSLGmR4`&n%mlt_(cP@SPjifn>C1Q)<=O zD^e`0?w$j1&e>of(hJfdNXhP}`E&sRCz%SV_Wyg^aY{j@FYP_~3+qtr^E8r_IcB(B zn9i7{c1;{QDZnfoyP8@HK3`z@n)3n6b4o*T_RtFjf8hdUXS}M9+wDZz@9fvMqMF>3 z%SPyN@$sP8a(vj+#6BDo+%W9gpw*G6qI^P|0>~?GC3h=oHkYdcegrMKv*@W4&P$Hs z5s->KC-XpbC^78@Mu~<;!I<6Eb*(3aE4Do@o7HlV4_L%XSDce6^4yxJKj1okdu5DH zA>7!RkUyKKHPeXWCZZv$$#K?OyvayfIXn9C+O23oZy@_bcgMIy?%}_AQ#u7h2gUFk zw(d5L^sS=HPdwb9woAeZL$X;xrGxO!<)e+@$|Q!`Na~Nbb5t~2DAj^xeQ3L=mRHDp zu>lF@SQZ|OKn__!P24lH5&o9)4k&@vhT{SxQ~uxT4u?osT3GyQHntEcqE8hFZyhW! zn-P<_@S4)}co6t2x$VRuTIIu7C)A#~74ur%Qek^t+6?&n8Mhk2%|zWh&8I23HKy{s zp_Z{1l{|dgmdxV^a7hM7R#a4ofpQc+jEf1vY0#z(Q*otwN56hcDB}BS_y4n2Fl(!h zR2|`!`uuc7#Kpf7W?Jg_9KMT0nc>CLxA-xyIl2(C+V*sDR+7&*%zApyqfh>>oEHAF z>#Ci^VXi=+8%aa_Uk%Guz*5QN`0JRvo$pD`w7tFvtau>uR*$h09huTZ@=Y@e7rsJm zy}{$jp#`ToI&m!Jm??V%W=XzR_ikJs0ObT_$)HjOy>dvg)X4PtJ7Kv-;-@G16TAR2 zr$qMy-*P1mo~AG6;^qu$cD#FH`qsUgwH1vv4=_ipuI zKt3R;{4!zYL;-LkK-gL`^268Upsb<rTDOX}@5y7tztgGn78&X0GwQ}%#cN2vNOTO8iIUMd%a$j@` zjXI=#MFe7W!d?|yWe?i^^oGJ&z1zgQ#a`S4Cv~m2@(dLmfTQwMjvOcZSGM9e4$@UM zMdcsN6t=<=02N7v3}L?Su(y)Wmx-hXb?-2zAK6fy0dPSrAeOGNH7AaE1P!|wL=Q^< zvwgMX>*D0VdTS)e{LQ_qc5DOtU(rpmf{NGx@Lo%Ke8MXK970n;6k1{3NN%(A)5Vmq#T+}*?J+b?mm9^+uaEEUbquMW6FlKyR8%G^xrc!6?d9ERhrSHy!rrr& zF-xW6BomY=yorkmS%)p}E`rR>W6iR6*1FBe8iZhL+-v*{6z%!F)HMFRX@CI$PWMe` zI+nC^4mMoNVPwx;Rx}2|P_pry(;jD1n=Wh7V(NoqA77CMbU#>y@)%ta?;#sd6i8>3 z>v(u-AYF^d61|sxLybL6-6O$*1WHN zv0mqn^fRGvn;V|4^;Q1TOD1H9TVo z>izZ?G2+_w7ORkr*N9ZljU*$`Vwgj@#h$6j*SF5dNCB4{TqR-rEPc=J0#}~;#WC^@ zO_+*?%r>TrBq0Se=aNHAY&y7ozAJAYx68$Nh|8LGQn>=8d|U;HTXI2?FiRC~F3iN! zwfYKrxVlEeGxY$#K7J-H+e(4RNc{*sPU3hkR#ynwV$qFg#bxZTpLn++GQL}7dGet4 z8^rrqk8_7#mKq(fR=C)ai)a1UC<$!mGRFf_^SCBsn;WZRE2esjs(9l2mkEtr@(3j> zV2gNRBNBeXsB-4%oy58+I@bVm#|&3!{-okPAGEf20U6X+7{04x9ZA*YLXxgCwVZ<$UHJ{n~$w5n-k=svK$2;M4J zik_x(Z{=>~U?3WQRM1Ncgu~y$qWYrpHOwafSsDH~1#r3w&J^C4fwGy-YGD+HgO@D? z@JjgB7<;h~)Q4oIjLA9r92nE}Lr|(ZXmfV`;naKxvo9+fJm@gZYr3<%V$V;S%%SvT z-O!Mjc4P>$44CBeAg;ty+BPL_NS*xdF@5)NTZG%&JCd8{8%|iw4w%kGVM$=&N$ie} z7dOr`dJl@nhsG~Oc7m9r_O|nNb`WH?)FS4eb*E7^)9X1chaF;tFKQbyKKp^}Ltgg_ zw40dv|<{26Xz&SJk?}&Ot!^}0_ojI$j0O+at5Z1_jsyH&z2!1b) za=!~QMhWOobL98u1=(~>$9>btIG4M?~sWO*^-br&{FE~ zP9mGF8`Z7O<86}0Hzs#7u2Zbl%|R86Zlm*$Ef(#T(=k4czepOeo(~%;uDksZ@N0bb z+2T=@HPVig@NeT^G>81Oo4_Pe(#23V(`S`G(@@~N#>kRXgWkihgClgTtvdy-=SKeU zL@(g*Oop6#E(nrrz>)k>^5X2!$t`*+Ed_~;CNjR6ybC1&2jZQCK;^}otb0`RXReLQ=WPOFGTt`Ki6(62|(wqlT4Hm%?{4=XKSIKIXo0a;e0)LYS zxNiZcrd58O|xh! z3_}Qz;?dg034aVPI0nmtP8Fk;?B;GO7Zwbd{NW$3s_oX}Oqg)Be(*j0o)nY4)X9k4jQdVcrRF2ln^z}-$QKugn|EASDJ=byxn}_#mAUXiMHlts$8b$fKfai?jVLy4Mpq& za%hfn`zH%E9A7%omoAM;doNb$O#=zqq1Ts3#Q~>pqAZ<6fN-9sqK@}2O*POm zQ<$u`*+;%GWVWxx@Gkt%*=524g!uv|`wv`%OMG|2wZzW52c$sTKQPbb7YJ59E%n&q z@;1E$=>?y^?i3te4TTkv(yl%~9iys8`h2km9UFD zs2k+R_rC@>#P`T4@-hHLZ~r@B;?F~1M`>gW4Kp5bOKHPJjfW!ie|H;LI&o|?82rln z!?Sh8xK8fw=*lGu8w_D1Ui3+eVQ?*_e$1uy4itf6l5h3t#sg_0DUdO<(=b7mG)bbq z+wNh!tfQs~%|`?qVwPP|W^v$|ZW*hon}p!75Dz2qeUe6~u?2V&t=A6o@dZRNKFAL;5Qf%7hW~$wY-%F~f;aJgH#uRb$ ziTN*`Kujm>e^VRB7UV-U>H||pa|L17i~xoH3@L#GBP^qH+uy)D$$YWFu$|WhXz83z z3udx9ZPfHyNraL=uM)tSK?WMqmcc0@j|xU2(GTqSR)gxB8I<;A);dLU?K_^pV2R&h z0BXAdgs7B-%CgLcqKU+27(q)jAp8hkvr9{!3uEtvE+#7o=^1c$vX&*r`u z##f@QG&`}(hte?}`;y2^XI}tE)+bL&M^zYkKwg*d=9sii+IPo3i_ZB>uAF~xM8Me~ z9H$qDhW5M~Dgde;OG-G9%Slrc)Ii@zzi%#Q$Z-M=afdj2AL|l+SVELPsM=i4U9nZU z1zMvbgVloKT06rm!E7R2xEPY^cH{?#$G37y6+&$D=j=N9v=!LgHRok7pgL;<7x1ge z?{5hsQ`N)s)EAnR_)>A&L?2DIsuck?C79rXdJBj)+ZM4g|Cxn2NeZg*8PoY2iE3wr z;R&P%%Z=|_o|qb!1F~iHbVpl@)DB_W3)M6H(tleL(Nb9%v`4 zFAKiHhxN?kt<(vL2;IiGNbdT@I3J`qdC-48(aw%LU2o$H3sjk+Dq1OT0%j_)yB&zh z*+oy?ALP}!jR8VoW+c=cfAu^%ax>=jtT(OfUc0{6i?5K+=lC2Cuz&AxDAxsoCLmoB z1aMGA#$S7or$-ped^9XNGw})gx$t=sax1+jC!_MU2FaLhvJp-}ix)`^LGsbELw}*wawu#vuX!6o|tZbt>piKr#xRx?$%m z(W!vu?7ce`e1?$J;5F6ch4EmMAhSj`DhdTwu!@KDQ{j{^Z$&sY6@`@1OA`1d3Y8YF z9p@WX*r&!4q6T2fZ$Yq0(g_rN_2L3+cqJJS$$*|>wJO_d7~8y_H-v06>U zlAwMG&05S?s$oQQ3g?>r1Qb%I*VF!tlSY?`?iVA}%6%pTWzbn|-t!)FV^sudO^M<9 zu{^2sq~%(y%y?63vAZD|mT9%2EIeS>MQI89bjz6l*zZZ;x!!o93TFnC6uHtiiI>?V$US48W=;@tyG28B}@6qCyiBKv5j^C+EtCIK!UvH*2Jiob~YIXkS~ z0Lu4_gXJTQLpL*mb^(nX(5-8KONwXehi^+r`EtXuA;c%ltdle(^q$wGc_p<@K$}x} zIGv@E)N0os!4ylX0d{}xX;MN(5h>y z;J3`h+HD5{F33!2P*tQg?r#O z;x)fsQ67VoHQa*a)5D(FIj{d-t-FsJR2mlu!a*T&L{&@>SX>Y!V9f#B;zmF4e$?XkmHX5V8cm63<(u+ABI+uZg7ZiE z0kJwMJi>-q^HlHrAOFa695J`wGH^?SAx})h%n%|`CzH0Y;#WKR5(9?wpo`lGb@;0+ zfPNG6iP%lQ?k|%P0XLKv7PP+C{BpZV9jSu$V*2hhMJwj4kcTz_!BNG$NcuX6A7Xx4 zHx2sd`O4NEpo`|jwQZY`Z|aq*#e6x)K+}(i^1X|3+TK%GfPq-g+#G=OuVJNbIfUJx zVE4aUY&uEz2S<~K7;Dw77@_eE+Kcexvo!3pN`-U;kSVLA3)dhV->e}NtN_V(1Q<#h zV@pb&q?Vh1{qCfcTb{7`2b#_VnX-A-E{>DJs^n42DW=VFd{U3@1jA;TI6{EW5~0Wc z7bUV@7w3xwF!BRK3x1SJ4XN4*F0(Ks^i~O!vD~ztXFcV;@SjP3M5r zvd!hZPUz}^5WPSb*ie?mq9Vx$7USPF0r$!68c^r5CyuRu>|<3N|Hy2-SJtW?o+nE! zZv_}poN}Tqi?v;)fFBv))8QWu_^t)FWCJFP>zLuZiCA`30qZ65Q(tq3mkaOt_GEJ_ zZG}UoMsh#D6H9|OGHq*%o{jE3J@)_b9}JCS0%K9;YqP-QlNOmhb~IucC?jocslGr0 zU|N7`UwL~{;T%tY_wJg=bCjhPd+Z#x;igr6?OmA=Q)_2Z-~pcKyQ9&$9Lk9kw}lS< zMsVybg$$u6$jWnEaDEi{;H+H5_dtExFW7$A>{rBG zrfU#MJI;=WgCHqT3>7MB)UR_WvhR{}M@qtxlxb423tXu@e3^gOWze(E?zyqv!wFfD z=f_fMcr&Yt96Aiv@)Kh*jpy<%7Q71z@0oa^n_bGOHPQxgkbOggl)DKf+6NI>LJDOU{!aZ!|6V~) zhx`QgrXq$dyJi?S22b+z34nfs=JUvydnNOquu-{ytC}MPr%Ph;I z68h_Oh_fb=&Zpf9gGfesHVlyg#<4@LlxtL`2Z_PI!OB9z5N!!?_)4GZtQ55UJpb^- z0WR4CD`WQDOmzW1&c`X;HYVSHMxISMo%18GUEUG&MNr$ktx;cOJf^p!c&`vUyQ6Lt zCk|#=fUPlHKPqqvkVR?DdB$j>!oz{DwX?k4ZOsJvYqc+}gUP9jfZI>l&kG|R4)~h% zY`1oqoNS;)6Qt(otE6OXZKCo=;wfu5)QYj>V^Zj%{*b;aJ_zRLms%}KMUe-w!dV~n zl>Z?bW6Umg(UUd?9Pl0`5=Jf&vU}3DTX*Yqb1QhRi0Ef8dW2Dp8~z-6_TlgD?S1+= zZdIz0$P*9skJ)H|j%)b(ZtjU}@~ZEMbm^kC=ZjK`npyMHJ4k#=to*B^W9rCE2R=3= z8&=h)2tT53U@vOG6=A!xkb`851mn>ID!RGS0UF?Exu)#w1)_>sC^c5fhpAU8yDu5A zfx}^op%__|Ts{#EB~}SgG;(`O=u!mOAY*jqKE<%b!03Q#D1bq>gWN&BizkbV;~FpY z_<;WjV}kx|!sTHSuCg!bY_An*gA1QI9FT~1{qV#}m1@s;mo8LGmJN=fHk2qG#HTHN znFpE2I=3E}h5+Ipxo+AaE@*^$PPeJP3YkeCz3OzH`ndPitfYh_<}-hHevIXJTZwjk>?HS&^F4>KH`L|08Ep@5!snd!Z!)S`VGhtZ$}J$5IsdYVk*nG zOyDzbgb>K#q-Wa;-`vzmoL4@p)$5mp&s%_tpx3W~tx_t0`g{RzZBy?2F!kaIogZcq z0Z&o(Z`d=9yLNR1(HO8_RbB^%zgU}FZNqA9NT7kjDWExP?2(vL>~Khf3-8`nf2wf@4*d&t*CW&^&cLaD zzy6Ux_(t_mcMr+nqj`Z$8epc8+t#jhCaR5|J*23Ezh!pq9CzbTPIlP=kwSgW+%giK z+-4T;5AyHe=Ts0?H!8E}`C+YKtoXdZK-WiS#vE-_^v}GnzyF`_Ua^%d;A7axRAk?8 zH}@k3P#5Ndy+$;CQeG+2TBdyO2ivn)kIh2E+IfxG0teMS*FA>hQ-*nml^sc+5J>sWjIzR4%0>Ul(8En#@tp6ED(NLGp4WvvbGM?1JhCbv=CA|rYQ zmG3c6B(rhLd?+FqdRE#P)tK`d1A5MRrU(`gCc4eT;qeTQ_@~!k9C-SnMtRswKvI#+ zcuoNeK;~4$NOkuRXxzAZi+Ja(gv*3Rzf|(ML>55v?*9?>p0HsuqK2JC3x=E{NpQPA zCVtad@%qS2F9uUy1x%AtS>Vgl^_I}~DI8Zd-fvdlyuTrMsA#QFA)uK=S!UD~qBpQY z9dvl1YLr;uR@a{%bEeZz;OK@Qz%--jI^Vq;vpv2@bc~16I8&pue~nH;2d(mmBZFiLNPkou@_P%+#B_ZUNrYu?(*fUQt_|E zfE$>bclz(2PL<^{K8?0sr8tVALi(C8eR;x8y|bl$A%8xG?66n&U1KJe_H%+l@ni@> zknY5`&4irc&4k(_+*g>t#Gdg5%KFOb-;e?WOF_7Zo~`2y=w`PQvJw%MNsIet2U~Q&r$;Q6_Ec;3>OTrR(nenojhs7(v2C@jWQS zQF_9hca&P+t15=M$4mD|emj@P4oq9j;s`{PAZrHpTDq-0J+x(6iuez_ua< z7>?T6CQnMPLA*o)fFEsqt%X+aopfLB+SZB*VanAPeL<})>P84hxPXUB1uh34yHCs! z>u*}XpMsw)Zz5=sSHiD0B7Nf%!zP{$na!v%|>&FQ^L zORk|njuLQCP7s2KD}tQZ%|)vPYfvTFoowT3ctr7FzR*R8AtY^OTmrVFO<9!nqoVLM zi!7qhYpS=7B^m-@2WEIw7L-laGyO~EgLJzzZf5EQ_^yd0Vy5*R5}@`h0|EFYp^ePX zRw+5C^j-cpuWEA$=!S)p4?(Je`4kl8iZbcY{J6#HiY%<0;BC(^-1~Egvy)r9sP5n5 zT=G0lg9s+>k+G1Nd5fnTU3KG2CPcSKa)3JRAt{O&aaLs3H=rPjL~wd%T6);RRha?U zzk55@hDdMW<1Yav5n@*ESEr)c3RxGq zv*9NRX$*i@nLz)EVAo~?D2vMGOT8>>ho1$!&0-Ol zyJcHEUiMkomE{bZ8?%XZh}k_bDPqx@d!&vaP{3sp*aV2};N({XMqHbc)|e5lHq)eQ z3WNp*V?l1u?Nk;;@iXY>xkf7J?$7yJ*@2u>l%{4B!FfR1wXwo0jo_py+X)99C+I7c zlf%{mJgbR$8OK=!8~m;6p9>s^9QG?BcXq@gDEuM>(_F-c8@yK1e`-HtBF4roRSSJD z&uAga+|BIRb@AeROfb*1XmL=WqMwSS4C^e(qO>6+1atQ8vJvR z{_vy+WHcPzj8x15ok8r=yL?7W2RY*|ITW7I`9rtK6S(xipaCQXqD&a>*ca%0_x2aaF2ZVQe;^tewF-Ml}D z@)Rb!aK`r6=imjj(2@*z3Rn{}uCc9@O5>UsDU*QSgaU@kQqB6bYxDamuQhJ&%#Z*H zEBAbORg_b4BQ6t4R$M~ydM^DYqwVjTu@7y)h)rmGd5Cb*{qe~yDFR$`JD#m4nR8)XuvEyXc__i{(C_KxA|na#BqK2O%I5_Z!-?b=U;g7{5;xqd|#G z!Z|MX&?CFe6g-{@TJL)I@qMWEBj5fg1e+pGI?mzvTzQ2o ztVq#{K3@Cz_ttRZadcyut&2P0p1@+M;2?nt%~!%X;{U{>)N+GOkz$`+6AAldwqux_ znZchb%NzwMAgGL^3k&y8D8(dm`Xd>I+Am(yMSF!rdA{*{3scRrTb#F6ycy2d zdlod#x~;enye6MxKf1e^i}d5lgB5(GSvzYKVaTvH73lGT&W-h~1+yUe<;DewPHYIe zKUz2w!3*8Whj5d(Wv)!n97#S%secrTAu^gzp(r@78!~I7`L2y97JX7&6=hmb#nmdh z!1QvGwAJ#)Mv_Q*003XX0-P8q&lg|IQ^b;uI2~8hFA4&p zmQ$2BpB&YVgYmWiKT)V0PIzBl04+7+-=%TooiC{kZh6V)%agiutw|I#HiMtt>dTA6 zb~bs=T^O8}tXm|5#w3` zxgmM^;Sep-baek44upLRoGp`au*DAHiHkrw)5Lfn7GU#ozCtJxxr=B&r{`k~6^tH_ z+5ux{e{CEXs~*|JaZDN(8h$^53A%o)=b=JiK4e1AA`ri4m>-tB()B9fFlbk_LMvQ5^?u8Mp#dH&a zUl=YRDVPY5O82)*>jzI{t^w}ZFBla29yuvWu#HGJ|bdSRw7uIsX$P@ zqgA~BqYA%C1Q18B<71P5#Dnw>(hQ%F`;?&p+BDVhyCpTSooc|HX}%6^9^_yL+>~{! zOlH*PQ9DI%t;0h7g|(2ztceWAeg@%BJ@t^~eSnqq-*0UHs`8T{z(-gb)$?mscFju4 zT=d;~nacqHW#X%YaS19G>2S3D1c`>lqyLM75#At!tfO}Xy^60k2%1??x^Vc?tRj|{ z)U$Fp>|CQ`ixSl+cL@5j=Bsgb=btzeVRWWaYi7RF?>&SH-n6J(Ka4=hO)5fUaw3)G zOMEmty+k%IBKCuit~dQ7uI~}B*TqViSq4^_)uLFp{U&RJP`G>(a^w7SmrVOLSRxx5 z0UUqx1yoOiUU^eG$W9KxnNpx`QOEiHLr;ijWuFz?n|L_GGm&2YW}_WVHqk2)G!Qz# z)Db&5BY0fpwzIm#omN|bkSYH3ypr9F8o>nI(~@iWBl#KX$KUBa5(A_UWM6aO+nM(6 zamJM_&M?v<$BTX3?N;Z|4NO6^^R&5m~0kdk_n)n2sVtW6L_^Jt=x*8gG+a-03Y zoF-;wyY43hajmvbG}mDmW4_D=CmwqOq7qf#inW+0wFzHNZ#23mFrH$HiE$xLCN9AM zejmG9#b#Vvp{)J{-3Xb+RTiiHw-?`*EhnO<$aA5YGGtxm_}x4R5u}U|chA+&j9lUV zBtFN&Ht?Y93Y;O5`hwC5KdjR~$hnYms?>(?oKzam{^nBVW<>ksbp^av9SBpk)``J< z>yDlU_7j75JAy*Nf4OYwxwsWFe1LRhwleK+R4en7Dlm1 z2W){S1Cn~-ojyg0&lkM_$zFzyJLhU>9X};BM00Ku(qf)hT603s5y^pt(U~k^Fv6h$ z$`7$f_g4A|QP|SuIf%|k?*p(H6@<@3v9g{Aa&Lz6D{(SgqJ|$Hxlhzl&*#w+7uZW; z`l=bM!L&Lzwybdgv3X#SxY8(Pktw=@xcveg)7dr)6Tox?Ap+5R;@se&rn*4;xOV*D zXF|QL_$H~%ULPTDER;7YQy~Qp064z0D>|TBy|`DaLa)B;6>md!C{2|8JSXZsz2cDZ zq`8oCs#M7Ups8GMpB>6lokD9-+xT);FVH8F5Sc#%X$yi?78|U}O{5_4>N6GSWe=c) z@V}Dx>s59Do=}2K`c(-^VM<&&S5@SHRki`r1AAIzT{ zD}a+q{W5upZOfmb6UMdv@*9}GpO%pSnfh1<*)6^M`=2K*#S-foo0##WGuhzf0YqY7 zQ|hjfvPa}_k;?Kfkr&KxnpEWg_uc?mbDKORisT}YOTHvWPt{9`iT^q)yJ%EN%sI`P zu+=hzTJj}DJqt3-ZtD{t9Qr$`*FI5rHz2acO~&J5Mku61Y89X8oee3hVpZaV3fN8e zP(9~mtf%8H#xy;)7lf^b#y4~^ka8ybQ(EJ+>c(Y*-h4wc&RbdwJ~@(hSuof0j0dgbn(8%^&K zY3xMGy7kbso4H5oB zF1G~LThTXs&1Cae@h~`NW-4GLDstg2r}y%`*1(9PkX}?fF$|Q)->@#(Xyi#?gfUCBLeSa;%9VEh{DHHqQiU=^d)kRB#XE2g~`p}v*kg5yZP+wpnKvLLJxwLsizsR8`J#A18TkzNoJYJjjH+uC66 z_=mO4;cX$LAgHO?h?up(=GkaHe12Al=UVCZXl11p6&vP1Cw;eyi!OPlxRKR^uEoFk zUWJ_Qv!*&ULqPe;WUDU+03j`;+&1z#jFw+{jP_~o_0kOk+ z@US)k2MbDlOA!^tX?$r4+qc{0kdT{2hv}DYjqOQ*4_am2PP!|8+|Caa3z(!g6vf2)?*Rz z000TQ0iXG45T5`5PmdkQ+3*pD5`lP^?xFGPkf6J#2c{XwJXsi&TH4XD=Zr@3(&+qNkU_cqw#MBF{T?=C}ZjT2&!(nK$7P$aYLwz=B;RP-fnM{~>ZIFcxdPyi9`j zccqSo8Ut59hI|f>?SupARLBRcZ$r^#ynUawmMVGjwQ41uvn}GEEzsoOh3J3?RO=v| zZFL|jnVmrk*oZoxL-AF+Jk>NLrfFdI3dIy$m}FYRX#`{V!}dE4m6ks(<~ztcC0M;( z)kQlId&19<&~t|+H=hryTSWoOcj`)%kl4Ok&I0TAAZy8=D&fz#TbA`kHk+|Jb9*l%pJMC_r;ntj=T zL%+@2%@W1QB=W!7irCe2Od4#V0p*Db7At1W*uV0>TX~V0Y)oGZYCY`l?v_-KZl1Yd z%jsy|6|d8;iFI~84n#lfbC0NahKwnzTQEcEFnmdtlyono9*3RtSwQo09~Qk!u@_l z-I;j>Ib@ILirw}*K;8YT5;BnezT!nJK^*)a7sMoQy)?*Sa%HgE$%crN^S#$)HIpN9 zD)u}cCxjasn|Vg#eWy^WL>A>|($(X`ka&?o8A~}VP^tqOK?;XDz0X;(CE~|p3$lXH z5r6A-BOPBzqv^OmBQnQf29Z}(jYpY)sPT=US>==d8+Ryu%K#D$$FQ$M@kYXfgl4H& zB}vWLOc1^Kn5Zv4P=s7%n7Y2bystDuI~<_rZm6GQybK0lyd8M=P!!l>vJq~ai3n2n zjpC_S!NPA@Y|=^X z;95myw!tDr2D@`UWKYm&=;2DOp$zA9j=;jiO+?|OKo@l9n(B)ass+^O@CKE>MR9bR zAjaOROGg{VKyvBL$#Oec)4Dl7n%Xe8yIQ8m#jD*xAUio3*hYSk`-nqFnr2XXsPffA zZzjpMUsM!Fb%#yLCb^%&^}FB_{)Xn}qMBBUjD(Kg&pScI&0ugzz&q}}f20xgmd1?+ zV-Nq6*jfn6RtY7EJ8F&L+TNvP=Bm1CejDx*4g`#(3CsKfCZ zB-IL)hI$g;`T(0FbV62c{UK7jz|n134_OB$F65MHt~7P}y^3`BWc*6c2UkMh!A0Yu zt{-@}6S^GONsP0jZ)D*lgkH%Lp9WUM-||7D4TIyOyr74{{J?kLMQm!1=xJzja}}^; zD}4vc-&JPgBe$$;k;qC5I%C4`j%xxG-fd^0qyd4Nl52SS86E*py*ew~=ezFgu_{n< zRk&TBce+4p)MG4jh)68a*zh-1YMk|(yogzz3yHwJJ5sf42%ILDZP3cOA&wOD{Sv*k z95&yT4#$E2G!>!K6E30=OfB;{(i#Z0MWSEPP9a1^G#`tg!fl8>>PM=e&$pg@Lk$Zo zXYqMp)`G`IewI2PP8vyh@8SdHouddF{8%7DOKpiC@8j`mrj-LL*uu}dP#+S`%H=M6 zIi0$h0|7zaVK}f9EkcYMZrULqDtPn>Bcn+s9=_WB_kr?QZXRF$({2L{Lu`cqTYAFU zi8q1q`if8nF())k-4@(sJmZ?R1xPgxt*)S?T1wUgovmp$N|UI$7IL^4ouAwDDOOXeHcoouqveTD$g6`>!kWVoV~sC{Zk|2CHBw zi^AEf11clB+iV3QyaTvGQ(o#ERm@jY)M{d4LuOUPS;G1+&k8y(DQdV+bVeGNgG4aW zx^kQEDr87$QEQ5RA%@`Mw#g0}hndJ;ZfM+U?(IIOh0vSk&#J~I6%J!NN%^0yAE7b3 z1rc)7e*n_!EBCX9)2>lx_Fi7pU1AnA2%WC|$(np1NC* zhOtkDfRJIkC8X>;v`oL0bYD_E__={q#iRFH{0U)zIP=TR$IPj${@-oyoXteNO7U)< zqB4Ads}jT}a9cj+3SRq?l8|s?Kr^(}05wgM)#4-2bUes1JeRcP>I`Hs46tE8n`d2a z*@6Tk`tM8tueZ~;O(&=iHQr)jKw(XoT7i@+cKc%A4weuMipVFQC(#4oMfJ+_v28@j z4?N%0`N1X$<|`0641n5%MX79%M1vls1S9aG5R^S0kxz=G0TwmtK*5+L$A~nks`LZ@`~?5YllB z4dbLSCQh{TP{uF-00RPa7{DEdk61RKsAxY?6N2+*UJRTR1gHt*Bn;mBtQKQB1?(sQ z01Hq7pZjh?e*geapgKkPkg0w`6AE4a=|dJpp%{H2)dpMwCJWfu}?Q_rp!^TRzT7N(j^?n1K!cd*8*BBCn{Q!wJ00T?g%7{P{AM`8g1Jxu6GrULxehzA`UB&=M0gU+K;M~|e0itb)jo$QFxlQMA99MND+c<5)PFiJ33 zMtx!~*jZ>+UicO|91^R2b%Y0u9)eQ<(qYny>XX=>71`go!WVf3c#p%vWyqzJIE^?r z>~4OntG@0`r&A(VoC^oM@`}q@b6bf8Wtkz2pu9U;K2l{^y^gB~PS80R0UHtvL0sgu z$0Lv}CFexLPkCv0L8d*hD#x?f0w>uN|FjG5L0>=2<-dO*507y3pqY(&!fdC?IQQn@ zP~93m1~&1>;?TC~HZ>i_0_NT|?zQJ9tso^7^)XZboWra*YzB?0ZqMajfDN&!A{|R> z25}A-RA~)xYLVOgy4OGvTHmJv9V~oO9HsR`A*TE%S1BeEoiE*`uzS&-A8b+Gk&rk> zD(8>Gfs3%XEX0t^ItkhQ$0SNaBZf&c_mE)=m|BAnU~w^oga>?=2T2a66;1(812|ExfhNWPsChbFa{citv76Lb$XO_NHu$6 z_#wY?0&zL2Eskd4dEtg_@~$1d?oVN~o?!rpF2({fUAO3dtSG z?ZDA~bR83DFHv=X&8Ef#TieO1H26j^4=Jd$H>O1@v|&V53TF zev}>4)UNC5v%~n^Flz(f_Wu`E*IT9T{u17av?$_fhn6X&T`*^T*F*Jw!HwM}_tOJh zDrk^J49_x}2{Ju#_3}=&zV3`V7L3t=wKtA)uL(Ce)&^Cc*@UJt@f9#6+~> zo$%4Xt54xzE*B?EEzr#-b$zA0T>uj>7G5=TVp1=;zDnL^s-4kV{`OOgzr!UPLOboP zq^BqZ>U1Z#IlopQWDVL6tdY0enIIQD`u|I4H5vTD;^&ruQbFJB0d1-$Hy&-qRB7*V zM9*BPfLVd(UvBo%o14Xp89?Q^-#P_EzANlv{fT3wsZSRG{Q@LSdFGLD>Jez6yJt<%so-(k)_(^qEgny|*4ZL1NPYsWHk9^vX+xXj^G;Y9rcmb$*NQ#w zTg}9B;cjT#(arF_amZJM6Mis%vMg@H+CvMsNrs0X`2 z97#e&4W0a>Ho%q&EufxL+bQC)Tj2Y%uP7Z=|po;`->TTqRs+JS&X|K>cZX@kWh zweuip`Ycc@SN>!onL{NZWd!u=ACYD)bSC?a_yuMB+?DjhZ8o2vy{bv%z>@CGwYjn# za*kD^M2;OMX}?sZWt}0=n|?!(vYNOpx4Q88{k1@p-bmQlvfk%0x{AO*tXAU1C_k`M zC!~5iG`WGAJ=er8W#X&y@}(~(FC2u^ zT)z!$!|{3Gs_WsvvP(+gDP77L9e8C}(bwYi>y&

%X1PN^ddBkqALVt^!Kmod_>w z06`0X?}n=^mmYetaki~Bug1%F6pCA8$-l;Y)9jdPJUpH(QcG)-XZq3bIsEWs={e8y8 z{`qhS?jN@3F9@r)2PYSD{UqI(3JXTVrHUG57GOX6NGq2}>OM5iR72dT{l~eT=T^jX zFdwQ5*d>CO2=!fXwzB%VlvES6ZAJG>_DD>VZ4xJELS{YsLQ&fQc`I?qNW#wr4-c~B ze4En9hzy(kcQi-^*Apr8hMS1Z7K0I_f}C)pwy={9ppJ;71@&ZyBgxpxA~TKE(z_@k z6kYTj4%0kuERYud*T1YNEe}CmD=Rn8w8(aGz$68JLL>o^#;c*gci9?K>w6PijH?#N0IgGPgCoY6l_*?aLa$u6$IF3^QFd)C86@TwYA`zF0mi3P&Rq%})E4s4+d0E0X% zdibTWpVMhIX{>@X{b|me>uH7se6!I_=T!txm9*IsNw<9iTo@-6Gp#jVD@@!m!3-Iw zT!LD`*k^WWqBw1mpHv4*;gtD^^a?<5ebwKhy0ax&eAeX3Ui{^up;*{r{U_K0GZ^!A ze&O~LREFX&yx;Aifh2?mo_yh**fH<;Z}XYzB_uydVg-&7^3{b?(xEFv@2TbkL&4>9LzrAfq@K;AYU?>y zIViWclU0sgxxKHNjW!`fTk@vWAs?ZF{v0Q&a~lA=bI_tnWVwEWG~;q}6J^wE=iyOb zdIGWY<_DbSs0u@+c93eS-}iX3njfqTIjZU^mClRaee#3V9;*pjEE|D8d0*khi@KYu z_PREkvVW(%z0DL{EvhquPfa%Iw_eTbf+GlcMSqb42!u%VMCVjt8`@D>{KiDgehdvI?@u@HJ#KU zZYD!|B=!G}N=Fiw^-=ld512I#J`k#-=Zu2Qk|fbU*2|baQ6vg@JAPT-r9w zRGtUv8aOsS))$V;K}rXc#SVV-A-!sENkUN>Of8sWC6gNcotXxJ?@dPp3caS(Dc!nd zb2FNB7H(d4GBTU|_hQ#BCz*dGg3_KHWhcEesh{yXQF+0Wzfadf#o0Nd zPVpyESLdSlEvV+T^|kJ#lPDnmdS^k{I6mnvlg^%W}N$H=3)&hDQl&|F{tM0Hbi zv!gRM_P`GA3@j|)bXAM3RH#X68fJ(eR$gn=onszR1-#}6mP8_6ECprxciL*9QfV)Z zdnadKg;tBhg(l%_x8fjqZuOm7F~p9bS>_m(=kp_SJ*0^cWR-{#)mN&Oto*h_eY%eX zoR}h=DK}V!4#b!OFq!nqhz_rFTAC&7yZv6 zul|+16v0C$E-|fCEA;6CH$W1*DVmJ10`IE+E+xYp2}u0Q5O;?TB zWq$j*7v5P4EmTnhEW*^?2|={+=}^qQ(*yoL9FKshj2 z@e6?`bBeI*kaXL?XE+;U(=)2=k8L=%-V8Yet+%GDdK2E&hc|wbcyA&6V!Zz*4Rzzl zIN@;T;e`ZGg2D0jHVFS*YKwA|;0+l>YFSDQzHRXohrn#K^{=A($yzUVK;#do42oZ6 zWgP3%^oC(9+lIeg0FLu$&C%hq)|ZZyUWJ$)S8U)7$o*@(C)dv&9@%-q-RAk6hdm{} zLtj}Oi;^~{`e3A@m{(;1qafc!{=<5!(Fv@{=8g5`=AX7;E#tWabFeCb3m|NmE)2u` z8^Yg~phmRls;7lSL6@C}BbLLi876jn57;khD@n7211&Tg;P2wp9y({}R&!{l#- zE8(})@K1{Y(1)ijdY32-0iPmPR-9w7O#-|-Ng2=U_Wh9!N$MBc;&!n^=(aGkx{Zu$ z@r|XpZ&SQ)^`F?~OjX+E=GA8(a)26x7q+K?SmDDK#ZKH$#Go?W~*5`x~ zxk5SC=EnBC6U_%n#IdL?asXV*x!=oW?L5);$b;KU$I+eXJnpfDoWWhhhPIJ}=$!IP zIao`>O-&$rm(G)WV5AE8t~pkvfaHG8nC#^%a62Zzf5TMtk!CG*)YShMj~6mSHQDC$j)qz3o}tzYq>lkQU^2^?jtwx&G=BSP9f#QhR!% z_TMy>zaEUhH!#gbeh#CVh9)^z+(XjL`s&3T3re4h@f^bU79~%>8clf{j9Cd9sSUb( zudkBhlbmYxydSs@k*RmbG}&|ijk}Kqt$33gOgFj}tF9Q+nP=2H!_)V;B2z<%WeS_= z#caj|jk*KfV|S=glb^A%ht}Kqkd|DHD@;5VGWGteqzr!Px0MKUVRJpJvviRB&hN&C z&KIHhB?_3ev5Dz62T&xQt3ynzK3=Uw;nV%>4_@en6uT5Bb>VJ`)1Bh zfIWUAV3c;~K@eVgv0vS3t!+A^nbrx_KlCP$=ZP=OF1iQ6Q5jJ*X0QHf6NA-q(mXr$ zALO|Znp>QJoa*&B4NnHID`G=9F05o)^B-{~W%MFF6xmyhHdV<=6i2S=RIUv->V^xO zD&`qe6#Ta`E1J_F1V?zx^?qn_K8My7cK50&2bfMDCjhC!#x73(&jM#^_7=oAE=3c) zJ%Qt^I4c*jIOn|x{2OeqInjZD8ir=lXT5hGKdQ1bL779ivn0h(vwbrjcsT`pnv~zQ zh^7h{6X}FLrigvjcB(<-nwoq?DJRRwn`gp zAM{XFi+S(nPKO!mH_>Rfp2b%r6~&MkHf#cDx-V^y3PyO8&w`q1{Bk)EO!{KPkO79u+t^f^RK z#*x7cF_}J%XL<*OGT!pHr-t)dA|?i2=vPP_4WzvV1=|+&?XWbU2+l@`#M}IV^bDoK z;Gk|%V_n-S*-$tNtH%AIjj9|E|h;VL=m=fRoTX@ zLdra05n?ryr04-SMwlg@?`zBn_mgb^I#CX~_4G}(;l#A^L7)fm=De+++qOznZxP?Y zDIGD-y5>kVi&aEu*TCDxUx6&8k3WO@?nzKH?QDlndt+D#Zm$ObK&6c#Z7L+i;KPyX z;e5z8BBmgk{hltRcU^f=hDCAZzV=#PI9?<;6Zit4f%;&XxA*r#f%3BtW^l;tl=mWo z^u2~~=b$k^nwP29aQ>AOAJ-n%koC-KyJ+&&6LSXmCP_KD9s3&JU+m?qalac{`;9Z?8VCuH z277FRWT9D0{35+a&RYUQDOxd#CB)q^%ekV0Ryp>ek;Q8p>ss6HNpu`vkwf}exbw(?E z7|`@E%8mFT45ZL@87HOYGGh@nb}KfOaBhp!isJtFpohXSsWRk@?2#v{ulY(0O$BOW za%gVaidr|Oy&3^=fMZKaTC_;En!6+O7 zGZrZ;Db*3OFOA`OX+pTa0%iRB`{lbI;4sh14)GKx(SZ{NwgMId!BhzDX@pfiE^=8s z_ZojHp>PzZrXxs5ZEGuE;qD{gp0+lq10i5Ln?Vuesg~Xcqv>4SiLO?fB$)aq& z)4}V-Qb;CY)x+0H1;rcctgokpA8l0oht>gw1!^F_^*c<9EB=bJKS>k_H~}X<{&)ds zFMd8h;e@uh-}Jv{a+1Pz_K!*Iqrs{BC>%6P^R}Zdio#5s3NuaJG>#c_1WmvN-;kf6 zP0LDS`@-WtZfF|^J;fh`eN!^6mCja)Kwhzga<=ig%fEAWdpTm}idC;C<#_jlq=Uv@ zsIEVPLyct5wBw5K$PMH2`Wa~fiocRkC>`aK&+}+LPqmOFHE>TQgbx{k+0(kWzt(i9 zjy^8%<#D#{z8*jkRO#G|6_K4;5ke{#ZAurTdyv^J%`MvP(*9WJc(#Q6^&l?!@?Sl6!0cL0~#;-UU71k5Vdy^FFto+Jmtdu9v45NS6;6bES z9?!bn!sz_#gwL{oJz%&A@pO1og(ID`XE0Wx9*Gz6JoA;#1wqQT(q4wmbW}`n0|)E0SJdj7sTN%87f=LvmkGQG zv7Z(JcNmwKXgC&_;eYl=T3FO!$*!V6c1Sk)&5X#|5Lbw-j58*-{@-s$+li|^GW&sx z(XCPIZPG&B71{dh4-c@vLaQ)|VQ=8)p};n{LK~2N2EO{CLm^C?6vkn=N>l%C2dHUD z{2Dr5cB}_x9CzLaaounf3(Cv>Y{p?b zGbu1g5jx9}f9yT)?19=Mc6Fs1$-h?jZhoK?(>IzH!nM`NUOIVvoEQ+8_GfGrZLmEN zCLZE5)nv7ZGP@~qVISGcattufd*6*d~ zI0vJc@E18u9V=2FcB?HC5%Uddg{0#6OW0djbeQkH! zi3Ysn+EhA^%s{~-l?OHDpDjQ*A1#ZjR* zmiq4r^aJ#-xLsr0twC(I4@%a@m^oVZEy7kAf+ufOLShj8tPl;GB<4S_C}%k?8bM8{|`@+js= zwf1j3K%A#bmHL<_g0ewFx+jYk_|Ah{(F#EzzU+n%vP2m9elg!(wJw4Ut}V*1!TZ)# zo~hr^du-~O|4#l^3sW}o6~)g_09FNUpn(IzKYiEtEbeCtUjBY5qoKp#LszuxdZ=+e z;&5}d!>JU)3I%R16V|p+NFk#5Q_W!Ed(!b65U(u5fEN9cvmtb&>_A2i=@Z z0#bZ{ZDuE-Zi|Oc8PG)zo2ry$bxt4wYsA)-@SoL490r17LVy0QTxv)IYu?hmUV~t? zM@zy+V#zX5cw+#4e#c<`GQ|E%@*&cAn$)>>vTyUBwC0z2d1wE;{qFFUC8rFPkc|7xB)$AhNySJo>Jqwj-*l{lHBb z_3-zfd9mgqoZL*^*A|+(Ynk^;s-jHrlud4Q2w#nWM&VNIki9kCv0U94K=7RHY}^ZV zHr7>HB3F!my&Uuuor_QJg_Mo{K;q>8oAu)-T|;z4Szkt>5?HKrLltt;`p4XZ3Zkg7 zGbj`h=4PU}Q21HjnBA`RA^`AJ)Kfu-FBWKZE!pdIOfs<>qFivi z76oL?tKl)61$loU0sCB8&I_&zMpcy>%96HB$T`q9wpp_UP;meEIor+FPCL#}YcW{M znle~T@v5K<_$b^yy1AQ9k4x|cO(3+gnB_zNklvEXJ4Fd|JM07OeguqZ?Ti?5rF($huu$K>~9*;j`OG#)X(>?U@nF@ZgNf-4K`LAf^s znWW(%l!>gRL95mDG^;inJhd}0#uX*ZUto-R(~Mz5_(nfIjC*Q7e+GdMhXv*zR+-R0 zrcAdlFzuDDZdKUvocX(FfvMn|8qWviZMmH~k6^?5T#vG`%$>x?cir(S_T0fd|Bj}r zlhk9|G{mp}%=?`!k0q}Gjk}6yv~^!*%2AP>osyEQ_zA1TRhi5#T`%(&-;w!1f%aGz zB~m6OVL1f&ZEa#c4y|_qiK#;fl-=zC4ER;B z7l5^cYkqcKFfR40q$u~0X4iV#`rVFyo2*Z5YN9L7dqN)ojqkD}s(xbPs!GAiqcgeq zehpW0BQW#i#!X-?2~PLhI<8pm7+ofKo&jyHqY;df3o8?A+!c4LIFuBgOP`Q%q z{1r_SKhknj9>fjN9AA0~24Ewwi3DuO>%|&kA+jSWKHz7wkKXo)_LyDHNaD(pTI)mLkC}f_$!qytn>m9+1WGK7Va^m=$OF zZE|g;_=#2QEsHW>4gy6@0Iz3$^pY}5mOv-3IqvV%Rr0NtrS;^pe@R-N{{=?#P#_Jt zgb`kGPIaP?08=Gr=6zjj6DU!8u<@SzG`~-mLmsFx7pM&q_v1HR2%FH&JpBlKEP^F{ zJQ6FW)1dYu0eo5UFJvW^mIZ(kx8eFz#Z^@aEuhFsT2o9iRujnw>b-H6+# zbc87y0+;*fvJfxK;w&C+)jA- z(Up~3f8n-8n-QkQRC|2({h07N2I&aE3g^Lh4O4_kZs-bLgq=9xOtTA4N&eu|ggagD z0-sbIqSz<$ki?F`_ElHqaPE)QcC=DSIT7OD5al+U28D#u88$uRQ8Ux*;=n=ZKP{YF zpapARrNw~z_Mz%=cZ}U3u3Q{cmwJ{(IA+*Q(<3_}^SV*mBQd{;6YM+mZO|yv@ z=ZhHrYq2N*RJ; z8u>uN3kv%p&(a#C=NDDa(|`O2{KJYQtq}XmD}aW^5t&_bbc5N($>pbY?KUW!kMzR!6ZoC= zm~jUmn8t!s*}5fW5ZBhIZhzWm3@41`23pSQTxg$o4yY(<{G2ErCZ+zcpBAjTpH`fh zYqBpBqHTC&YwxxDmFQbugc%QsQQ8&$o1fW2Mb#m#fAWt%>4wlfO-3XHh zcpp+ci_Pg+m1{BiIlK#pQ&c`GdJ{o|*s8=F93T%DZUUC6%OjVmP`fw=jHHgCGYCLeVEBg9Z3M(ziV}$?{p9(26gYZ=AyK|oH)xbO)H1)IGJnIrUQth zg!Qg9q`59h1f4~E)1uwUNx@Y8cdUgnhp4HWwe0I@AM;4j#R}nO^xB1}@K~malv(F7 z)hPV6Uu_mIxkdhgdH{+{S`esQG{C!3(F^9h35aku zk+$8kF`(5`nY%9g0`ZRJ~eW`lCYiyR~@qJzZi_VM(xr?ySOjZX{ za-%(A!}}f>T>r}5GsQ33!Hyu<2CW3_C-P!k`SNg7@hh*$#w6Ki=ovGLm;L?<<}LePF6<6{&0oSlqxY` zf?2mB99*%AVo|{zK=(xKyA;zRAzmXz0g0y{c;_MJ>Ratm(_EdXV4Rgh91`y^R7zod zNzmvQ7fuMG%4VD_kVsxmOsWUu7!nwnONj*DyDa%OSQ^1T05kkw51mDi{Qm+DnK{z% z5Da|%HBQQ~7$7NjBcm{cR)P8F$Wks?<-Q*qXL!dgOre7LJkBs!)58t=rnZDu1kD^& z`5io-zV3;M1bWDF^^Y&aMlMdCwXG02aRDlR_t@hjv)TVwd>@KRJ72+awvDK7*{rAIl#a~Z(0TO&^pd_MR_dazC3wWln1pt|QrQ0%&j84)Tj}39 zdXf&`$}v`KhDCmHz=+PVjerD$9YQ~}Nre^4T7?aFWlU}+BZ)|yIRs(DlC55Y+)x0y z2GMTU5VG^hI*>2E2U6hZSMdfbMJWK#pkdqtq`epKJO-*?^6y9!b);RLQ=Q8udkM@F-Tl+)C zI4zfyZHl0i@J|O_`Ye5A&$sLZ4q@}62OrW(oq=6+Bwf4zaucOc7?OAs- zYmRI4)97LW=~CmhMDhIpR8TX=1R(Lmz#T`%fZupKVApYMh9^Vgjf`z!))yszGRW>t zZ^qKL84zpcfqSXh^i4y4oaj=*&rpIz)twCy#4@U|Dev1wY>hN0UCS8pB`$7;I}SIu zJO%`4Ji9934(h_MjKaEPp+OB|WBLEGII%;WgK?B?>vI;g$|t&#vXSuidRQ)(qvk^=l7&f)1z`zWz3ik5skNSu9h{g z0aj2+3)xsV9|!1k>m$H;KBU|$F-sB6?w_`mQZe|0LkI|#bM=ZK(0ws0A_fQlDF3k^ zd^M_Ru3B_Ni?Q1Pa?)?Mi9o$BTRWwoaNe~%2TbW`y4lDHKMD}X|@DyDbXwIfQsCsWK%p~qbC&t0-ho5?0=a(jiMP>dkJwWg)U z=2S{Su%Lwm{~_2*I$$ACvD!nTtKUCH-n3enq}*wIe|faLq-*QB!mP(7AwYhS=&YAn z8(SyN(A6?+E6031*=pLDmQyt?zGBs=ZuC=q`+y<8BU63jdnDOiV!gKfWOX3gfR^bc zM{Dsaj*=U7=nY_iS^ttPp2Tn}XgjR1bV-b!QcR6QOkfeVf%^=mkSztZ_KfIp2LJMX zQp8pt1vLsJ$`9X7M?4xf`agvS1@e(cG+{o*fS*n~`wuirg9b$$36?CU?{;@pB%y2n zs>ZE!o(Ncu#?;lU);AZ%W|0v9w=;ge(?2n@C(*wS;r_467Rc%1K*zT1cYlmxI>QT; zN*Fvz1WB6w&H|WVegRx10lFu??+ukwN(cV`sF4vo`4QcR|NVS-lAVZLyxlKYDSrHr zep;}UAZP)^JF?8@SDm;bV4F3&b_SX?7O4b_2QbN**#I!9#9 z#nR~wTs%S6V-{Le9+?2Rur{V0upy$cW{B2(MHH6hP+B5&s`IM6-V~8{ z4-M@hkhvG_u1oA0%4cpYA+BQ(8`AYS{`nN^8h%&OwpJ@CKq2`@@bZ4Oe!t`|9t_+# zM210^#sCoF*V>v~q%VJ6`8IVZ>&68=4d*gCS4%Nxq(LjIvR4*5D*zI-NlNfO-G`Gu zSb1o1zemFiM;{sec5Kg&pdRaZ_1>HLd-QW>zQ*`xZyRQ-a=&HK{JX(FTdDQZK=ZMj z2&Mp_(@&K6YO@Y2Yxt6tah%9P*KYc#=D2f69VKLUU*&IN&$;cD%%0)p{s+Dr^@9N& zHtifB3D1d3se%yAIx2#X9=H3r8|RmY(5CUEAdZk-y(yb5b0b6Er0*V#%RcN7R|P zefqby-g2vvcnQ07%WVcY&&&$$T+Z>u_(xPcpAYXH#gE)!qjll&;3l*DF8t>qhj!tt z=NvxAj{#=^Yfnh(=jLXvEjD;kyZd%Wb@Vl4zgv*%c3$XZ@paS(gI)X*{<*puJ~WVq z-{pMv{74SOx3Z_KUAct>4ptA!yHU{{>43_R=F(sb5zYlYFs#+m3$@7z;d}eeo8aYg zMTQipjaSm?J7%LO^c7gXstKKaG?ss*AoLZbDBgDH`@=%^+Kt^_S@mgTY~4cq-PCBF8PT#V zG+d%kdJqFHhSU@i?`bi0+K%#9*uMwp#}FOH`#87Y%`^4AU5|on*bCC?SVqA&@Xe*Bn5!dyZcVCSC)4^Y3@M)4sz1gn9+rj3-&zZ02Ck2EwM!YyA3(>W*t+Nlcu}beqo%SI~(=T z`KhKtMh5g_1$mf%0|p?;#OMGLDPPy1ZK;t8b+mUm6oPhKxnagn zC{r`6Ipq5{jcJq;>eTnjEMi8>*%7_@A4#)Tp#oE-Bq&ME7bRbq+nRp_qWE6Z|A`U|Z8LDR@Up1;wY_E~OlTEyXvH*4OnP~H z49F2fv{jw8480cn`a#u9aZL+{f_(~S-3GiFFm>hPDq+%a{D1sYvIb~iwOQ@isQw;e zZn%4F2Vsv{=N8XZ|6uHmMBqK*Mp&P5VGC3Dto-DynsasNwIt=pNDAv8 zrfkw%6k*e-=ZXDm=0>Fw)VgqWD%#uovBl;5(F5qzJdeM|UAw!~gpS zFP#-gjU@t!qcdy7$n^@PS?i zL0u73|8~{+Ul(hH90Jj30C6h0|J*380E&#`8@D#Q%?{F@Ismyn`cITd-#*qpsY`>A z|D<%jni@VFIsxYDuB9)Jx%#SaUwsYi`Y2AUfj`5xi0pU_Yk$DVKi>Nlz?B6iWE{(_ zho;c(E)&8Q^Q|{b;Tjao8aL3UDOxaIp*HOc-d)OpAo~P|?%lzdscv{rf3>9kc{&Xa zp?4nH>+zfv13z#W#M(wg9rrlGSE-S~j2RAToMJa_cYDTHwfTRdYT;0eiLmZJTmu1yB!`mic zRnhT3c*m&}HSG3!dQ~CKkH=ofy7`?Y=j1@rHPQzq3r|n1R%dkl<85rAyJ$^#=UlMq zl>fE@&|-z$S%Q>Z(F9m_oTdz(A1C*VDbhH-c8;?D5{Ct>KuxDuymmZe&d~+eA<@{v z5mXVGOsb#b*VJ^(lA>NUR*~YN9I@t+9Dv-EH5Ae2G)6R~mbc?mS5y}d3Rx=?{&8LN z#IO8V7&3|DBNk|hx#)6kSp@xL$gOp}Ga9?UL8BkYBH_8xyf_IPF*;1~}+B*Zbi z8oygqv5Z?-kZIiC5~!=t0D^iQ?q&HMv_V;r$nk?GJi}NR9kA1HY(SsjT6Vp>2&1cWaX&b zEVIWb)9@#Y{`L&9n(MgxavAsz^QN}dpvmvbe{%*P z?zq#uAk&-Jah|Wk62|GsRGM9Y#U}TJTXV#oOsQogGV?SsZOag_6n^Z3F}uNH`F7?d-3LrRLD1npdpP<<(Yc4@EOboC!qV&&38U$br1_FO_Et3=S#%GpBvj>sK6!Trv!V8h&9(S& zDGe+H@359gx=Lt?XF7Tsmw}g_4DIGgRJ(Le9J0LA8Ur!AJ zQkkus1!Lq6pm#xnQ~P&>&H`BjN{erJ2-XW~ye#U~{r&64clf94Sz3;QETk{81(_q0m3&UOl~#5RtfL3 zP^Tr;`2%V_ssaW?LZk@0Y(%ode+L}-G--zzR6TR*9NM7~J>UC`JX+1XsLi}iCKzng zBhNdK^C|wW+am1$?TY@0vhD%M*A#Mm7b*=%cS;r!hvqpQ9$BY^`5ZzdV=^AkP$-}i=i?>|tIyYF=Ek)=g-pg524F!(rF9q}n=+C*N z@5L5%muM}wHcsL#&-1bi9oQb907}{3bTuCh;uP7AdQnV853tcdv?5NOC;;t@=eLb%Gl_xy`b%B z;u{*sG>Ju{v-AW@C<2lWv?jghHFdsqlb>7q)jvkc!@Yu4MUTm$5;v2&%Dm-QGx<4z zmr-$#n0lvrz!4^GOvDj-_NrcE*kj>C5f1tJp16IGfJjYt-z$xFZu&hu$X2}oll;wY ziKjN;b2!mYvL#zFc+#SRKxsm~hm>onM}+58M!#S(B7OYGLR|4Rh-+1Xu)?|l$>UjSAwn( zC19D{TClrF83wLU^6FUJ*7&61JvJ#TlcWNhU|8Az|KxmzOZ)vkfPP8LGf2mS`(BnC zo)Cd%%vCNeP3|*T&`JCS_gz+7;zi3dfzlND`>~|_!W-HXr5@DS;8xK&3n}e^+LJ$a z86;4i(OBOVNq>*#Cq3N!$3>%i$Q^Ok-Lcy!v&8HJe=Z$YfJ`@UT0XkyL(B0o?fn<; zl4off{vu8n?NfxnoHu81&3&D8bew5V_JPvpKF-T#$NnzPy3_`D0_KiVl@&?2I_zq1 zT6~sa$ROXx(BVR_^6PgIR$Q^n5p?za-?BtZ$C%Qm9AKgt!f?%Uq<8T5@7BK0dw@lw z;;oH9-6miM-`HE1eJApxN)WS72L^=7a)Y$61`4s9$Et#yc-^|N7SM)R;JQK)H`wR> zqki|mKUTzR?g^cZJY(J5WgBj;o`y0wY%-yYzRPT)R0HFwRVO(i^?R`l6c%Gx^?@@} zt4eCsR%5#G;7-X|Q#Gc@4y8bct81Kc+4K!^-!+|2x7LxaL6@04uZO5?>&0^g`sCYe z?l)zMs=Foe_{15%o4$j)yYeyEL$s6NQ=9 zZd`_mN)Tt?IEji37D=H3loo=Od=1Aj#e!vnrlSTNw0Cs*Y1l2g5Zn56z+a--X|^B{ zRpeLb=x++r;Vd94d!iTp(en229#v-x@cLbsXfSsqPAiZ~q`3(8ekO+y-^wH1lI`Hc z>OUHDGI=M?0cck4rw7bT9<9?#hWu|poi5VLURWH}`>`f0($d(4dH#toC^6Hk?48eu z;3~G>mHY`Vk?@87JA|eP_uy+bzswW>~+g#pE|Cryx#iL)>JVcyW94 zUuG1OtakD~EIvj(0mbcZ3>AQ^h7iZc#;4dh>YuA&&0vSUrY*O-WqRVoPNJ+(JzGs2Hb{FJT2$t+Tz+XgxiR139Q0txW`eRiw%nz@;6EmvN-`4-~mWaVxIpVPnyvtDWT9PR1~& z@0HfZBOO;Wss1w8tSdG#%gX@aiUdAoymOFpg>+bvad`TeO=(RVflSx%i{ky&Nn6&m z=rZtKTqMW?ojS)>Of>3nZBdD+r*>56N-d2KXT>0+*BueH-el0P#QXwO2~3HxS!gzW zD@vW!(z?)tYCRi2Mt{s_NU_f@iZ0PYkfYoFeGe2HH(q}fFyvPMutfDFpT$H+Zjh~(h3_Ha6uioHf3#}aJ~wV$94mm zuS5=-XzpGiMq9k|chs9U_W~jN?Naw!mVmXZ07yo?(xOecfhzPeJtl|2?GJ)g-vGV54;n zVQL0vIq5N70|Vjq^>RrH;5MGqA68@~3|!Vfmq{GWhd=Px zkU#b-a+?WtGG5tRcaTuwDbohPH$)d4LmXX}azoSs6meDKsW%sjn(?iyI87V2DQjvh zi{i&)nol&lYO^ij)om4dFQY-!r4p4lVdSMfM|F2H5odRDPWt-J+k8)?ZZStdGRm#W z$_H8r2K%V*t*H(L?1i;jTLjZPM@W!IY zVoFWLtmKs?;gzE*Q7z;*BlKB2lu2IRu0Q^K71DvHL1M{iD)6oTNhN-s5`l7$U?-d47e_^jh2bD0vJ8Ub4f% zNZ3U^f}t$y5nDp?V7-cNLK`Ym6qmNT9C0d}5w=xYR)9q}9012!Q=M_eeuG)nMn=dJ z6w4D}m)W4Gr)(!#%_U7rJz_|P)F7{FD1UMAbTr}+3>F(i4l2bjf(_>hiha=9&aVTl zY-w&H_1rRWphXiCE*DznWu}VC(jAqF@JejklUQF+<(N3WaR(4SlylaDdeTB^Le)02 z;Ew!7Xr{tK)U&)@h<}qFTmcRW_)fciNsIZhgMaX>H^jEI^zlr$!WP(if6 zI_eub!?{a;ss_3mNfA=Q%I__qvvc)n2OD0LecPYf05v+3LmdlO^uu8ESWO@Q_W0Xk z6D#zy1tmTKFGqC#>wr?v#bY%E)v8xex)AJQ63(i4({HQ4XiBYx7LRGlo9e6*Vc?^{ zgw6%Fz=Zt1S5UcPTkKBT2Z+SHYi|Q+SV@0A{Ds;JHye9!k~tGOtSA4rw5RuQNxAb9 zic##Dh9@q2028!n{HeGP)Ri-)Rfq&YBhZLJv_oQx0dgv*QeoaTh(N&L!Yzuh{*E_K z#my?(eI--U${Lamo;gsN_tvKwNoP&xIN83@kabvJBc6kEF@?R2g%%>>xK|6_dQ3+D z`C(`Or`#|hvcVHSY zF7XxwFXd&K+B>f>4M%Pp(p|WLa7*Tq^9BKTKk%4rn=KK=#=UA6%Ali=sT3aMY0=Sd z#MqbS257n3TjNmUq^oncoJP{Krl9DYO#HgKE=Fcy$&8?W#v2D*XE@$4bsUFE$?Y@R z8tn-1jr_*O%6KHyY-TQ!kp)$oL<#6}2FttD{a+<;&&i^3BMnJ`FFE3A;tIh1AD6BM zuduxlpRzVD@3BnDX4qjwZW4^m(whbYf=3_O2yT`LFW(FbA z-B!{V5hJ`1sga7<>xF}uFH^GZ|ErWSe49p)Ng}769kRirB$FS&_UTUe#P@5~*sVUc z#qIYH24pFQLHONe3eFLmNC5pm+=Y&PR5K$t6LJ!D9;Zwn*}`7kr5$JxNP(%Zj1iyU zG42iL?4n0e8p^605c4|H7fc-;*v#-gGEc7~1KRjR1iUarF6#e@ZVe_BAERIvk{Eld zqif1rU+~Ox2LB*uRJ~5po)s$C{=H@e2wV8w9bP=l!ktxpjFv~GR~GD_E0cdL%tP+* zZxpxub)C?2Ru|P*Ru;lbu$I0Sg`&1lmJC(cF(xD^Ye?Ow=E* z-`r+#al6HIbaWIihXrrrs!Qm2=6(78| zm(1GbH>(Fwub@Dj#z50tXgp~tX7)k;c}4WuQe~?7)d=6OOAk+MFyuf zoDcv23UC3QKW;*Q002**Io`wO92m#TaDDAywifU*j3PP!GIP=d0Yp&Nrmr>9Q?{Q@ z2Ho)V0Jzrh1QumiuDr7Vlhg03hf%$TZU#kDaL30}X%^SVR4%Wt*Q~jawwi(8 zGuKp}TiT)#qy`XPNW@w1zI`a@+z`+>M}oG-9XJ2;$_mtM{urtWy^6iS9AxPDT+j%RNEfs>$mRE^+fM>WKbtt9Rj2gBs zWlW*N!t!tUwVTkyWDwghIlbPSqBm59@E}h6&$cI-V~w&;9MpMngA4q*gQMnB=-cHZ zOt5hRo3#km8qviJhb<|&P(t#B4AbY6{_v_)FAXp`Y z15Kl+Ts`~n?26eO63q@%RenF_)vY(^Itl}5+PcCt1$MJ=L*y)=V8A30ROC_Oko<6mxVEQ& z!~(G=?Ef9YS+Xro)Y2LdEswHtwwx>s3No!&_nAdK8=6c!a!p8u2GT`zQ z_M}=@bt%CDPIHB>Tj_=`a_#(}uOP~Pgq4Z}<9(6ljVnc{*TSqvS>i$BX~$i4ie=3L z#IyMGT6gQo{guR3SjvYXgBEC7b!OQpY{z-;KbI~RS4epPdR=4fg8v&+X9?kHVgEEUnq^3N zVlCADskc}$(RsWjPz8ujK9aR>z6wOfL}SZ&6d>|1{zvI#*&Z_3pZw!UkUNof``if; zfA$QHyDC~W@15`X0*jk~vigpNq&I4t4p0zV>yv!L^Pd>HETa zW|q*&817$}Y$FRkGYBU1Om%Y`1?8r&Ya7GTq|c(4(1ILP(=PERd~!Up2HHdw65ezQ z|LPBTL9hM{fqsen0IY+Cqu1SK*EHtk9EaQg^!FaCK0ftg_4eclW2l~9o9>A0P!5xI z=6Ks&s&;tHq=}U~&*>2(z7c`O3rKono|k_jfS&vU*2j(mNnz&h3r>B&qPHV{`PXs4TI!N zouJflZ|p11q~wJbF@}hS3r~lN8f8o&YZ7&D`RMt>5>rc+MhA3vW3JNQHMCSx8{}^q zWVbbs^kobh!#wv6Yi7KC+ca565%5uKm?>sbXQ>iW%r7^@Vls`As?19husW)yC%S9E z6OL{pi&tz6>nI!S@g|G)z{Hf&N{fFIxmEkxFP6?G!Spp{fkOrQj0G5 z6j_%&9JpBo4@G;GE_~*Nd`c~}P$Jdc+xNA&{RRLr)FghyqBvA3*yEJKlg1<-!e6Qv z^HrfU zMaz?pN@R@(3Gg91NzSvgP6N}B82H%Q&RcFcKSd(>L@x{1WW*)kQ`5fl!zn$TE0Q!T zFJ#y>Ze+`(#H=1xa?!tG{Lp5l-$s|gcB9^cTDF+stKF1Od^7}|v4Hv`G5qu;v9FLVIGQQYglzt?wGIswh)q;kPhe1!l2*vBIGG8WHc3Jo0j?@~W$7 zeL?&c(*9>!K;;FPn3cz9DnxJEBskh2BmdZ39FjN#UWAehQ6~Ribv05WN~`CPK2*ee z)HUl-x;H1KBz13tg)gGenz3|@b@+5+dx=7psIOdKKY5R3^B6Do*Fa?s^bm9WlQa90H+e&J4nPDG z&`y>Z)>3YlNW0wgrX^~1K_vn}danJsP|#q1_L6r&T0V{rk)(5EZzt?c$5+OFqy=9U z?lZmsctD50z!s*Wf9ttdL%;q62QBVzQ=Br{b@++I44hMglN<9Er>CosP3L#Gr#X-u?Fpp2`bm#T1Md-P#qpc3HuIov($58P6u*h1Rz5G zPzxU?l2CzIHqsMYe{vl5*XCp6CW4Dojsg972R{u`nK_QmLE|dgRttpV>WYil2i0~i z%Rp-)1B%H9QO&UI-GS4$k9(57j@{mU4kNh@CSPfIUOM^{ki4 zWxmVEcbs&pnOQvZhhcJSAnlNIcQOxkkFG*KUGV@-syM+gR(Vsubu#H)#Ocjrzb*rv z?Mu9DyQj)cy<*XRC(+IWEa021t45y=x8Xrq@ySX3 zOValCyN=ZUdUE_vg9DJ0_@+QkA)}sO_D5vx?(N9ezcLLSY`52NOh`hoh}$eKTH7n2 zH8%>w`95X;JZ{#*3?*gbttX%fZUQ7LQyS@s@u+2nDGf_y)fluXE9*%mhV3kOLtcvj03ZZGnj|#{EvYh?1ULWws#O30 z4o|%}HIKx2`|#+`&H~t~Kvm%n02erZ;tAuh63G`8#jJ?SSS^c7|7^C&VU|a+4ah!n zA9#Wi{dI^h@Nag38&ugJu`j6E> zBdZ_+%v$JrxRN};y|63>bR{T^sSU6*k#N3@NU1v+L3|&xFs;195QvWU&E^tg81m8I zf%fQD9pdZ`Qz}-?h^}81tukjsNBE*;sI!fEL$m-l2zml)FH}Mr7=8%2Zd9NpbzrNs zpTzOTm+P1kW9tca=iVcZ3WV}!Wp)NhkLUS}iHi3OzmVk;9x+g(h(pEmQ)UHF4uXZ{ z4$<$Kgd?g53xvZx=)WA zm=A5;l;_m_T$XhwgKiRG#K(;;R*e^HTqylVH7h^fMaEu*roSL-we5zJ@<}4cUK6)D zmreVSQNhIM1^oueb3so&dR?C8c#m(BV)!cdOY6~Y&2)9TGXA>Fz^wWC^;m_)v2t;f zgoR&k+ew&|@i#s&6^L~k7*^BgRV-Q2&}HSCwn47fR7A!@EGCP zZ=gbqBsaPf%Jw_)Vnu9p&odHmbp}tcgN7+Z@da9w0;^C%@PF&hMuFBUhvln}?Pb&b z>m}v|{bnZ+wGVEgK{HJ2R3~8j;PxU-zzOH^Qq3ponD8%#r_T^~|K&<>uw}T6BoypU zn^={%nz*siL5QKCSL;_md}x`o)fifBv;JOy#rZQ4U2svdR=H}!Av_;r zdPtE>u`iP(&*ykcsos@F&QKg8d~h`Vxm*5Fi&I7c@-a^%2mPI0UZ%loQS=c@O{BrM zOR$nnou~BeWbh5BjlSo5c9CN#Qz5s2_(hT$pd(j1&UT7v--s_vUhfd6ILEo_xZ@F; ztTXKmwRaXd3AG;wAVhg;?aKUSX}>Kl!R3Xbr>>Y!X&J0M3~uSNgPmtby>ZDH_moEX ze===7z~OO!Tq(sVw7y3RhpE*JEYstxbe*4@C%6BC`VCRMlH4>ag*l~e;&XQDs*pb8 zYwzFpzy}iN&No#6tP?by>f+C;KRcY>M|@VH_SUIi1h_NZ2c5M&v}5P2g+)1x5d~yZ z)&~jD1tHqNZFWT&>~3iKxqWwS0NKTB9o-?5vfI?(j&1q{m)mQj$JUudQ=V2YAc`FZ zF76%L?b4P?qTV}Vb~iqCUu!T+CYf&?iSx{POS)W-;HegDie_H+ET%+To#K364Ba!` z|Nm&d3Tj}GE0um-2Ot+FrCfQjr8dCw{eW4LV}96B0p?UFNB{jmdM^asL0}qmPK#yc zy?X`84}!-)qc;J7LO><+W3v^DPO(s8q*=OA3|#XAhC22)O_f{54e9|tIMeNLPVp>nW+den5fd*c52G)L2X6ophE2mfbw0p2Krr7H zH6G=YdRSPLQn&2f6N;CL$@IxoEb!xyM@UyZH!o0DiR!!y#IKzlIsBc!ncR%KY5hZL zgh;Jyk@BzOb`#eOZP0u2`)}6s_APxYLhfX?Vx5le>kM6p{Mj9B>n3Qf3CL6uo-pcW zRIQPIEX1HmrUVW2U8=87KsUl?N0D1vD3mKhYXAA}0F!qmD>s+u_{CgWZX?FwY8`&4 zb&z!5hqH9d2|xuE3x5zy(My&RQk-A@3zFh96dRHd&$^c0RllV+%mZEG5OH*hGm|&c-@lV?9fy6P+d1F6p z4>7u+m>TaeEOC^@tfg$}1SE_#h`w|4Vglk~2~SEg|kVHa#{ue1{zji1x0O+S>qO)d9}ELPYAodHwgBzRae+X?RZtoDmj0 z&-UFM{e#8Tp^S%BcKw3GNM)9X9jK+=i*5Mm4z=K0BUlJzjmd!I1}L4U8N54Q<_y@w zB{N{UD!>m7sDjKAf1%%#XVS3DNm^UYoLXFH`)hm0UXSW1I(avFZ~(Ru>ktd~9Og zu>2PK@yH;1?t{wbso3_J{vZI zZ>BzPikhm{V^_-`%IP=1($N;Dmo9qq>P6vrbgQ^H*)y630Ol3*19N&zm2gDUaW%fZ zFY$UEw%{{YS9RmHHM3=T)NW`S&<*d9c9gX9UK+WoTAthuJ*3V70|i4UxLk`YdC0|< z7N54vi((!lV~->2sDp(c48BWVOP@t^OSbFd(C5AlXlicH zfhxs#LvPxoC&{a53feGe0bHg{u|Z6Odh!mfU;|l1;#SIAfqeDJYu?lu8=jOHdAP3-wubTAl^xusc0glZTM0^b3OAF`Y2>IJV)1tBGXVb@gtkn zB26tp`j>^x!j*cO>L5)iD{-}py5k}_qJ5vhJ%4(xKMsW^_%nC55`>D zju+0XixCnBWcDPFE=1ip3!$53BQt^eS$Ux#D)Ruqi|{J<$RZ@}o~e*^+rcesOdYgL z1S*0IzNoDnQI>Bt6!qIg>gEGLHNipq4x^gchWv@^n;Xtn4J_>?#EA(qC+P_(R}3uHMmOPuVt<7i@>#K~-nl z>CA07h)H9C3sn}IKTWIE(dF%PJvG8CUWAr%tRPe%i=fEQz;j@34z96>uDka#mqkGw zE{1?Da$CP16qmZnJz+$rtdqV&gbRxu;}_Pv5WG1`Ti{S+gJ~xrl5DBt8#ZQVhGe?l zrF@vp#r|F|jtZ>g3U3*HEg>0;mX9oTpT9qUUJ3-oygAb+MLhZY)(UZ?-cd@>?3(}) z<4`+X|Ax9gOV24Vx4xTHq!U565T?8yq4R{QbfzW>jZC>La_VpsRrIu9Q|xaat9@V2 zD~Q4hI*tDsD5XjQgh_#_2(5^=R4zNZnX|(x;vSDW{rqe_&4urQR^`bsAPAp zMc?U=tYDE;Ekk5y@WS9%O$&=<1%kV|o>pv$T9A4_*#6uAq~oG1)E>rk z5%nGB<9sBOi5vu%tWGy1^VT>4N~cQNL(Vp^1Y8 z8g55|LH&tKGvA$N5l^X4f2%x5z~m!tzCF5V+k@teE=sYwX0zu#(w0;~*nEl!TX}&z z6Aln{ZHoJ3SA_FF?)HRICp^0*1q-MJ@Nmwka5u8a09ECm8iZ$7O*e^ZGx zp1j+cSVd`0D;-4=00!v1t^GdPURlKt_&PMVMFDSkVtkv{aIuiQ8C<(!i#{|2jo|fq z*s>T9wyM%1nY9v6x*2}Ok#)%XcGTBB@>heca*D*vZ>=bSb^U`0=u3IQA5S& zj)Uhwxs(4P#XNq*LO`+Q-?g;DrqQiYt*nQYFduyM0qyu1MEpMJy`YL-S$>uP*gxdX zc8*kR@$DE~GQKTV#@Bam>Y>m?cTGpGg02 zHcWq=Km?a&u7OI#)qaq6(-Yyy_VC80iILe=aqK()pQ+g~cUfv6z}=<6JI?wlz+yD( z)r&yQr=;*p(vR(d(Nk7CnE(RNRg%=ms_S1%^ELiSxm7O1y`~WyQ=O8NY<;5N#w)hL zW!g^q|Ap$(E+u^^o52F(os|hgRL^YVLrQSn**m5x`-okN3DPybVokprG~Hagx2#wk zg0KvUp)tgTbJ!C@c29HRLQVo(^!SID7>KjnApNycS*gJ~^L=YGlWc~O8Wyj)>m>)Y z6e!a$kvi*pvUudhABL~`6776XF0W+@-UODcmm_q_=Zr%di|!xw-kl@Pk-cKI%8pHf zuE4TZ>L}UM0so*lJ9Sj(V{JJUcrL^-eWq*OzmO zSKa43fASwsSH|edRt*MAh_S|~xTX+2yH4niBm_=y8 z%CJCapZ_{?3~6C@b8jC_|KSXe(qcX^1y74*n_9JU1a*(K%uYvBC@15j%oRRw{d7!%6x>=9y6?aM`nV8(We64;x#79_E?BlOLyVn#}?fbyYKJ12*`k5=v{b9|?GMQO~@K;fk{vJ`s7#L<48I#H_t!!mQ@ zvSq}r{-~@b)WKvx>OG{qU_N%cjQ)V*ax>Cnt{N(Ya}a{zo>GW+GMIPE?zf8=^Nm=z z1i!2yO&z==DTo10y$nx3PX^!M7?`WHnja&y$7LM%L3sn6{IGl8R$a1IcL`{6?5P@1 z3ENd1y{X8_Nv3QgE(8Q*v;HF|bIp`(i<nb>z;uVZwlks@it81f*8KYL7yOSYaB%lPfKYKD>3m^`zJ(~Lb3ptz7Baam;nKR1TFXXwZ*VeF1Q>+ zo6Kldgv^;1IOu?cjM0Dne^r?}rZQChL(X@L-B0@~9Kw%Y_`T1A5eA@_kv5)j>d#yt zD0L?AD^O!d72GzBpCOvh@?8o9A$%&xP5HOwChJm6s6k=SukD_`wuE3^Ac4T3n>*F^ zRI$bU?R(0PfveRRF?+8g+2fb8No$4XiTXSs19z zO8UU@TQ%k;DD6$RvI~EVWZMmd10I197%m!Eza%aXfm@|9S$2Bg+#b0w5BHw%Y(s6Scxzt2Zz0QojV)jSg*E3d`_mqG=!?@*tj6u za~29BdlAodMq`Way*9KhtB3k=(IL+a9Q?Yl2uL638m!~8&p>gW%IkdU^io?OshY)s zWP&0jDT1>t$B!oip9VXL?iLZp)*%3!LK1wWny!Z2isVTo1bC$Uy%!rMU|c)##O=rj ziI5VmWVVPUVnG`MhYZ1h4zW+fPM0NeYYI}R-*LQpUo38G@Y9)>WP2?xggR{p1m61` zwS=aX5F9{S30(awwq|b@dpHneZ~^J=yPa&6=YVPrmd^Nu0g2Wwgkg|Ah&B_N!D>BL zLE{?Km-bqOh=u*8u4+Ivoqa(9aa7K1;qF-(+7X!V*!2V&2qh1=*CGPqV}%iFJBEJ@ z3D5>5NF)DzcFANaf#wRRvCOyF{iQ%-J3YZE#oh`F=PPyU*FXAwvP4C)6OBw_J7l=D zuYD+U`Vt!Ru!al`o<(O^OA5)I+HvoILt{~fADUo7fVZ>=Impw?lI-OE=iE&Bz0LH2a%*r-uZiT_ z_8VrF9SyqASQihvqkSB`ek&j0t!VP6v4OfWj2IM?V5433SCW}k#$-rWS;-@0%i@f! zQf3t5MjGzWEUd5|$%=PI*takt4ePue<&5H*Sga^eJ$q@q0k1m+W~kRFr5+}xEaeZ< zOhRyO79S^!qg!IPvx^S@w-_%xc~<7aE#34*oCE*a@M>G=2afiMaWOZn3l^g&7=K=; z8C|0!I|9ziOazVBc&*Dm`(`9x%7v?KDH)$|_0azqe^{UD*H_!Y)gNK{*y+dgXaz2> zjP^m$)V{puE-ac=Pg6pa*Q_wF;>B5@ApA&9Vl2}xF5k3$_--^mLU<^e4)zBSG(1r1zC&WkPUM-iS> z;^u~0v5kuXS84x%nE9;vamda#Ips9Aa$0H89|JbE&%$LWTLvU~%|c&+$3&U=kRuEN z2qb_2gvPkZ{}SdcO%-_H)QC#QYN$tG`RZX*#Lw$bz~)v;t}=DsjWm9J>i4w=wdZKL z^HQIO&I}F157+efYI8EpPa9+6(TatQFgVIT(@8HDN6NxN*ZzSZg*z7;0Pc$BcgH6e z*Wn~!@h$vJ5s2r|Ag@lR=jHr~gvz~rT-k8HoRQz%)ha+Kk&UpLvcWnX1k(?5dVMA( zlFg@O9hgsP*5%mO81~#Gr-EWCxAEyTyCEY>xi)zV=<1dAVsn=)_^I1$V9FquaZpt6 zN9SZnCh%hOvTA685^4%uXn8X9G7?eFX_oyw6}RlI%m04T`9(B9;7X}nu3yrIjqWoL zy-O21UrY5A5%KIn0t`hkPBzd0U8OThxMAf@qJD*or84x_8rd%9Na63MAVqcf`%r+J zS>HnD@)-abV?(9cleZT?OYlaAHHfqqZ<4R*GI)3{65^{8OQ2ibnDN$Lql>IEVOT0E=-ic2@U3r21p`SQz__g{rce_jnxMSIE{Ijc-CqM(#5Lw&&tWT_tGrlSp1eKu%c<`E#GCMwIOZc$Zn{)Cc8g&Mzx@=;cAU)@Ow%(oE$ z*HMQ=1lPN8P)UCU#Y}mBv56z6$nmSk`H$iHTIXW(MNC<>qJ{7RhgnQ|X6qn$1@(ju za<^DtcG!MMggHvT!I4iRP$?~=J^<@>fa5^W6W>N3s%@O#Q`;PJ$^Q~(eE@TYX_-I# ztIN8lS*9bH{LR<({Q&C0@Fps=NfMJXqsVM97&p^7(>laQav~_ZbFp;A+27PXYB|Q8^ z@&7QE0dLQoKS5z)@Wk6I=4kNI_=UC7d7zU~3Lqw-Xl4KM<$q}Ex__bW{ZpE?$mLnL zOu?{-3kZHcU!$oKxKYEuk+?P+9}#bdx7ME(m@bbWq+w+qJvkRdY7&WhT>dn}z6nlb z(Kmkcp*`26SiSzux51rfu(g<~2Og%E7&aq%pyjn{qI(?2?QeA(v|{itN0}&tpLvd& zzxoDfl{(DTwT7moVuc<*bP_C(s2w;PzGmvw`Vz^E4-WT|dnersbZeG)qY}lP(hHD_ z3~<(>RPrfD>Dc;Ua5)5%`d$d}4Suo6m{m|KHyFip-w(ZZF|NriYfqdiBUA1HVX7m zemFgVf636ycnF~R-8so_L1Ss-s0paq9(L_UIEWu7R_u%gO}deYC7e8e#a|OZMGwm% z)2-diQshju)9lM(73vJ`D8N2>-^QU#*$YG-u^lP_?Wo4H7y*#hv;;!6*Zx3;^};Qc z_U}0~vdI}Gz~?nl%{i4i*?9H0_0to7hucMO(>}9j4+uXzO33x}isqv_c)7O%H@BR< z>YZ4YySq57 z(Fr*Eke3!(Zz_BXKDzo4M1kQk|BO*?(dlp<+Gxg`Z7G4Kg!5WPoUilh$*tYA-}vC_ zMISDt9@eOrlj%}Nw;)Jd5~6dBlJIik32oO6mgeZZjWSoYoLa-8j4uENDKLdmZ#Ra6 zQG(Kt41v6i& z(YB*CWak|~|D&Wp)%eD``5hb*KKEdRR6A-70QAlcLL5T?^TV$32Ib-~35Oh&`a`gD zK$>JzSvVz|b|xQ!I$?kS01OX7otwAX$%W7Y7ee`9gpSD-s^YBz-cCL>o1O0e%waX70jkg7*~j`6@WT#Oy=_sbR_47Hq}B;`qf00s6lKkJ$`x^ke{tyM$^Vbm`Gfruy`CRv@tTkmDA8cfZIf9R&_zJnM`*6wr!^NXQI5a}e~%c!#T z8r}MQdMpL=nbXj03pv=HFu;2yAO>3?8HcI%p>fhu1UMQbM}Iyvzwh-D2-otc@rc#% zgX070j)l53YL(AeP_ixvIY|3&x{!@oP0=*|EG-osiMp~!@`1%p!IgwR_TLeke%-#M zxv0=y!~RYT6jcC`Pi>?U1As^Pvh@8h2C;T;rJ=3stnJbW8OE^K@jkvEORCN>gZttr zc+LCtkiN5EuqY5apHmb*>`OVq<0gx(xXQo*KMxU#@?qRO%I{#UM{9`_@T^2o2actg z@<+3y(5e4x4MPT74J(WG(_QyqtpZ&!X=53ZUE?X)K$zi!6Sus2@Fl$5Y`-p5v%1Pm zgFJ>JyzcdWpF&=5xp#sI!>(7Uh=iYk0(i|gag)gQJs+_2aczK(cU6J|jmnj9$s~y` z|FBN{PsZxf*K!2;b~*J1E-X!hIy}Uy6|nC&qf_|Q?S<#fe@6PVqnn^&>7v9uvs^0_ zm#a$>%}^c0BKBs21u-3SAAARV3qe4AKiG39r{nxPCcy!JERFOOm~g*#hYP#weBFGq zB|+C7=;K$&5Ni2<&5XPxIpq(fAdAzY!%Q3qW#@wb2a(oXUbhc>J=Z`R9cgL+^50Ee zG`yG2K~m1gGcWmIgkOK#=D&NKwp&B9_ zWg`4~y>Iw2=`4>#eP8h64zg}cB!2>72F@7{l(7yR2qB7hW+remUa;Vi@h5vTW&{-D zc*P5%=oiedf6jU=|6fcBI(l2!I?Y{=w8%F77t1F;#)=ia+W%(84^>&Fcs@-|Xl&am z*g5^{XQ;Lz3Hjv91c92FDGjQ{Wd(_2#YmuotIg6>kCH`sBy}cziPdq22lr>nYqTHz z&WE6OJq=QNDLp#yO$T~RgyTK)8I?&?{l^kOiM#hT`gQ~ntf!0$EWNholp9oa6e;dp zy}AEzK;<6z9SuAeJa3boXxK$3f#0kI+zb7f6YX}q>iO<*-k)LVJAHs`7l-1!nC(0V z>q*xPE|8V8`hYYvW6Xd-a-DN(%Gq$5GnscpSOJrlA$sWVdp-O+-)q`>JsTjsV6_r; zY+_058$Q$d;y5ao{h0>lPd+AYFFxI*I(G-vkBnU9t$u0el*pC78j;Z^=5R+&WbY5g z+;a6O?%g5uCA<}XtJhXSSl<+bCw;dQE5C*d1dFbxn|y*13&iQ_` zazhpWGNiFwIv!eX&JH(2jqF?6KJZ^rpT6KRKd*R+y1|tm`PvmPC3`>RXSsq%LD_O- z53^wJuhTZCGyoOLARX;AJUw4p$o(-h#E znwgS;pCetX{z5yB>AAlT5eu6`R9kw%O znMOz0W10J>&AbU&-cElIIyj2KZNUEH4o&7qec8~reF3_DZYn}#{%pzNW1lToO5^FZ z3tt8^4DJx1IHU;u&UiRAy)TLx+-e;i=5&v7r2#P~#Cgsv-mP*q4@kq;iHUlbb+?+~4Izgh zcQ9o5?XGr7%Cx0B)=uoclkv?f10w~bFnKvKUmihZh{-iV<~qe+ue{P?R>Y6|idLyM z&yZe90Uc94UXie{e%spN^}2f%<6IO!iJ z==HDG4iaTM76y^EziXeJ2zubAB@T`9O{T8Nnfy+1WBT+uk#TltZShiTgv#Bp8JvPX?2F6G(-qH@ep* zp|ynEkJShPD;w7GOIdpP{?vn?usB}RT|FEgjjr&(@CI%RjiLUfu}TKh9nuheKPWP} z#Q_Np6UO3JaqIkn3r5)BQ)=k37W$Yo4!95@6kr>p3TbXgT9z@ z?9-5zbh-hjj2hN$ys<8c;d|1Z`kNPl z7D=O?D!+Y8l{{AFQAIbHw}o-nHX7^E00kjrABOD;e4d>3hD?c>M zILvDvKnz^T(d4sF=)7Gr%zg|m{P0?jLfEb>CJ@+Pf~D;A+D{!1Ep86Uo#>=GL&_?o zoFwYv+1wDkg&DTm>~sk3`leZH65{=ll{lt1>!aj9 z`kSFcznHdrEe3ZLWkhd4@-f*acbmF#qMff+)SwEr{Cq-fPUABVNGiW2uXX$ey_U@B4plt%|eU|5oh zi@HBW$YX?-?<9NFK>*Sm?+r^_4W!uRAtWl}fli9QvOBN_rhvk!8<^en<|e%`4q3$N z_D+>wb5L@7Mv+5Jj~zm{!jJtrev1>{PHY%)LT=DaP!@7Uz)QK$8(i;ebYO({QK>4^ zg*}^r25i$oY_2&FWZFnfu2Xrpr+Y_}CSm{p0|DzqR;@!>n6O^s47W$~GR%SuAQ1X0 zSCii_XB*Rq1KlSf7ZHQ&6}m+|k`Fl&=8xbJF!ga|vEF&cfdv2n2YCUWVQCPb002*q z9cEKjWk9XCosXRpz9y>bezHu((qlwkWNDW?6i)S3K$8}C;~T$om;kxcXI+@)FgV>3 zllW`D&AmE(7n+U$JV$^6=}RI|)#TVAq8pilum`o5T22O*)sjR+AD5vXbW1%)-x^S$ zO?1~H8&XeKa0C5_?@@W1?`Z_}+EYQ1u>MT}jW({lz70d7y6uUmq_<*HJLw3rMN#Nw@g!VTi2r$N!Ju8EFq0^XjolB@FG9$v+fqHe;u)jV;$x zKN4p-W6>dtjp~Gu*DCrbg6teH`w{1o107UwUByIks^i9ln80p7v%SxAr@jFsG>B`` zYZg;YIZM@B&$bo359jquK`Vifb0LbbO@;N3?2_qSmILr7rZgYh$+D$aseot3fXnzG z6`qM0;A>!7z`&l85&lz#P-2j=R8Gc=I5>fVdh1>n^S~d`?yLTBajBX4qRL7juUtKa z2QSuxbIBQzzGeJL_(~xic!hqdjXC90T_c=pL@L!_*(xvW`V4u3H%82K5d(M@LRk2} z;2MjC$)KZfKwD09@AVS$53UV#3x?Edm6%ufO`Eg4Oa~`0k)DE+uyOoD9ou>TRjbqd zGZ|s%+6NFZl!imz05X(G=o^@y(%gZ*t4az(_9M&HG2KP*VGb+7QDSKeVBYKxBa=k` zFP?TV0ke**&i_1mqC!nr>ApxYROPq2>79A6HO8K4TE)A^^WzUQRxD|Y`j&87FDBgO zT?-JpBCbv+%-R^GY(xt(*ik-rEl{`4mgkN(*%7%Q)O@DEBq(yLIm_|U=A;biFRh=d ztedfT@2EcSC|U~uKsL;7a}N+?%|%u?y-+V1&^RZt;zZuTe>T}&<}o-}jB~dm4#i8j zO$-Cv$d}dR1B;})@1NOF5wjxl`E$UqN1nPX3G|7dJLcP##njU2lNjg3ryPafa7i_W zLW}}N+xMY_h$tLch3~Sbig!~41|A@avJsD^LN~K1oG-`f@ zKR2;xb&$RSnj{JFZ)8pI3Ex9)J?W;eXutOKOk4}-XGS847F8!jhRqgT#-qq#s)GOW`w``6v7fa~ zhF!CyqDxokk{K&c+kVu*!kMMd2N9g>Es{73eV8A~8hQ7F>pMD^4qa=OyG+j}Kqspw z(ZWDs_8;&cL~9tm^$tsU_sKSi4&TXS4+})2<khM;DF`O+^s=jTFHF>m;eN5Sj7r5&2u@$< zUQXi>T;yElcEGY~L7iORw-Y1n8)l+UX;UJNv6hwTrb-*r?Xx{#E7?QnYzz)H9%zIe zC@xOPl|1jVXBD~*-)0GwLZfqm>X1o1UD}nlzrrCi*6^lAv*@rI_V4)Bj6%`)(7tIz zn%Ktp6r}|*5p)(m)RDw@Lp|&D^SxH)=F^NI_vE*qZ9W#JKqzj`am?lBgeAo)W;6eF zw@O)9zN_pC0N!5VE_0OYpKcYB1oKo|ou4k#uKDeC{Kam4sk}AdYQ}xQtu|=NVqbt* zWEv7C&L2zEr~v{Y0?!SL7OXt~a*wxow?(5^a53u!w7)PK-NA~2CZZ6aYHWq=%&w_F8%mP?x@{@)#c#*8E3LGeNM+>{;=7oUY1Gc8MCmPpruIV`NbS!+(C>fMw7!O4;yX1;QE1gBTU zmmHK)QA6J`Qie4pz-!J8&oGIk-MT+q3^qqY?fR*rcQy???N%d(;p8-SoIx~#rT3lt zh~5G6ZlLzTcs6HF=-+3lchca?am2A=)W`3X(}}CR!fMJ^888iB&cBg?eyC9cArcVV(i zSOW=PgrFLK8S62_Vd9n8%!Egpww=Y{(owCaP6i}9Az@Dq7$eIo>B_Hh+W-Iq07(GV z3h~arc5eD&a~{yb6sd&0nXrw)^<+~B04!olQSm7N00x`^o?~u8e*geapgBd$;)N4c z47UN@JhyhngyLQ45yg?xwiq#E20;LI;#CdW1jC^H)Bs;ztx{(U7aeC5J}k*QcD$#W z{dM}6qyq&s05vDjq2Ia4LYbo0D6-1JIiq_ch`hjQ*=8+gDZ$7-P1LH^{=~9oq{m)c z^34jQE7;@gesNOC2opklWph`t8T@gke2AWMflC=(xSOdqh{R zRut(inqlgGr(dc^gpJ^Kyj}q5Se<`Z5RKZC{A6oh?n8C0zkCeqq!H|+6&)V4(aH>o z^%ZTz81>R#GQ-fFGc*eGxbD%wEviZRV78RO24vV0G8kBc(yPR2B{J57BoV96ygQXU zf|%%VEU>3}30UY7V@Q|JdM7g)bu()EpBO@N2%=`btbF28YAR@kb1L5eVt_2pA_vR;imssow^bW)~(C04NI%8tEyR^3=y2+C|!T z;6RvkJ(sPafKfyjyGR}0K%HZh=zjg%AizyHNbpHr4=+5iZb#Bhzh311o7QOsUY{i< zH2%PtoE!|ZuwsFrwKaWFu~<1xGoWi~FfSLH{A3i3(}5V;0^?8+fp=%Du)J?#ODS!^KO@Xj%YOG z{e_n>QS`-$nEyokxlAtKeP_5w2Yi9cBduSbVt06)DVhhaN5s zOmx|c_VD%ZOXH5-#ZiZ5WBT=WXwqR%l`OLX;lT8QZ=KYcQSg)Zgyem$B&ZP^MD~Uq zxf^hCQF*}bwUaiLsUPt#*k^@ui*!@`lHL~>xYIRm=bnjyzrh?WB!d39;i>IX-Je<8 zx5b_xI`gV4e&<_c{!_P4J0qs)=>mFp+N$l9nI`{VTmRaV1X4CRktwP60B!Cf>}@+- z6Sy)2e<>OUnYy#`RRJHJ)ih}cD$AKBzo@1`qyYndhZpa_KT^7spnL!z=njO6kVF9x zz`M>m`jw1^#sCBK-tw%hzDXK^^7Mv!0R4C`DA)6-rs_W@g@lHN~(+<@3CVUxg z%r3&e+3C8i3fd-Sz~LMwDN;?3%43eX4A^;Zm{4h*o7&j+apRkq0>}1;9AO+(oQwQ7?3yoGH*U0Xqd zyg2Yl+PPB@f_PVE#lW{tvZWa}$df?LzM1J=?*(E!-l`V@+i0vV62&=?TAOxa*7bDh=G|V+BUi7pIK#L4<8EOiW8C~Ll;fK6u4da$-G+&K0!6l zZ9MBpWggCjv_qk=Ga;#GJu*i0$T~lKrAx^3E{qKA_dA~BR zXxphYrAa!%2c~65jY9A+-$gJ5iiFHdr5~m{r3&HE*6-b7y8t9RYXM?#Nh)>3xTyAz zVREgr(mc0kR!$OMCB_*exN5M@IUs(fhl*hIf)EJFN}nvek@8iZ($B2qMCuGBov63@ z!l!M8Po2&?GQBKCd~|bwsjK1)L;nBE9PFp)p&x_ug+;-@g=b)X>z2LVyOj0^P)}DK zfinSY7XlDeukjy|mj2(2!)v8GNK#f?S|Is6U=Wu?+6)N~o7QHuh;8)zMB}(2Lhq2< za}wQffh%}U5Dmdd9{o}$)5VTgWcdZLAs|VJ)dcuK>&LYl-Dso*3Se^>>p}3uWkc`g zK^JjgyD4Mci4N>#9FpIHdg#Q}vks-=%-m)U!L`WmTe7@46<_@|G!+BhN!Rs_bc|TR zLys@=@adbj^Ibm0ylB`7o@gS0dTfB+=Kn@&+wD9{m)fD4!2}VZIv;t-^i}J!fOgcv zQT4DL;n=&BMW-&po1s_v@DFtY@9(Hh=;(x?000!QVFnJ7f6abak|M$Vy02Ap!nrJl$EvYh?1ULWws#O304mqXk_y86koUDH!M?qkY#Z!=# z*BD*W&wZC|RUDW7F<{kq8awJ?Lp#>!#ovjk7?W3+mP|h2u&)S2s^vWRB(9mS@cgkj zJsd5Pmb}UFkQw^+Iwkxvu+PQDO7jfe4cr4HX(>-9tyEnbUJ%j{@SR zfZw_RY1fY%R1$)ag0*vPk;^}5$De5={D1*VpU=U927-j@OM!p%;e1`amPz_~Bj%c( zh1k@Z?C3~q9|#f}AIDC|;+RKx_9lOXeAjNJ9+iOhDMjeleLepPxl+u-&p6~3W;T>9 z$MI7(#I^sCVfdW0i9v~{2Q%-%20=b(ufz0(8A)fVYp=qgfq$_qC>hSX;Y%vYF()tZ z3`qm=9?|*Xouu+z3Mk|YL?X^e)BsXX3i^<>ERuZ({>dAF?RmZ=&^&&mP_UKN9ah2| zB9y7g9Ene!v!~AE4AaHc<<<0}Ds&x}u2^=MmDf*U^e$6k77yAr?gh-lZn9a+SaIJUz)}4-6)m^_3~Ps5W@=aX(+9T|`k?<@3 z!JXt*8^9G1t2LfmYz0vniT;)}w0_&6Dj!)V2aAcz!x}M85MI=hH9%#e$##q=-&2Jj zle-lg+^~}lgdLDZbab1>KGt;PuiJ(>>`uUd=FqK{-V7}+auICQDeyF=tsKTnDtCaJ{VOZ5CDl0_7n~Ov zj4;eW1Vb<7d+^<57~4w^5X(q1fcVc3;&BVwxQ_PkiBFO8c0g)a9z&E~bJ?HCwv*0? zH+t%JIBEs-i4`<|@S$7u9*iDFOK(g-hsnv=OlFfC#xU@V+}!?sOD0|sJBTkijZ?|2 zZ)O;vY6x%vVEXm6pEi{g5|)BKC56vDtQppD0DC}$zlNE3CknyvXKH6B?H&*-V|Ox> z>DuO)fD2;gZO8d0*QHUlci-TD^{msGUI`e5^e-ADu!Kw91bkNS>^GnI6HM~YO{Yv@ zbNMnLb7Iq*8q69?-sr?`Hp#F-X>4%6)&U&)^F#Gn6LMh;DTA&I9#)uT0FLz-ZwXm` zf*l~84eQN7+&u++m=npnOEk4#{;M}jIrMtJC8b~GBlT$@oUD9!B-AD+Ct+MyqJG^> zAIiIQ6Fc!2cl(-YT4^+*$$+q7`(ud6^5>m){S^?O;?KVic?*hnALcj|<_99#`Z9aMS zW%%Cl^f@QBn~A|Qt-v_g&Ah0}!(zx>Ks+MmQW>jer%3&8B0Y+yT(n==AumZcN1-%V z$Y|)J51{dP9W|fEi5YhronzehAZlH%1uZc9+{70&YT{-a-1BEEVz7M!8=dUtL4{sK z#>a_*@X$|>b}}Dm3)qBcJ#NFfwApSLhIis;)aT8e@;B$F84mF8?{c*Z1^F21$RV9Ab~~4Kxx)1t|=i!BZDQ z`XxmsSb=iVMzL;W7IkBP`(82|6BFhUeiQ-@crPUm1cs0o1Co?-z`hWL&G#nb)YF+br;G zR^O7okQX7)Wo2%X4^#h7l>!+l%m0_&q>||@z@Z9o+%o^%n0n70z_B>Nk}@Lg+kb>J z@{ipO;ruF8Pte7cI3}-o0FpU0H9j)}FWnJe1NROM%*Ch7+O(E;8&cmmgmoSRKmh~6 zUwtT~r!EwY+{=!fjcUCI;(B!8ha#Ov+IF|+OXoKSJ;W>rw;nli!0}ZJe6?=(m>8Pv?p-uE^ zE)Bh`!9^friJm8U;n1L)yhEceprxH?6fbMr;W^C1Yum})wAVQ#{$zT8+5ueRM^jEp&Gr~ic!@Vv$i%dfD-Z3%>!-#d^|l6K_zVA62Ic12WQ`52R*FFcT`h7I5?1||l>ITsawW4Z$zr#zZc ztid?N2Wsoi8CGPr3AOmK0rKo`A(n>}$(KE!yOx6R{D2rzS4#z;!(Dij+`#SmDcDh8ebN;MXDLtD)!JX!3G%8|*qv0>RUEz@$+O+E!i&CM z<4?+}0NYdH9H8_$gb_|dy3$g z;95m>j*YC{-Sf+Bc3eWg|0aSwA=Ky(+hK}(TyHT+Gs+H#BVk_f>l3Q({b{K^wDSAJ#w3aQpe9$1XpSF^e&7#tsqwGPiLH;(63eQA2 ze)Tf9Qe%MQ(pPdVY;&L!vyua-Y0k2j9ff>R3TFFkfIR~+6fhzGCZjAAs_s=bIo>0&Ckw|1^wj_G0mVU;Xjt_4dUUA#q>af(ATe&R`d8XkFGfqraiYh&v?A#+^Inefudlq9`ToIg{&!>wS-`^t#rHvb7)gs>1JCi1u6P;KLNGwCYjwoK0DS5_g}JvVQfki3^1rL!2QgJGTgro`?>5wK#^%g$6L((YpsL=AvIY! zQpKb)9^vMDSF+kR#8W)aHCeTVj29{@!lh{0@~lSG9pg8~I{ub35d}s=rG*=$4KO2o z3=TW|YEH?QD`G4&xpVFYNBi)S5erWN+{Z4_QsM%B{?%yd8eU-nato)zqPU07@2?|- z7@OvR!e*~|K?1TSLd;@@1?oan_zTz%JfX*3#?fD*QWN6x=5fe+iRbS#b7Rq@rCGTw zq7Mo<@jNSf?GbSPV{fHU6HPE|6yDdR8#FnT(d(bsheb2rL_WHfF|sBP*3UV%I6v43 zJo;g<$46;RYO5$_xx5$Fb2w%#2hEQm)^7+>W-btlMsDU>V1oHEwBqa-V| zRSBSH!bU)ejmjv7qqD`%IuzkEThdRlBZG(gS+J$lDJ%Yx^RuXX$SD8G)Kwia~ z2fRPfB$0XB$_r7=SUp1h6kUP%;=2hz|5aHJTDxX{XlJa6)J;Q204ss3Fslwi4a?{^ zpj7UVUYi;@De$nc@hb&Ji4li}bvzo1eaL=5+F*cZ$TWVLftK{sJA6nW0FHX+BH9+? zA7l)-oSY?K3U=f1v3XuKXR zLkOAfg|&c}T^vJafl#Y)KkDen0I9{$43euXsgHaVM;|+L0z=qW8fs(OvGfdr3I1w~udR~0& zoo9+8ghWTjxbldke8<~7qTQEcV141s8Tz-f+3-HzXcZ1w$6Np~`x6<4G%|p@Y>beq zFJS1JnmyY~#mcsq8lQ8%A72jIyXuRpPTyA5Sh^k|{jo3kgR>RFRG)yBp>%P5nBfG+ zOF+P+?Lpf?Bd`PbCFgdf^>%TU&yc=xA(kpwR9o3lneyc))^?0yLOO~7sq1TFL}_9V zWJ>p>B)fXHk70R+FHs;IF0V&-{dsdqn8T}rdZX!+YyN&mA zYCN1yke%u5zfbv92O79QlV8{SeNA~gi*R{f|!abz|No+Wq1BGc6&8%17zi~ z)S!WLKYujF)=2`;?%3O<73k`Q4|J3n?m1^eW*&}yyNuNaD=L3pd_CY@yI{|8RvVZ7>0RP=Yy-n>|RIEXQA_wg6hH)1@+0oa?Te;V1g9_RBXJpUDr&O39#cJyYWIu zu=>GouuMTVwP)Je5H5kJ`u4U8lq-?TvN!(U7)I-U?`@ub|^GfTGEJ{!EOKX$}rWHmWvUkPXpP5T*y{tTjkG_*!5Tb8$|uz`A3!{%TN z+vWRD9HEu5omGF>SbMujWEkc+pM7=7O)TsD=z&jR1?1OTB zK-1A~rg^&lgK?9A|&?I3W^eIZTW1JF#Bmaj_J zws9{;HQ(2G=%hHMlb@xJxe zeSv&x^DQ$jRimh(<=Rux^WRyf)EB^ohKZ;gZ15D}d^?PUm#1;8n z%_&+gseODiI8^(A*iGd3ZD!VJLj~^03D=_qP7f4K-eEPhwkPwPyYLM)%)nc)qVt$r z6+Y2L)phr@SAF3Ok8ehReg)4Lf3}SzyL!?J;hI8kh!Be8;6jx)2 zlP~aA4&j3k@_w5^2w09`XqJbuQf?yO$^QQ;J?~Wq)YXr4hz@o%bk@0Nya0jo=ev3ryR-U}z0P~+E4PEeT6sMZHKM1u zxa)MK#;OtUum+mSn7F_U#30kD+O@Af2q64`Q56|vr$TQ<&_FE)03eIjG;WIZ2Vo^f zv~aPXZ&KM|H+H~WAfVc8GGPm3;R_X2O@43xc^;x-dvZuWzAEQjaUQ8s1D`nR;@(^Ix?^Wkp2z7Vo2$tegG!f7_h^>XIWf@ z!G_YCw~x_{LLrTd7sGyYvP>tI-ze{PH)Q0mI!`4%=}^h#%+lOz2D?_L|;|V0whnp87@(*e@*2Wz)8jjYuLe=+Aw>z z5^{)iZz~@j0&YhJb10Kcdu(xM|cTv=1YG4#; zy(uo=Kqy97^GxEf;22E@#Y3!==x!JIy5<>1&B#{R2($&9&$o2qrO=9@o&9!&>i9!r zMF&dWHo%OT_7OD27LOrR--nn$_yBiPljfV_yj{L$IRRb$DeTlOqw{GP5;`BUw=ND^ zFJMw+p=#Nnf3B_?5dw-}B6Le004$HBU)C+USqNf{LkQ=nz(5oMR*dAJvrx~t8#P(I zWG5eHmgnkt#-g*b3T-;(toE%cIvUQZX0}{)k)JOZ!TP6+G}D49t2y-{oOt2RnqQRI zb8GPD(;vSOEwu2aGBx8St`NVkbTw4RAR%%qSZHk+xwCM8g9#uJWZKpfaux@y2e@pw zei5B%B|P}qkHfO)6I(KgP|7x3V<~;DfJJb|xvva2R^rk4%6*Ohn##($v#OI8!;7G~ zYj>PhGS*4JJf$vVUf(&r#@HN`3tzOpm;jDUsbwIpV*WwcRP9i62FJamK~we82Y&xN zeU-pxp8SCkIa9n&A>?{CuAY6BZT4E$uBPLaGN%@uo_R$bHjH-0vz;pvpz(r~)|heP z*j33ikOsQx)(E3$L~FBE!VR+%t9{L8l7-8B^h?K>BE=`erRqN^;j+m$ZSO`PIulc; zaOmf^m6n}f5%hK4l;y*F3l+mzD+kzTt>vI+`0VC;f$knu&2>}p;)6lYb`)PboOdID z(efz9N(V!qaZGIoBiwo9Q)4x)f3v}V%G3es`lrcV#`klald9W^hT`waE_3jdsN#2t zA(o|w0588Q+cm&L1XC{BbPTKT!)ojKj?Vo*m5lPderL}e`>6T0kM@@1-rT|NTi z!Zb;yNayPW+w^k!v#T20%@m%e^TDIPE#8I0>V z>l4lV!YD0ZfjC~9(y8WhD~|kizGj}~#&icsDXW*X`a-bDhUkT~AH0K^2~jp)aEr3f z=wST6jao>UE;V|f`%uNIYmn(Nu207!f*|frS@4Lv<%b;?R-J3(z8l6|%D;-mfDkIh zlliK8sighsoe6a^fPS;izqK=m!4e)){#^uop3I=f{I;HNb+{VwQu~F)vhxc3YnQNL*|mE z<}&cty88x$RP9L!4u2c=Rt&*#1i7C3V)_rO5t4@*125cCsW-@{=4*U!R6bcFTHbbk#8yr*{Sfs zgU(rStQ0d;37GrDm*sMb!I@E(Kk`q3`D~&?h(&7<{3xrp;am3Bd}$ZHY1jY^Gn_f4A-k`{AB^a-M)&2PctT=E|{r z6rXcs8#XA>YeSzcm*ff_c)a>09y$yvU``Gfbcb!0lLgK}^1YB|jje|!H1CYQ8xS@e z*;ZE(<;uHAWidGs=~XXyu`UwRwj9OCeXntfKlfQXWnpK``sz)1+0{9YvCEQH5s`Xn z7*8ljt`9NEaWK0;J+L8|ha|~cU#zOtLc4V_%>!fS1pV6Q(6}<>^&q1+hU+*^3Mez& z-~Jp*?>1yh`w+cT0kgQz4YHcPQ-P8s2AZkU6@aWpX6HRKSRB|8Ve}J8cvi=^@bX+c zm}u-|hsVa34>|EpEew=^008@HB0P=sv>MjdE70vn88Q@HxIrcmO%0d=RRXnyN+(c< z=AyNry#j=0E)-G2000ER0iLC45T5`5Pmdj7?eRIj8+fsgtR~KXPA_k%eOr+a^%4Q? zgVg;!ADmFW@0-TNd2nXp^kJr?8D&&nq{T9!WU>nWKmaNc_8kUqmOe{Mb0H$e^z^$; z@hJ}IK1odGM8SmJs+BkwpDci1)+v85T1%l8L>_;L110Q!0+5-%Vq*gQueCoRXD;}g$g-WUX$s#_c|>0>-8bgc4Q z%gE{ZCOQ&p#o*-hd;q^(3NdqL@Mw{m;}Ol(7Z$V+FzK4zzAM&CTUlm58ppw<^_UR= zC^jx#DL)&}7fibM;@$n#&Z&{H0bN`ZAuKvy_>%DH&F)30ig1MHrd~@zn zI~otjbUzYvfIx#ke9zk`Y7e~|Qj5pFrfg)4Jv3T5V%Jf-PT8HD6rR@(I$ATC4P1E~ z)jXx)I+`HUPxC*EV!=Hm+2z94>QCApf_yrzaY$$WzSDv}*2@9nYOK9v8*-wIUTcIc z5+6n?e_iQ3l4TG|o4!&8O$g64_1I-p^|`gYIQOUV-MPf-?+N`2&Ua1T%f2Vf#*sgN zWwfhh3$TOn`YQw(R(YLF$O!PL0=99kXpuyo<5=g?dZFPr(D}RZ^77HoU%ZJS&aWR*3ZTVDv|1=5QA9Zx^eB2Ad#pzO9|LH?LNfK_4zyxI#9 zS8%d&mT5l*wIfT~*g~KHpg7dilmL;Sf>9}HnfBS5g$cEX81L~_<$)QLKyQfY+}u?1 z9g#1c?fF(J`y0F7mh{~s%8$6BotI4zy4jIuyct?uL>)1n#2QBjU8wGtOf470Q%B5w zweruD8P~b85Cc522-ruXeESV&3>moK*z(7ymhsro;|JPQDZ z7{Cf1V~Uf%o46)kFl)jq@wLFDPTG8_T0zRbY9vcMuHuHRNzX%$ZI}+kboD>xK^b^K z^=g)$alLm~Qv*lQVhCt?a3!gf8Ad1Ll+d4Ml?7_>9RuT^eDdaJKCZ})+!T&WuWo&y zKH03K$#Su2(OFs`ln_BHE9s*$x1R7qM-+X2Q_=T(!7IAz`Ga>xwS2zUGG6Jh^eI6} znzooC?}*;1lJExz--y2T^TnDp7FoFINM>aeCS8j}zNWv;yBb%)P$_}5K`+aE#L{TQ_X<`VJQjcoPEraE zSDG;P1u6{t#n2=ma-6y(TaJ363F=283_+lcW85~u>I7s;m_Y;R3XBDPjLJF}OZZf$ z&uvY-4wB>)g~!*tTcoGwxJG-G7tlpI9G@3}%w>bYDPS!%Zi?b8t<&pTrc;=a8)VUo z7GX7Acnn>A4D*1Wa#=O_hN;nwnd}8V+p<>!kWe(Y}>#A0A*5U@PekpWs@R`cN zL<~1fR=8sr9B}H$zFi_myM$Lo&LI{KhnIODd7ptBwQbdF*5Xd08tG8plKNp`m@Kxl z!K?aISVnX-VuOPBYB{UhlUDS?7bOJVz55dWyXJ|_msf^&O5cObiiLiA*~U_xwq$+G zB`cy7Cp!bSOtI|_9qhtOXIr(>9lz>W1rokYSAT!QEPk^%!817Id#OB-q6?iwbQ^mk ztflz9q$?oTX4Ntf!rQlOeLz3WPH#+5uBP&b8V%9eHi>mX$Rth2Q^xYot2Fd2+H3^) z?uqrk&2*9IAZ@#pa6Ho!9+@G_;zNX#Z4L(UN|nlBCvS^|5XqG@`m{N$<<$ZW_vCl` zhZ7Av{Q8A8r%_fMa!u}aS8uT)>(Ey`?}_2_)_0K*jt=0=#=f|^nvf7!TN%cHT5Iz6 zxW-D9>IcnsGcBkkZhS1?@Lw+z#pk{4F`^D!QAf}?0PQCpb+HayiQBE3k!vo8UsJsa z1DLJ53D|y&K*}C%V|RS|`LeApl6>U?Ui0~wMVD>Uc*O3kr%ikYnbJT%3 zc=ZE|(#}QZ%dQIHQ*DU<==tb!mkOxR?SBzlL;;1w^1L(7KdRv8*d*lLUHMyjWhHK{ z39?BoK^|}mOP5FHatxlqS2mR6S|}F)^XZwA2>HM0LpzJ8M?rfR7hJy-x*w@rOunCn zIOBQrwa}_lB5JCq7b$9JFCJ@Ut0-bUMx(*L8S@&fSTe5fga2_Vn7#Riw5iA{{)P3E zPkVE)J{SyRC4`kr>9Qo~1*y67v<%?b4mwrCj20*T2eA@Mr}J9V?bwJUPEdHE9ME$) zrLSAct%V4sV8HNSBDTdjzI4T0c(|c>Z}6i3vDsk>i=a3paKN$@*^f`NIi64Jhh?#2 zH19^XTMkQ`BK~<%AoNzNUx5MITVV&QGFE<)wsj)=7LxUE7bm#-C=9CQiF}R8BUdSv z&gCt4gwYx@*i(gwRdbxLYz0hnsZu6IXKV#zn2JBNV7j=RY&IH(BGY+a?PWM$L&4+K z^M0kidnxxv?2juAl%XJ?b}DKlTO=z4>F;0#t_~&(ec--!%{X3EY+e&NflN7383PGd(rUP4{@D3*gr0Js6-Jq$e~j9h@C+wD_mN zMFOWpQD;`uFLdR4D;5xE(`0%)O$*2G98U}|3;#bMR63xX?88F2} zqK5nQ4hgqAV}G;IUehCfORh3B4ARM-wcrB9i8$+^Z&@SW+-Gv5GtwnFc$zUl$t@=^ zYJTAExNh$RN#72>de3F54@%nilpMp=m}hV9Zn}%`f%=k>%vvDopP^*21p63h#^|A^jyQ z>W%EX;g~X*!kwiK22MKi6TKK56R`o{Ct8&z%`y}^bab&HSQs|^!M3E%jTkfKu&PsF zs}?Y&y$Z7Yx7(5LFXR%ub$5}pmkrLSr|OnRP04@rdMOz4i?+5qGN1HHMr61JfYTL7 zre!qGy(n%W#tsOcByX#{cqGro-SU)Y7Gy;WAZ)>w+eU~dAYT=!-B1w0aOO&PP5fLv zmbF{A8aG(UP2&G?BW%ZtbPrQ2TE$7-3Lla}arQ^GKOZ#t73t=C=ql3aaJu}@lCi-6 zLm*$imU1ne^P7F#MXh}S4H5rlCR7sG*g0vZ`ZqDD;TAqm-F4qFrz^)dIy&aUFT$y! zQ;~LoFO*&cS=T3lNS!5;Iw$_^$W54F0YAUG8s9)c-k1i!baUXT;~`;k`G@=IxM^epkaL~G=nJVcxkTp09y z+TeH|e4SzI-}`d`RmJ?QAioYZFgXLTG(FNL3yXkZi)-h`Rs-H}MlPLJQ_SKfCFUOQ z+Uy{0%zSyhXz8W*M4IM(1`Js+C|{m`T-C22000NBQD0+Gp?sRR91EI^eg=zy;K~sOmL(>b07IUmC_v z7Gq2I=bN}*tpq^bVjTdTt4pH6Si_f{4V;+gBcZVvC*L!pV1UnJJ13z@(Ml!YIsF0` zf8}39 z+S+)jM#K-D>9tzJXwy+E6mEYCuPNTZlnn_$b^NF1={T-ZDU%3YMSCl4s*E5L&M_&_ z$=Nqb@Xn)rD$tkz;Nygue>yFXP98>@iToP(A&x!TJJbHpv0U$@ga(Y?MuL1or}gp< zXF+!L?l!=80ixZ;gLgtMUxTs=mi z0C#x{m2;mA!fVg^<@gX&wNwJo9kt#X$rOI6if|1KmNz>;{HxG{ypl2KgJ~1$D-I7Y zEUWofvCDr(#`Mdhq;Oyyrk{n^b(0*WC+^Ev^W-ChSrO{tV7Lu8s)|D5KAn?Y>m{oL z@Qj7HR|ujABy5?PY&w|wWJa?chRx70!lVH`6k@=b_6-~w7@BM;hzQ`8NnW^Jg{Vi=Hl znk7l^w@{s(rrXM#(CR^gB3c4Jd~omizaSZ$0nY4RiKnA0XHKXH5a{VoPX-H}E>)qV ze0IHV%@gB5%ltFbr5$(@frxR&L?;^>nw;hlb`DeCMv2wSXFK>ZyYdAGu1*+#fw~=6 zX0)4teK^5vw<3$-nXmfBEx%=Q13R2ba)Njx&iKB_R4d-5xJZx1?Ah!VgBG7!Q}r-& zFlP0K%i;*#kUyI7OX^E~8I*I^p#5RNWCMVO8E1FouN#~*y#IdD2EhO7CvQz4WA#a&VI1~q5+sS@|FIFpn??$XAE!0_7E_}PE zJcOhNP`xJxj99L&m`3zzuSg%YT6k)`rZe@w@}y}@(bw7OduDhEmM63q0hMmetP3tn z{G^5Kok*VCGXw^Dt(8b~<6!~c2V?z1G?A+E&)9g(<~Jcu=S<&pS#_ND~|FtVb|jR-5(4FS3cvvs~2=wvBdSMLFm%VCzpvtS?lloeL&GCB z!YxPGaM#%>_EVkde1U9uWdEVnUIF->SFn%l&-XRZPM0U3^ms}hJK7lz6o@$t2u(PL zQ9ge-r0l<}(lkt)VDSxIFY6z4Dc*rEc#ZDB`DdA6C7bg)und1BBNzEgVeA#-g^MG0 zA6Z@&$LJZ>DYw<}C3YaKWffZ_G+bSV+Bp^jgiF?bfgBxF7p>iu^ggYXw$q)9;1 zwfWf<5T~?qlZ#m?K1dGul8x9rnrrgi{v%aucZz)=(gBh|iv7;xRHwD|Ex!jI(Rx#7 z*GxlEkMwNmhlAF{ENsiz3rj2cMqMi00|ukd3T0x?%czFj7@nIv1TR&(*Pn2JI+0_E zGHYVB#G5@vwCTliI*_k1;PTE0T5&U)R7nrz%^++(D`z6f6@^*eLn4pBisMWe!?8-~ zTB{Rqqab$%hQHQh8!6#Z(sGw=%^QLwSEPQQi5nifS3^Ux71#Ya+7Jx|gd)=(%%QvT zo2%YF1)r1n19=N0(rN4Nid@AzM{mK)1@o~Gl^VBk?9oBmf8qJd@=$QO<9x(MF zo8_i2x6h{HD!v2_Um(<1k9p%3wO?5%&^KhhJq~2GsV{U0ucVznNTYUzhKkpd2_Wx) z1%J5a__#Wef*4hUV1`mL@iV|yGQ2)uwlWGCn0nR0Ot(2_Z_1Me@AJRD&TK3Rw-ci2 zWKdf+Ay-U*$2QSssMuU}CC~al1c~5v(|y9Xa;C6h?_s^z|ms8iatF?^w?22bJdDY$+VDk`J5Fh&Ef&?Y*zi3Xs#i2r;`W( z7Xsh*dfWN!V?@KAJg0WmSy+GoJ694Pg*YAuURFE*lE@E<%-viCb^-sX2$AEo2`2?&2&tki1yU zCn-O!xx^suRykf*)TC+`j$2fW9sG^ruy;`b2jj)*rqi-A?RZk1b1w12A{>1bGH`h7 za58Fj%PC(3k(g8o6kYM8t@EedZb4x$e`BuWu2bm#t&DY7Pu^xBKM^iJ`CAQ8UIq-j(BD z(eBAXbO8m>`=|PR>vQ5LFL6>cAoLT(2HD-xXK);%78t>`Tg`Wrq$Px?()#Q9pJS3s zXY*v1$IN=b3{nx$Fwp}05_(gBmqhIqW{sp|9WBjte*>NS=NiKxW>*Gxg*(s3r*uA$ zS%uf%iA~{+o-%zgHBr>hTl_J`#H4NNlPn3K(F+xif01L_#2FyF8(0)FXI}b)#C9`7LP3XzWGPj!4)W;gQBT2UB15DUGu+(z_?~(c z|2LKo2bKJOQPl*lF<$&kQjwHYyYuDiK9$Y<;bhHJ#6Cy(u)7fpgbwTS`UC-5x#J7r6LH=SJ z=#C#QVy(jZnI6YkvB%z*^l$Utd2Q%G1$OIIq!Mu8Oea|lsbrYkRwcWekLq@QqtB1i z86a;j_s~Ch3al0$V}tKZklNp@CBdJt_M;D597Qw`drNJp zzouK=wC!V7wo?!`A*vc8U7}Sc!?ZbvYGGCCC985F>Gs{797ME0T>G1~xyycz(hR19 zXJGj~LO?+nx-dG|^o~{$ob?ad>j!6f?1<*AHgiq-!MArF-td(|J@~0vYtHr z*0*hq*xcE!j#PK8i-+_T5{L#xHMPv?B4@b(kN4y&_-7t@UQUAvxr$=x@GQCfl7a1&`9E>4iqw= zIzi?OT`|xSHu2mNDMOi+QsP4PCVMJNuT+)Y?h4(^Nt!@#IG{`P-V6SdY%%&^MJ`Cb`0CB- z2L@!V2VRT+HZK#lngIVjyhpnYN@*}$Ib`Les`Cy``x@DCr~8~WS4g$28-E)k-pe#h z%L^6XJSMlbQ?G^Y@rp7gS`1q8OPOf_ zv8pn)Qx4>wLm|62!VCg_lrMe9pqy+sGv}k6$}H@J2gju}rOI)|Y$^XWUasnh9-)tC z9Epv##=x@^m{fMm^we<)QnE@wiiT(claoT(SrE(XOtso(E&6ez3W>nsJ7WrC_T}#F zYn%g3%T;NO3ZrhUkZ{ifN&jZ(D-En%`;3^$?B|0;6keuPl^76GO~}zfnRxE6i+VMb z8=DV7C)FPP8}%+V7JvW2qzu$Ks=Hhltm-)8Z1`M*<0Lf!YtD*cOT*?3pnw=DN3zBc zeLX}oFys7@@qek5hIopd&zdnEI#(5eViBqmlRL_3KulS#r96(I^=joL;&de&_4+x( zUltTvOQ1weXesA@0H5=+n!V~`s>~CkrN0fB)Ovz@UPgpD1<*w|Bz@*d{kl0iBy~r{ zbB=J~RYQvs7$Zx}nc2u$Nz6{$VU%twB|pL3zxA;XYA{9>XV$7YAQS!U1wQ88IcHC- zk-pZSNOBI3A*q%2pQ8!hB6#e0zTgubzh0gBr_451j#o`P__lGbpfS9N)$u$wtNj3? zDGfEYD&yy-uEIuqezH<{D9Fss$GS6$xhvOLnwg}9Dyxy)B#|IDYY!C=Q3a>lA2Nj|wK5$XvlU>c{_JwM zRO(f@A}#E)Oyibff{LQV1|(KYKc)*4@1NHL>tUf7u(~V*^N#qcJVX0!E)b0 zn%>u?G|QI39=2W;Jk4)8rYbvv)|Vn-^e9_LV{nz*Aw;>g1%R}BXVGH3mISODWNuw8-iULo0n=n8OmY7Dh0g<3^~?xvkK zAWDz*AB$jtfh~Rz-zr#+XfF!qRg^R0)#C~)uIEvGI z#y`yiPW=WM9`k1mG;tmE1RnorUz-zTx%_P?dxR@dh=Q8F(>dU6wPmaxS4OmybS1#UYzn*c0 zMWJP0DnI;Gu(hJV?v3mwozVtC*NSvll2R40iK|1g33ZrqUw=UFy~;##Nz?$Byk}EV zSV`O#9XcBG?8P!Ponth7B#)c6v%|a9h@2TQblW=i9 zcJ47(mx1ikD)wlI0>6XoNr!;AKy{OTB&V89ZEbwkUZ78bT#To(gzFQ(r;A9idaMx; zRo|{(nNR?@-PPUxk+n@$K1{mnlzUFK^QXI(AQNJOL3`-?!r9uwt$4yfvt_ZLApq0x zjsI-?@=+U43D|?Z(I^BHDBoNRSLMX7T_&8Nh%7A0yVjc)VChvL zG5R1OAZm*$xzS}F!k2+6b2D||*z|k77Qv`bVlQvH)bJ$6va0WK{_`D8AAFVM@<6?U zAMW+Wm>VE=4f>`lw2LhN9CfuH4G-2wScy{n@ zw5m>jF}C0*zQE*zEm%wrKYF(lo#=|SRo+N*{cK5(CpwGpCq`~!_gPe3o<{o(i%Yp3 zrE{%ZtuF<>z4Ray29;S+94F`UzXR&ckE4<66~a>Z zuFW`xbJyC4s}+m>{~JooPV*6O$3KjOlE>}`)b|v#=wk%HLe|iqHh1^qOow5)Tt%`< zP}Resz|lpI?D*3%&$pbq(3)MknVFtehV-li0@H!izRJDXNpFxFBRS$Ww+3~#oOo6% zc{hJy;S`xMJQsK{QHl5s!owx1rIv*v3ZUEevXNCSaJq8l)Q$I7GUX&=^Oow$MJ(_x zJH(fRJGr((I@4-Qh5s&6Px{^&=i_~RHLlA}__S25Xa*Vze_E z=VAe)xWOK?%n@WC(AX$ZC2!H4*&%^||4S@RB>PX)o{Jq(^J4A`n;X>) z?$r@5oHgZ#EQhpH2o>&S<`xK9-H6y8>xneLB-=&pSW?(uHC1pA$4%oG zQeUo}tts>+c5*h-a?=>U;d9+8L7n?C&BZBvIik-X zM$Dx|AK6!eO@p~*f=N>BuDH(dltZL|XqnR|EdT%sFF~HlWRyf)EB^ohKZ;gZ15VQv zx>Lq#aX^2B(GZJW007K=m=5wLWkwY^DgaWu=B_Km$dg!GVLHhyMf@ ze{F_`Ak(tZCtM&U^GdRi^v9Xxa~4x^Ar>X*0{xSMk;*DbCK7k>HBqL3862fKjI$VB z&S;i_&u%&W`@6;V)Qi6IGIs7<6U_ayAu=sQmR0;zGwqNX!l9LgJQn)@Lg0Ax0c}3L zA&0rd6WnG2RHKqJf`w_w1-`5^bJHV7IQ^Dv31zZdDG(#r|7U8YTAwPK+&*Ux+RM_% zm`18O?O*!i^OG|9(0%)HkDo|eNH@S6CHL!vf&2qgVk8@&+-J`D|Fs+QPaFmx|AV z$iFRJ@1;g)#@c`m!>mi(>TEF=l}5&$m$y34#T$7+{jWofua8t>y4S8!{~QVTH_4 zkKs=h2`X^fZ-VtHyzgujzMMYp3mQ|1zq*Z^Ti`<5G+gzu-=om9y$v4PdR7qR1J}6b znLegJ6KX4SgnM#fMr(jP2T$Q^EoMzPW9GrW78j!HoaQ}Ea6Ql)Y&jpJ>v|0&5h)Ue zyX=qxHtotA8PO>qr5kpW&8TiTk*)KEP?3YdTbTY&e|w!p**`gA-5;~89k3s0l8^+*HZD&;RzwWaB@xP^ zs5qKpT%A*sAi$P{+qOAv+qP}n_Oxx=wr$(CZQI`2h`kSY|3N)eMAbR@WhRBiKAi)O z@uRGU$Eb=WO5xI*g}j_K=y3T^^oF7o zrdDF({sc;AZFXuQh)6ggmz9uq$nOn}OCX^;w~9##xG4r&pYslMkg)VB^Mg3LzxLd4 zkcQlL07WOKR}R*o{J4J0QMtBHTWLRIUm+yILtm^oF?Wg!W~mDs7v*Co?s(`}j-K1s z&{Qy##jtPQu_^!MvsXoyUa&HWy&}MR=_HkXe${0E;l z+9|PftSMtQoW4mIrI|cYS4=Aw8l1~`wOhw`nCReCS2_W&_6d01XY?`+9@k5cg4?fI zs!Ny6!PRI~grF(3>|<%KvdT=-Ucc3Z;r?C02R$*gxI9H5xT6Tn|2Q14M7yy9*(Tnz z_EuE58hvrPz?mgOuiRmdIX$va$=_soDjgQWn+8(}05FbY99i+F`j7EonD23++wJ4D zt(eeA$oV8r2PI0~3LNzOm(#{Bv0u2sTd;Q?F_+|$Yn!B3DTlCBx?-Ta1(`h@C7jB^8G`{E z&gK;fsOr!<8`r4KK6B08#3rhfgBqUMod?MKjM6fmo-V6l)5v$k5+mFtd!VraIEqwh zA$_v`Zc~P&j_!Ebu8w0My74C(%`U3F4pW=7P7xA3yacE?LAK5Z2}x~uz6RGD=;ViV z7*#tbkC|GYcL?*0{&cOQ4D;yC(gE9K6lqjHj)N;flqnBOB76h#7(-4X;Q>GmWLDVi z;W}k|^;VRb*QD~pYwCxeA%$)dZs0e#wtMdx`Zvg}8abs&Ea8FX4Ud?w7Ni!kog_{Y z=tE>uQf?azJjDj+)LcFe=gFijwfrge(iJ**vMUVwZBI8Hl~3se@5fjpuX;Uao~X!L zQWH|0&!AfqeL65(63Sx#8~CLw=74Hjm!X7d`+J5ewx)Ru&n;~cta-bM&{EWe(nG$s zlmK@G$J=u>NE}!obrV7rbGI&!5lr6!+jO@Mh#LQJhgsv%vsRkt%S9E03=Icq@TDW1 zuTTG?-57Kr-Wm{0!oX{#RHFKn+!=Sz7nkW5Bc?^s`#}4MkR-MXy?FXR2vF zgfWEPXRHt~*gUpq%U|_STD!=B+~=&c?x*GgD0mJ`qM=h`eMGt0`n*9rOAgl}dJxC;MrNn8!p|rX5J>vMR*NI`V9&9L~qMyP0 z%OSEXMx`FFffuwcWB}I^*0$|-dRyR(AAM;w4{0(zjn`nR3!ny^4*}t+kt%$g#9wva z!fZD-Sc7~xhGvyeUJ%5ym*`RhSBBu~z+A8W;FuQ`cd2@!T*J^?=gsWRjey zfcEWOt+_JZ$j+r?bX?JB)vJoyB#R;6lbiY@HtKK%o5y9uAS8*68GYVFMe0edWax0G z&PLeLD^~g$-Ubq}FO9Mv!_v;zDjlc0dCE+7HB#mDOMP$RU66L&QN%}2V6CTz(7C;G zgY$)iv&1bqMULbS4SI^lA#0@JCycNV<=L$kLKuX)U{&Bh(H9a-_4_gCN_lQ9dJbN+u!H%?2hfM9wbzyg^O7&%>a~<9{5jbpSswnrvaRjTpju@Tw}#M?u-vcX+3VA5-~IP5(XVfoXT}+Y1=*=9A}82rZAnKnJF=7_MV~O@p=aS=P|WT$8X_Q;r(SR_;ZbP1 z_9nGjsL8a?t$LwSR{riC&iHaDc&vR3Ou1Q1u|Hcnj`kTH9>KOcoGES$uBh7kGGK1 zhKxKQ*??xH`MKBX(l=n5NLt{kfyUaF&Wyq~U+1pXboAD4(rT{=s&9}gPxy>k1o)J6E~hDXej2}XcBCe6 z&uW6lhXyE#R?j76w?}Ym;Bp0mYapj41F)f;w1Xn~IZHq5Ls$*5T{SQ?Lv5=F#X#f;6RFVGJ9k{H}E>+6-puy#JI;2oAxIu!7ZvMjEsDQWX*U?G#9sK89RLYQo8V&Zq!2v zK|Vu$$Y90_moE}He-Yr&FF6lU?(yx8to5+he8VD~9hiSs4OZ_>CLJsXGg8PRc%?}v z4a-Udk%)Z}hDmw6!DLtfr6_>);XcX)j_4MaX(kC1^e7&M*jl=b6^NkGnS~^cw&}<= z6*Q%d{Ig;_Wlyxz=u3Qc-=941Mfzhnq`?b}r~u6^;-tlX=}Xt}*w=zpJSh8Izl9xf zT!a{DGFg=5b?rSgUv3}vW-I>26R}6A=QERE1zl$0Q(cK;qMF)#8Ea-RnF426_aNoVQiF*l#oCP))e8h z{qDqFtp0^L44eoX1gZ#IWty(-xg#dmYtOI2h|@Ka>FD`>5GWmZR9jQUdJ1kc`)-0C zo!;EQm`{Y$zqqZH8`&IdQ>c`ue^3Qa^R@B09^!i3K1{~34}nMnS&?RX z@Z%f^Hnq)z`7^SS56ZJvj|^1%*n5{x=E_K&n)zqw34_X5Z&dm(dZui$v2>TyTR)k} zew##+QuTY$fEl46vi6Di!TgP_x&wEV^1FlM2WsYyt?zave*t!+c>-_*qDu zr=Qo00tio(u)kMnj~$>Z$5{W#suY48J~*FtGfH?1GvSp(hk$;Pl8!b~mkrU=Qy}mv z)h)4Tgx8ta%{u6K+JX-1o_;v-W2&b4Kt*xE3VpT9?k&YrIG$PVHZ0zU`o8rpeRej= zKm84SzcMT{ykcB*kf0MPKv!JVrmJwR{G2loxqk_Ncp`;PW1B#m8*zGHFM+&Zrj|lc zAyr{R^-H)HzQ-g{ozK>ca%I0qjPLa_n)xpwcuWop<}jip_ry4P{huR|xkUrZ#Vscs z`!ghORHN&fL32oU%XR$>(QU;lx-al76td#Q;&NTN38V)?y|3QjE;p+yY{WOSZ@W_0 z@6fWTe#{`fn&@43wog$KQn=4fb$rWR4 zim`Ag#x|&p&A|MO)iN+}pTNYB*ru?^Izwpy01ae-l>+(dlKgy_-Y~jmI^eOeWL5=1 zoFw-}dboc^2+%mdoXh_>9CillwQ$kw{tn4Rv%^}vGu>E;GLHg!%L8x;`T4Wi`uLg4 z7@Pf(S*KdnL}68MB)Z-6RkrELk~ zT=~v1=>+67R{6>lVIIA)MXD2j00}B}yEIMfhqfsOxliU?E{h;P9tsS=dBAS+j_KAs zWF`C+MJFwPl<9E4Mwzw*NMna>^2H(%xCs5HzOjkoP#Per$vr*WDe^wt?jwuTl~J2& zC&EiIOsA0K5tn*VJVk8wz}){SZqv4$8;Fuz6Xsis$j17%v#pB6mcQU6EgPf2XWRbl z4@9|jJ4fYU9laJgLyt5`Kge9rUlW3Ldl&^c-qo`(;CXzysuswKJDuaG9!=c*760xn zfUS|l%c^*6v-dQFiZzD&G(Zs!i<+=!5)hL*61*+Co`xTHwB!7Mlt0$;fOLhP;E(p1 zvP=y@YCQx@;Q>F!kw25+8$u3Hq|q>vEV~kAzKBR5>3|DE2@J{0MUAAi z(Xdsq#2BppYwYLFulQTXJsg9t=GHHW^&Avm<+xFt<@ zKM;a9+1hPJAUM4c)d8GNB%J{Q$h7)Abxl$5Po5a3J^5_l*CnlkMf~5T?#()64t#uC z-dDlUrrg9!KdT%y66V%N%&v2iuA6+k0IWz{WoOUxTl9BD$q5H-G^5-v!)*MTxl2x! zZ!2UbgxwMY_h8lVl|@FzFqmis!F8zB-|sFk_$lCK2a08IQy&zHRO(R;`X~1HA2I{P zpvCjZvG2i!LhQY&pT7?rn)S9jTXdiDR2yO>{I^$8r0_kO4W)F8{%Os-GPyd8Aw+Z; zg@Xt%g=JLooSK1JG%*PSG^YXkHwRR|7UyE9M-7^eD2F7W0^OB;v-xIDKT9wN__Yy( z;dOaZu`^qH2CDL)2@nY4-6ZaOvAj3|I%Td(@peo#@VQXyrf&ad_7y5Nuks_-rJ8MdDWdpHHwtCpB4+u)$kX!NRX4 zkEnv4yEvB|8_7i2Zk=a>5upF*Ebk|np3KLm^{y}ZkQ-zX!t$bR*`>%%{UiR`w&Dd> zjqqUPX|tH4PKGAn#pkG*R_Z&J^h+AP2|?yzGkF$-oj@dsOS36dK|BsW9&d|>jGv!q z7Vi7TNSpNH$XBAmL|A&2_>uGktS4R7FpF%F-%o8FmbhPQ(rr{gXl2nvr=~ySYm>uj zK{$yYT{^8An`Wz;!0j08MiSDbQ?eRaGSx>|5&Lz?Xj)%nTeX?tOTg_ z+?E$aL*@+iWS&&z`KrkkUrR<8Xy~_Pv-ahpMrJnP>`T19<5HWql$7^$;zoDc(IH=@ z10|RHNKa*e?`)ti5WzgY{w%x0=7IVtjZ6l57i7KmDN}8@n@T?FpS*bQnPeR1MNcX} z>|n|o&d@~}LS}BW*T#3Hu=tdL7wn8K5j%gXZ&8<%dI5#?9OXuLo!kkQ0PFVGg2Ba& z;vP2Lk?b;F5BAM_&-3uGapAJ3?8HYm;$zw9#`Vh9tt9X64oYOs^A01JvgRh=oFB`% z5372T|K;$UJ+Ovya;1jzBmZTuz|618hM;^44FW}^H+CRI)S4=DiP>3TLipdJ$P(~oB1a#bepmK61lWIL78I{Q#@+u1+s~`?M-u_qxUnWfJE#ac ztPsqZ6b&9PDQVU=$^iBllH}~HeDcPOX_Iq&P0hhSX@A%=aO6FxYUto#WK7C$)~zS_ zWy9Y7{5;2j4iFUmv0UtF&Q|sI`(v)57>>3^kA4jhEH8o&(A&i|^7mV1yNh?7&FUL> zPH97ENBB(U=Nu6ZmSb69}}B=&3|Q~5zxJs_ri(6$hVku_WZUJ(-EfE&l&P=EA4E85ZG`skoz+SGP8AdU(*S5PJi;LhfyK^%YOHS_g9~?b+WoNxo4r5( zRI2=DR^~#!SW&sQMNJMREhfjxF4y3;3GYuT>O{ zB_T)-6B0EWV7^j2BtH-Zj+c`&1oSUndoPE1oh<;J6MFTsFJg{8vaO<~PUoKCIbu%0 z;}c5V^t0a4TT`hj=`CRu06vHyI`CP%vmX2y4Ni+mN}brligOvX#eE3_KnM%@`lUk` zEA_aHu$zK1VrUCY+Ke6yGRsQ(@haqQ5!9@?+k7vvxhqvU5?2)xof`S9`w5a@i1HIC z*TKrm<*-wO#9($L#7P?`V)E801ab)?s4dO_P3l9cqNC;(?epN#(fc;z&4bXi%c=N~ zfBn2G0t3I6aj@ZAVl+qaU40||MMzVcKC8_=sLWK46{$kzER#lDtMsVFx@dmCqxG|m z%mtmEe7RaXa&SPXc5I!cCdV~1`%V_0PLgoysT18>jt~&Z@1-Ou90j|;zI!(f4+=mR znVEbTj%n|rD=3LF&s>mdQKl7q0|~lWZuA-n`@mt!rK>j4C0J3m?)3?2&_T=W+hgga zaM^xVC%9M|+B_5&5U)S77Q$MV4X(tDI=3?YI)*bZS9tjbcKIT4eloi2EVZ_Juvhz`^6kC8zMI_^@W)7K#McS=)=!|u)ZvlZ z04e1e+zP#0I9Zl(@7fBMqJzqSn;DBIeuWFAB)%4wBE&z$W!!2@w?#HWIyx7x?Q>^m zOgPYdO%QEHVWMNf`<(GJ?JRToQg`i3p3l}Mb8P1nd)&yQeIpIf=+#~=CaR9>-R6fGv#iD5JOuApppC=DAUf`=*>cg;dy;Cb7 z&K`9mLXo;QrFj`3tgnz4_8QP6sZzZvH?rJkl?&534kMZ4v@ex-9ikrSWIvokje>hJ zU@Eyo_;6L+q)lJR#bfPo$NHHT!In|!-joe*wzX(!p^9C<-};6N7b`ren* z&!86w>J%RRLp3f8Z)6*kuXZ?S>3Ib$hN9Exi>APISjnk>G9@)D+EFqwCr?56M{%11 z2|?f2Jmot5@v&e*g?*}rkj3ScPskm}|0Wt$^J7tE5{@F_xAqim@puK7q)bZ;}e$ltGIjIZtXoT}?xLABzB(GxbG}jkfH*GE*YEXcmh8`-KPs5ov zATBOR#{iQ_^GbNG1S4K}`cVXp#BbxD5Oc1Ua5daxD8a&EuyxtYx1j!%p(}$$|D?)L zzAcJ9v4#cMOoLs@DE7LJpI%B+tsa>|m)jDUkH!2FDjUI@d}n*{J3)ei1}dlomXfbq z3CrFFo5w-q(7n&a=S{Jl?g91iLsYJ!QI$HW4nLoM6gf-!@aDT$2ecFD)A^!bSLy^g zP9(2&2F8P^E#IZtETzFSY&({mQTpgYrGUtQ#KNCJtcLsz*FY5X2flrZZh2M)7)pQC}R& zLerqmmn`EJt?EA#Mvqb-yHZlXJ-&lLJ1?i(6xCtoSCmyHKpOYt3R8w-#O7AI&AeZv%k2oZPz-nYCy(0-49~{AI+IDA1M^bIhmeHuU|!2gn@J?Lp$2H~1qs*Xx5n)G;knnU$CQMeHYY zZm*eZ6a~&Qx9fb!JxrYR=P9Lqg!dcMJn~Z)?^hukuX*dqA(es_u~vkg1@KQFBWL#b-YVGZ#xp3>x7ChG@zzD>!wT!yXWZkV>0qbXraj|z|EWH*3#DG;51 zi;g;~feZ%-rNfLt9OOn7jgSXpa;{RcBf(wX+Lv*!QQefwT$8BlLx@( zbq@zt9~onvq)jnw_GHC~DZ>)VQk}m{SX{$E1Ga6T!Oyf@WFn3+is1{C7%%09c(5 zOiBV!Wr|E!I+$g@+|Qx~Zn^|Fry{eOfwyk*4H`(%ApzTq!eE~`6G@hdt1cq4V-1`v zuJJFfERLHwVXqNmb!>mmgGr-O);iIGzI}`xqW~5kZ|6?-bd)RmfFA!%^&bMcaR0?N z$lRdsiYehSkl!1-`}fa20VrXh0S&~pNuG`Y?znOwvW9iuC)_{7ybg*2;O2BKj_=4x zvgqNW-&U>uEb`d=AW*V_Ml^L5wgd{QhO6RU-eACh_%rwc!;K&uq*FZ6s=ah)d2NY+ z@M8xWxagtyNe--WGw(qf2v8?T=8JzZ+mc)2toesjWb`Dm71`b5+EWGWw&Qj-pMqg- zyLNe(s3(s}E-*?@kM=kUKi-oDf_cheRXVxVCN>NPvBOI-J;1j~Oo{C*pY5avf(daa zHri)$Jy-AuUF!=cnt5sO{^^{p|9oRNgd&IVH}szRgolabYVfj?mZ`nPRFRo8jEfvJ z*PWSuUN|_t6_&1A4`PvMzLZ$1=Xm)G^F!#^#TdSXz&!i-FJS_&h6fc4yvL#TFI(v^ zzHGD_RlV=S4}nRVF_sm!p48Ym2LP7pDDw_&$|gaZX`mC<=M^&fks+I7n`A5u0K%8b zm%oBw1_5v z+ZC_l9J_aQdk}!ZkCVhKTNLe+WBa{~_2*peZUjHB;}mWRmK+XE+JvB2BKlp#a+D8+ z!Iq2wT6e_n%9z>(LN|}-W>jX?NXp+%sW zEv#^yQ#drXsisszH<54LtHeas2Cua>h;C`ALDH!^%_%<_YPjd!%|%1Mu&yHHaVNPR zq0Br*&3abkVOv;zCu4Vrov@>9(syrBtTFDJwUP$52RVv9{%GCz!^-vR;Ea;zDB-uy zAZOrR-SK~D^7fWTSx((MEwO5I?H!3Al*8#UwP3zhBBbRGXZ$Im!jDl13|tx=a$91z z-Bq+bn)Djf)(I+`7;z_XA7zU5mUD`K|XS5>NzDuGpQ` zS+Qg?h$0EAoO&YE1qL>veTN8LVDQTn5w`pCr8=cHCERJk>94NP90Tsf(<@XzME1Q# zCO_E+oQ^B2!2uhXFo#zC+CbGK&(#+vpm$J~X=|wEhZ?VFr4Mx;??GU&zdVPZx2a@D zq}DF*oYP?iQ;xp)1UL}a=Zt`LsOwNJBdRKE5d8rPkA&j@9=fHh7hABxF8>KuPl4eJ6^?S7}I&s%z7A4c!)&I;uuNTZ^~O@k!r;(C+%rR6}4wu zo})@p#vemV?;-eIP8`ZVf;Ytj+~{|&0Cj7*O7|JvwOB@~jufp2Wma$B%4%`*{J8ca z(g`c35JD+L7ec((3A6z%@^!I~FEi}^ooq$XDOmoOgaFhshVu(dZVeSgE zoR=GQj&jooCS{c7qJaLE+OpZpes^g|5=K@|!ta|tE1jg7nyjwR=Olj=qUKMnB^Pm{ z#Szc&n1%WgK0(bd5t?Wl4!qaG7RFpEBnassX5$#esQxN%5aP#n8D5=S}7NiO^474Uu3HaBgnzyMa8b0U`wzyUn=egP+c{8 zKAU2d3^Vz+KLFkZ%%%BH^p>fT@|EPv_(y6kOhW;JTV%FjN0RhM>jO&~j1Y9~Do_X= z1U-^#Bnc}3u6{oW6WUpMKlpPIIC)9Chs%RC6A3@f>9wE?aYVNmLCAz?8PaQt8 zy*qxQpf5!vzk{{swyaNn>z;<_a()+6t?xx@L;-`lH4oz22hV=29ddkP2CYvo5XPHf z2;Yv49`&9Cr@+H4;( zV(f`OWU+c$>0*CJjli0NoBu6wtZADzJ___MCryhj6vN|PBX=xrqVj6G8s%oeu<E`;$+OfNW_W@O!_ z&WCz${IPF`aJUfxXe#8D^*N}mkVG)c&z1hFKaiC*9*&VBSA%U~1xu8Addo7w)oetkEsNu)OE{GlYj8?S*Tl`4*AkrK-{ac=W7$ztXel)b}g z5J($#5-F{OR2(`y={%JXb#$f0k-)u{(tLq$3v}Mrq~@{3MW(T{i%gQf8_*v@ct$Lu z<;2}%m5c~vNdK*z0z@cXL`dqhqtaS{j6I@i5+z!Eb7h`LSTp)6NJpz;PqoV?>v*r} zwaBdj(}&wXn$PW7fv)({D(LrBQI*y^Z>D{WYv+L=zcGlS+A;(}qYPDk*Ii!_tMD68 zFbFbRwZjyr&2i`i5BQq>0<}3$P#54j$6_GLAK_}Kh5W_08CTSPcZ)xCS-z$G6S}E% zCuJF~Cehtg=wW@(#gNzS1i=ktxL|bPlcUD+Pm}=$K<A*$) z)Ga=Y9`a&L>^Czqvw`&hQL_rQOYrg|Ahe1xxmm42MgXQzO}CIEc~GH4;|1sGPw@W? zN13({UYT9Hv%?x|7O!Bv%NRTZ2E{bE!>d-J8PbtH!I>HEAf!E6abDkOQl=B?R^|%5 zgNWS^ggeWcjBbCiL9%qCB3pB+Buus@0w}`~|ShFT(a4bZy<$mVv%V$D?t)J2Xklt3Cg60^Ip7@_|EVTA> zltkQ$s>wSCj~TB2ECXYBR9KzlAKQ5J5uo78(|)?2(QqzEAXJ=qIC%w-D~=iW8DBlM zeqH%gwR&tvR2d}+!A}DJO*&GJfNy|yf-0W4g)?z;eI(qS-yU&^KvO= zK>En@`!kx4C5L+j+|oFO!fnqmf10!2dy`-dCkzUQ1hOkTeE9cuDxOp?AJ+#A;tj{l zXLp<|H4Myc+xO2)6lr03SS1PEbnQl5R(5($;_}mdn8KhEnG;3&)3G75>p#16SmQgu zW&uONMZl5#H;rRdu}#HL+7bhVdNjKRbo?8;C{QNBtUpLQGi(faR7+=l9ll>Fvxxhn z8W8vW-aQk3#E|cbhGsTlXev_#Rom$%f6t>H3F;loB13i&-?YKi^ zIuh197wU~c78{n&ip^i-93OIhqA%}?LY66g=8V|c9$*v#W4|+#ne;EmFJe)Ue!Br-St|fCarhD(Co`2OPE}#;YX;H*nU(i}~Fsb(_B34@Ok=dW1-g4$|Zi&ca;4Zu}ASn!2>+7D^W>7kP`+%Je3`|dxa^OS789@s^5Ghv)oz5;SpBgL_a!_HcpUKX^5q%@Tg$XZ z5Ige53FmhC>WFOYyBe?C<1V8MB-q=3b7qh4N!z&ZqJblz=iBX4qrrPOI2CETV2qkqFD;8U9}YRQ>z zca>CuJ>w2HVJWVtuxG()Pn;QFe4H(bqsY^qfgu&+Ett(9twCcN~Db=n=VkM^!^M( z8M4<}xz|{vvsBmYw7FA) zr*(Ze7gCL4Ca61QT=N&V z^zcf_Q($$he@uP^l+(dAQNd#$iWxx|f$NpDFCKRTH&7;OU)$VH{cmQ32R^XFW9sEU zlFx?)Acl&TzAZ`D1;|fQP%o*SaYS%)pKTf|mkZ_YUlV7fKqm8lYfA6}?yk}RWG6Qt zuT`$^CBjqCvC<{f1cgP^&hJ+Gn`XARU@d~m@o*;x;h$|znpex(dXZ-1vPX`Ms!fp_ zHmwvW-sAWQYG*8jP>NAGX7n8*b?%wzRtE&lmO(*VNOIy2#+~j0?|EwvLgse9A zcbi^eZ>zn8ru-l#RLj+MK&c$eFWbRtLDPvmRd~FihQ38%W83* zQ!=ZwYrcWKU-}WYbFiZb^T;QY&xETTGs&qkTi5fyMbQtSo8LDsaPr)Un1>x`?hMc&xka!rCU;{oNBKy6o7Va|c2B`P84CTE@a+|e#)*L%lU8P` z$c=3>nbna`941kyy?5W>h>K0U2GOVDo3Wm|Z#1vogIgX>qaDipp6zgtHyA{+2 z>4g%yzs?_|JyxlUWg_Yzi2*jE;%Yt8tNY?oZVf!%CG7nqNO@@{t12CQ@k@LUNMAbkG4bo9sTx>!wgSJd-MP9a1YonGM&1vW;cm)~9$EW$FxX== zn1=U|%$eX~;-C1pYKz#BOsvc-@7T(aybBx?A@e;oJ58`rERZ?xk{O|%5tt|3Qh(4E zwUCO0e^ZEArJcruJ9#J~-c!tF#hYA95{wqaPTB-r(SE?Rg~Sa`ibomQ2&}p<84IEy`N z(8dGV^04gj0wK@I6sm~zQ|PhrJys4!WM)K}DS)OgJlJry+qc<~+O;k@=6y*xls_$d zj~TOFlhxNQ>-b*0SuMsZ1F@gzpS`H_=6&)xHB6u#7AE0*ecb7;*aArh3%vdWz<)M@ zV!hFe=wl}mMHX`uMbp(?b!@zG1r><=O?(-QfON=E6niq}E8;*X2h53BAaW~K({{Lv zx6@ZXKgm|KwMVsF1sOx<`Vd5KE*&I8w#?hjRRBAQVGFX2zPn%MA7}&lxvKk@5AUvz zT?J@dbvWQ2R6A+!Y-O|vq_(akIV{2Sl55`wo)6(R^V|-4s%##+wkTUk{GOmWCskWA zSahwhdaEOVf!0-}q6_n*eOl@`0Wk86NvyniB~jVGAt71vM=%pp9u=BdV`#YuG&2+B zq5&D%M;rHdMG&C9sVKp(in6DUV|R&u0^4Bx?Ttn+sPa_YUUMepgn2%KXM^Gq2>Q)I zpmSvi#P1l`>S$roTl6=6@0cW*w8oCjZ+XdGC|`SWnlerQ?RvtaulXk!?{W8NEuT*H z?fvQijL^68_B{{2NJ$Os6-0OpcNrihv+#YetjMrFo=UQyL8k@g`nL1xPR#2GoxGDN zIexY_*Z_Y=y*N$F@KOTaXWVy@;Fa_F3&Bcol%OdOI-IO)v!`7~f*s zUA2tGjtTdbwZ%ax!ok&xzAx?tyqliWu_A+(TGmCxSVv@3z-DATkR*v*=fh;VA&MHZ z8FOA@qtDE!{hP|yj%zfk!HF3sQ%|dF?w5~X4F8u1MjH#fB}xT3b^u7AN?o`FK%_9D zAMS;H8>57{8^VKG*%e+}{jAbWe)RYkQfGsvqU7O(SpLG6zqliUdMmQB9?N0`-3KcD z)@P=kA~h`?z^q_?`|ro5m-*V~ce?%^%rvLZu{nv_jR-nyRX#!83cE`0n;lH}xtf@1 zcg`mdA%4+zM5+`K)EJmc9?$w}NLzzMrd6^@dXGI658=%n@k)UduFWj&`lq}yxDeuX zJ2-ClgF(>+47TP76Dc|$*NrvvqeBB?Y-o*x;ZY%l~Lta@kUeB;n=y0m9Wmq@( zc&qjoTb)6T${m;AN-gG$;bH!|Hjm9#0%}%vy(e8BvB*Z#?OF;_<6#!&Y z8@+rwyHclYGH*lEb%s6h^U!6PrSqDUWoB<9mpP_Vo91dmLu~9LE7C~{S)c-R3E4KYeG5TH*Wo((02nI=`wvPYq@D18*i%IY6$YUxDB zamaV4N9nUv@XL0wNf&`>=Rw!$mJ3?KMsT_VZg1l!gC5Tkj=x^1Q8B5wP{59@n}F>i zi<8DyuCtH=T#n=o_@(VtVIEu3bhINIac?FWhP<9+G1u2+fF6|O_*q^~CD{04IdQm!HoQd&%qKjHD0vL?G`ckaL;Y>p@E61q!5z5pK$@6j zG)F4_0e8u^H)1?$2dsRuMN}%caCG~(YXjgn_Eg)c(x9wd+MHkp#_8CdxYfv-{eoQZ zr*)t4bk`%OjCOCWlCWOf-!_jOJomoY$wON#t^#hauB(xFnrcI9ieNEl=a2!yH;$iW zbI2x)eN>aJ(L4ws-Xd(!?U%Mx(0RR4z;QrvC_EC-)yq{>i40w;1^ssT`f_7|5NP&X zQfOr{ANhU78w!8T;r8vU-|t7>Q4?iZ1i_tLZ(T8x$T(iQ0Ez*}Cq${mhkpG&f*6aS z+W#7n>i(3w3igaw(2U8Anpf7F3if(ZspJX@9Y2G(88Y&bu&D}! zZ^bTQ1~WLEGxe|y@gw}b9;ZB|{2<4fyj=sd4ZYtDjf)qe2->Ir#O6~RC-Cr7neQySL z+O{sa&AfQZ5lbt_90OC1c0aA5IknkpjNIB{J_7==Bf?EnkMq85@?L$Ts~t>$o!=dP zz`k{q__BSd1%$wXK)zRJRDhTr)EM!B&WTp*sB!F*O9-9`AuBJ>rj=DM|AhPt;+~Z{ zSnaZ$!41qOc^Yi{v3bEuVC#U??u-+Cd^Vw!6jga{uhPi1tl5 zt)NuivRz>eiPtBD7VkC$2%|gW{M-h5#JiBR#S@gS0YnXOCkZ=m9Q;vjk#_LZgQud6xIV zpTXR=6Oha%RfUaI%z=eZ?#e^Vt{M`j#E@i<^A7v_&gIJ6J-81LC3P#GC0N|CS0+eP za1#aRj=S+Qb21KFycgDi1ckp-9g^S1W5}by2KCl2qFa*t-*tT{T!up)cXGm>v`Obk z7)qNBi-kjPt*#acmxL@g!h$;Ge;YxuE@^zKMNWFnxg@S%3#U*%?Cg)wlEJ$ohDRoH z@?g+1&WI@FLTmN@b8}^D>B7_krl2_r$hx~icwTmfCKhMG^OPA$T88rV46jxmYj+0VsQl;NLE16Ol z{op7L>HRX;vdpsj9%B)ATyf=jQ+A78;o_4EeUbE?UvP8Jti_cbcSWgqFK4J?$;wH< z;y-q7_fQk>fHDmC$;t!gt_Sqiv(MHqkJ3f2_&&0SD^Um&j?$;X?2&cQywvGBn>9f7 zw&WLpcOC6PG<;8=8S<2TH2kz5=q+Wp1Q|e-?5An!)R<-(D$Nv;RvDqUgHlBvrjhMr z7JnQc9{TM^F5@ji{ZUVyluB(kv?@sQP~Xe(L1uR?+x2LmF#3J-f&dSjNc4q#^M(ZtY*6df}p+QCcbNO{1g z9H{rjnqx!vYyg{OJi~b`pu4C8p^d0c01f*6Ph6 ztD@dvHx4-Qu-q_{Qf4Gx$O2t4;UIeBlA;;_R8u>#7vj-zWBy>QbQsIXkNAdah`cAV zm`kXj=1ZVPYHeGX&`CHV><&s{;j~c+nIkQ${{CO#(>nG0P|J+0=SR*lP$Lhxz&$hG zU;g^djAD`}%*t4vFgs%XPdo3{6z7(TE(i=@Gvor}X=El@)$DuV3k~xM($6!q5NBYP zMYq$5ky{7^XRyr^4PoLm>1sv0gbv8@aI9@PBk_{7n3Y#YQJRDoJ~9dj;8vF=FGM7h z1t+7ePtGKw2w@Xq0i{_b!t(r*)Sp*)PCQU|@th)6)dQhM18w2>N zLA#Exf?V8SZ+>tNvO~!7m&EN|vK&5K@-#G-g{dr34y+rt=iCMK-)*%hZEHE^@4QMm z3b_QDGXzDzt6XFJn8LZ+3~phY{y>fke*e$8wiYGd2CL;{**|=w_R(f)+U6h5sQ>R(w`mg={Gm#ZKhVP zS8!j?rW6FbrMMOv*jj7zbR(4()@4|bnFejHt&_BtqN|FRS%oFqj}kVApfjQrvaz1t za$#Aw0qPKzdm!IcR1!ZZuy)`C1V@yni$Z1@xr9=8w;a6l~58}mJMaw>88OWObv6t*pe$%wvab^8E;ql|0;9Os$Z zSlqcI1Ef*4^i>C~$q2hsdr4@OtyPmSusX{xki#u(^%^;IHP67c41Et=U1lxK3DgJK zLnZk*WrFhw5Qn!J$MID6pR;R7%vR0gqxI+g&h#GX6!tz!j)9$(!HVgLL-`al0HITd zZK=R`K!r5uK{D7@9UkWt)=_)$u!_ut6}&g{UcLdVxV4PI67sxD66 z%m0V1bBGo!*s|@lZQDj(TX}8Uwr$(CZQHhO+g4@OsA{}Fe*5%e$3C&22CEj9#?{N?-Kksa9z!LTYfA*lIOwq` zn}A71I+1=XsjCTKy-(v0s#kKa1y|GQ4pnW!gA5L4MjAv;_8}b=5~Y~_x)E7R)J@N^ z?r)g8gTyy&EcM`;^{$?4q>^w}og@kmzIUrac(jP=SU5&(DpmJBB-}j}{{AQ9g_TbE z;|FNEAvA{Tq6p3WkciauBl+4cb)<;Zlf;SQcl|VGj!`VCh;oEnD$vR_ zP|y7E`sT+jU{1iS$viw0oYQ8cC4^D7)R>(&Pnn z7x)lyz@SgKW=i|tUD?uyKJJ1u2`7l*%nrX@Dt$bqGblG=$RfXxm7sOH{;szJ zup*?n1vq#^R?qthm&@O!{P*YPgeP#T_JMBX^P1RdBXDa{1RLASEtsUN9&qkgb>jTM zKhkJXI8&4HR4lsXdXkzi8^7EW5g1fK!>j*D;s$|Sh5raBxr;O|hGo(J)FMrLD!GSz z%*_CRE@Km9e+6GlN@^|H_CZ!iGPIN$oNdA57Y+pGTjL$|C-79+WCTwtOk{MeW^*aQ z=y%c?tDgNUV#?4uQL&39RNK4RHh#F2doA1_aM9@vrsj{3IJbU=u>X|9uftyniXI4A zSi6N_&yepKc!SyA_w9=?g`b6}4AoJ&v< zng~Lc{nLQqbSX65!5@N9zYCWf0|S)NFkM#xy}CV-p_g7vZHE*>quUbr$1jP+&j&?8 zP0+A(vG;mRjaI(?Z~@u3$Z?DsJ)%H*8kqiBQF0$2Yw@V7`!CT;Hk+J)tV&4Q3IC75m#>jLuQT+8 zom7m06?lC=BfSv&B@T01BzupLeB3L2@D0WE@PSbf%=ddApXieT;}6tzA9xS>UzqDA zkLt38%_!xCQL5h~8im?Y8p$0G#vJl73bsgZKe07RTf&zF7pe^PU%_Sg_)CEon8ih! zU5Bxjr9tl)Dy1QUY#QHipGro7YMb^l+T7M=qlXF!&-lGWSpHV;Hq%<&!m~vJP<+4T zU(Lr24B%y|CM47x&wQbse;I=)COsa=O1)KSNIJ1+5%0GSR#73vrr5P;6+NK5u(|FH z0kLeV^d-Z$iLwH~cpKcV{~$*@bKZ8mb}(gg`*n&YE5EOi zOQfbtkqo3PmHEhBEQs}(D>C9gu+Sco%OQfg;=Y*CRcSoI8@|=?@3jYSkC<*7d^?c0 z4QM2^ZUgK7K~LP>{<~B@^9{=UVCkTG{Jl`CV1&Ocj&ny>4iUaDVTjxJAMf#hyG@)l z!10o$tK-cR3vgsV=Vfcm4W$ljljl5iQKzW@E5PBw`QUfH*N%_c<+7d!`wQy=AIJ4} z!36|NM62a58J|y>0Uz>AG@kslD_P1l!<|oTM$Hi2WKKErJl;ydW~p|x7DcU&3^fz}24%D|@S9B`q`89v^HG*Yoj--)%n& z9j&zd&3UEdDu_5hWzS{1u{h&H9Wd)Djrl|p?&bSC%8G>N{+ zRL&tHZIQf<>ts679nPD_u|hzGdGC%oL~?1lH zGzWTT(_u^Jjc-_LftyW-X--2fW}WM8N2-*i&aqs3uC}p{)1b+e2lIz1mN}2oG*)af zf*PaP73l~qieI*D1ugS-ac*9W0S?7YiT(X~;8Cju=Ef(z_2598k2W% zXH6heLezqaA~7G-G;|-|X2SWNuZw}3-r8E078Et0a$*Fbf*)kitq)7=H#no8SX3?8 zrVt=^6dDA4-B|D-WIX}`%s+<|jILpx-c>@>a=mA)Ps&Qd|JdXp#8gpOm1FzJP2Fb- z8+7~kheoFe6*9A%ElXBTnw7|~r8X3`t5SKTS;mapg5mdz7AXi08S&}?&6f~{kkKbQ%v&%1_XSVeC zbpba-aE5}}FDeUaCWmLUkbdZ~#d+rJ5c_i*uPa@!cq`tqMZl#m?859-I1f8g`x=J} z{;YAvXA=qJg8nON2C1U5=8453qJYB-e>58lnu*fAO5`0ZeOZ)Aku_GQqr_7FGTr*S z;PdVz#z!z$luD(5d*NM-2$H@$0?s=up#}gz!~Z5%Y$#|bOaD%q3PfLBMFPnR* z$X2v;&4~s{bJ;bV#DW?BZ)!UN=Gy;XuneSW3XX8UUf|DUlVbAzM29#oNU5A1;M6UL zLZ3K@d1jg|cmy#m=+sbW9Mj|$KQ zz0x~E0>O{BE!`ep0CKWSHs3uQCV_aosz|Gz)Fpk}cfKuxf+RJPka{%v+=L`{?o~zF z)tVND1GjB&9p0I?OVXCB%EcsbLT*#J(>ylO))7~Wo3APyCDt&2;(I5^l6`)YG^6O| z;$XH^(C(5d*4tQx>17>U#K+KI2;gH~ZFW+$x`v#~m;{~mE$iAMGI1e49}=}9jeeQ8 zcch3p1S0N!TnvQ|#|ET`ircZS`A0nXE$ZX_i|byoc)vMdsYO|+zy#dspfNv_U3kIv zP4DMvs-bUBj>02mivc*bi~NzOBBYF{u&FE$DgJFq>r+;o%J~Gu=4vSP%Gp@IMzr^8@CMJm7YIya(A=|J(F}1yWSp`xI z_$!LM4{D2H_{k9t4y|Zc#=LW19u&*MHHl+dNhz*p-)N+$LqA9f96rAb53`t`v zCH3o)K3mm&mYg44B1Um`AA&R)?z`Ksf|8(ytG#mD8sIQ21HoIx0kF=1#M2UkZ<}Ar zLxs=g7H6hsNK|-oYxUbu_ZkMr?PbRPw9BngB7|#L;})Af8}ZscvZVK@hu3jy3}}_x z4nK5==Hn1~D8JI6ZTTI~F(^~oril8qy=ypBoT0kBbQB`+WO4u?Umf(Jy?DYdTt~ob z2(|$=cRe+zrlIvj2EtMg7H6zM6#==F)u78y8ce0cW@{3!QKadla3U3ERuUg7pH=$) zs;1kI$e>KZFsLTSE~*v&xr7@8uEfX$(tK8>fq9(k4rMiJ?{;bKKh={j!QN~Iq2XwE;lQvAvZxJT zu3u#y=dH5H+VuozjkuCDpw>)*PNJgNJoak5vhL2BQfpyS2!_cc@dO<3LK~*B^+3qk|X}C6ZDgKpUqt>YL~f_-UolM`d~P9rz*6i zEAXLds&?8B_nemGePqCTJ|e`Xqx(7}c86u^En4x*vB6qkGxww(jX_ysj*6*-bNqq3 z|Ejtb*b|JbT@A0x-9k4VBIA7P=!~>2BQcE#Z0-OIvc<@!9MJAqLto6JA0F+-J;U4sK+rW4xx^CLM3nmFJe=Hc1wX1 zj$?fS95IO~1zXtiB~i7QewsfcVRhTOBR=#$6*a9D*vu=%#Ml?)ADu)oV58vhQ!?KJb2T-om8 znqo|s1_-W>G)mU|G^(9&FKwIp3IZXSg1;O-j}z^RPXorvPZB|^=BLZXRB%tq^z8u* z7*Q?wfavM$QFTmSqS3QxC2zWT`!nrac?4s4-cZVOeduzBI8z0(Hv2i zqGLr^o>>)`H41ly5l-x)1gdEV$!+x<2FfMCl<1}?qsoCxy)SGD4H`K@SXF}&r1veF zzyp<383oRE2E-3t5BQl)m%O_9v%4w?jL2m$H2IzW$q?i0?8#`nnx-rD5HlS`&xZ(M zmHj+)eY69}F`%Vj{#TZY-u2d#m5EI+aeImV&~yvI*h(~q$nIIL=j>lA^{_G_8oEgd zUBy|U&_;VCakTOZaG4RTZX#k_`b@sRpg-0U3{se6B+SzN<-+t30H$LLMFpn)Ui)su zX_8-Qa*e6u=^Z3SA^&&{_Y(Yn$2|d{IX*_;1nB`?8*?_)lGfGBxj#Cu>Jk6!Ut;_l zyG($&j{h6>u4u3p{(SpKZHIhAkpMMP!be$5q=G%T<}vxulnO%3SJeh`96pZ zyaNLOCwvb?|DbI6@F?z+Z`!B@hTMytTyN?Vf{;t-=342^37U9*!X9SgDzEn zAj}488wl@AA>Zlf>fvdbNt@K@NEZI8z$GSl9og%d6Q<1OjpVx8-sXO)21WBBX#~dP zTrJ0B2K01zI&~suf{@@;kKUPR3XA=k@a&d zQmlf^^FMs}CZi+={`A=Z@AFJf)C=UUkQ?rOp9r~VJGAE2gwQBjEPu9D5}P1A=>Zdw zsZ@Tawr*U?E;n9wWUWR7+}m9KuAY!wIHZR`BPrG!jI#qdz+v9bNO(7qd+MCM$?nDV zgHEWauB(!bIh3MCE_wWnIpt&D02||aXPh#~A}Uec8S%ndf-Vua)p*`VV1NidRy#bN zYs-;8{;Mny2Gt3RHp-0Qp?XjeIIeBWI%4T&=ZSB!rEM2-BE%A$4*$Hk=yuobQ5Ts; z5WgJ3`&WB~6XV>Uk3!19%2P}+)!`}T?59BQ8zkbL>sJi$|eXI;rUAn`DwFf^CL}9L-4WWZpYk zyK%BCaVFTjI9Jb}GzO^@LpIo1q@2@Y0x9eM;L9RJ-_(q9Jf7u9l8Xly(;0{+od~lRmmij8M(?It_IZf|D*tKC}eQ3E~ynI#Qf^nYfg^ zqtIm%6g#_<9nS4BOmr0adidtV3UQ7jstXg?7pP3xxWEU=3EbB*!8}P8mbtMp@pNo% zrk+fCRR9ay{Nv@xL3fmx#Y}$&IlaxG-m`CJSw=OOlVhU;Ts~F}(C+=b7lHj0ymsVY zCuG_W4&S)|qe`Jc@w9-Oczs$v|UZ5z45OVF?e$g0^Yd}0n;^DrXBA`oTc^x1IADz)S{D@c+ zl(n+&ntXZk$`GMmOb&W}1cT%E)@gP_%#T*S-_QVb(c&9SttXCssNNYTPNSstMTxzx zGke|)1qY6&@ENd^b0btnVKk=&zbLtWO*fFY)zk=2*WwL*n?M$!z+Kp*99A5@CF9k` z*H9IC{bEB$j|QJ;`cMhoO#!U|SE|s4HmBcjfu+J)Or}VnqxJ=%{c;Puy1xFR5>MYU z@L2tX9{&fv!lDpUt_BR|>n?kZ>utDGO2^ET2kYFduz~(zJh)kx900?{$2?*!(~>Z) zB>^9_*+@ILmFr_^;-^_YTpqI=nfT^8uU>fDoeU*PT;1mPGzHh+phj5Uze5o{Q}2(6 zOS1Q>;z#w^ZkQtBCWN6w?ZD41K1V++`6l8Go<$BSrLt4Y3hoe>w{ZTa%sVM!q1e~G zzRhlUuJkrE$@UAm@F-)X7<5Q;^-_om>qUJwVIjB7ra}Z4rf^$yrPPbFFLj2{t2yO? zw$|q$^}9;}N}B^24jlTt!{;4%2)pn0jLmJjXD~FWXnP>H)}YCGmw>|BN*Rrb@-vJQQc3M$Tu?Y3C-sZx+ZWaaSO;x2joN;HQ?p&b9#Wudff;3-MlHd?Ugopf`sZ zI&CTa0`v#zNH<;Vidq+=zlsEDOW^}_K$WU|TG=ivd|?43uKDVXWM(>7BH8)U1^Lq% znCK}31bKjZZX88nTDb8rEpX^}REZ_|Eu6g&Kr1{kO$E#1gL!3XZGe*C@CzppD&Usc z;#!%aH6axkoxK*E>{_k1w`9>Q9J2o5iCsl|XhOs{|1&dzf&W2V)oXt@ znYK+kRnyzP4B!XxRy^@r0PoZA zPY7UDnm)g)j~3C@qF_&vsg9`$)rOdp4(rCwQ{Q;*5I>K~p&#qB69Gjn>g$r#rw4pF z4x>q@EgvLxdeM-f!v0{F#I|Ca9COQOw$mva+0bkd^?F`3;n#JEFZ4TmaH2j706DtJ z--e~jj2dByLnwX}kBGy0{%6gX7Te}0s2a<6Zik6XnzLO-!LNA+TEjV9`6q5GcnT0o z%t2LZF83;cT%Ruk;L-=-ktA@k54m%7pCz_G(z;8(C8oT==D^))dL4C)QY=oW`^i3= znIxP%47Gg}6B4Ju-1G9=yh%fBPAsFpeP1G;&2nR(^WZRf(P70Ql4K94ISBWH zRj>LI8ok}Z@K}u1jUmIa=sIKo5gMo49R{z%7P`E*$h}vlC zSh28B&vN?-#0|{9^o1gxT`!PDf9Tb~0D%$bwQWe?i8Tx+alC6(5Sd9W$^NKm2(5Js za~SU{Y&8cc)P}@To~=i#-&Gka`0C}E!so-&48|23uM`vS>!nH65FA5Jv7)MW+ySs# zS&}_4LPFrlJbCY5reRCDb>^{cKabS>T{F``D=MiW_GuzN28EvQ7%zFQ9_Kp(E5Rw? z(Lnk;IaB1~8?*c4n~8u~R@+~1I9vV1f1etg6KltWYRfeFDs;GweFPYW3cy4xLJ78J zm|WIo-(lG-$d=El_G0ai{l#Vfd~T0!Y`u93UYKFtG)(SpD}#wpwzY~$ z!o{J8EK_JCb;RcDM`_n6Jelcm`BYPn?dp~sgU8!lHB-rtwCiYd*K&7Tenr~MC1Cmh zyA0xN={eO2PXY@Mv>f5c`>wank*eqMq29oevPa#$@zEF1_i)2eo^?6fVe9`gnOq(N zK8*GfOpEi_B0g$qP-={-e*qP0rcn zUn71Q4EX(pneJ6lD{WH_F)7NsAYd#`Sf5TpyNf@HtmCtpPeGOFYBT_Rr=v(6!T!pz zrn#aWYhC>#w|N!2n@nlUpsc26U{-a;Ytc=V@>M4{udU19w<+<$p`;%kBb#}44n1`= zYfHuX-m92LSKpjb^gP5!1=z|{O~!8o2;JRh&pzoM zr^%H0Xs#2a729hl^lQCv)^gdKN_(}mg=-k#Bl$#{L`We6Xzr%~r$ zL=dL&*k_9@VI{HJT?vo~$|7S8`>_xy$Nz|aBoH|=oF4LnFPXRr z=i&$822LHc@i$z9i!+XyU61ujZs@?Xik9(lQkf2=Xr&y&8yFvWqY)vHOK1wayC~yo zYHt&VyKx!AbCMPZkm-X@nN^Q$V29MVzio5KX8{{bJA}qHVNJ!tqf!{Il#(I z@+b^f1&`xRrQHG#y5+6q6*_QGa+}_1>;!h!?}u)vzS)ZZekSd z??Vqa=s*;DDcGsJ4Y)ZIRYg7d0?x zpshV~bh6_orNVs8Vg+BjNTh;U8r_O9IH~fNZhis*!mLru-hF>@PNnaezmpLe3KD{uC<hoZf zKbZOf7MrBc+gy97=SW0!m99JOr~0?XGBDuY&xj9SzlYAlRx$(dw-N)0RQWamQW?J6 zH}J@ZW+y^Ci0*e;QVpkh`UsXDeBq8;);**sTWW3bBs!24a7vk&f52o64k*rAt%@6z z?tc|Rr}L`Y8h-rAnrO60+4gepEFSwZC7{@aPDxG=5L=)yxRMcL_-FLPCeBEk>1bGY zTOF1+SWaT#_2o0ak%#0u{X)#1~(H*4g+mQuSCsOj);p#nkD8zESvfMriJiF<9 zD|Tbz{b50)&SdFae~M2qT|d7e#msJ00Cg}5AFtA5XepWkC*fRZ*9r* zONT)i0Nm6>^s4Pw2%6t5ktAN$KZpvG{8B4fVV%Trizz`*5?zp@fO|9&?{qN@0{Uewd-*N**;NcH$uK z()l|Pp*+pPUgg`0AmDN^f_PrI*)TbfKUDG(s_>pUVX4t1l3s`>YZ(+ln&^xW4m`aS zU3ueFZ)wbcd#pk1jDtKNw*=TnSu{ici8Z|X zm)pDcTAw!YXyti^PbycgQZL2@+$;5N__k{X>HCcg#EG)YV~2e z8SB>y$6^XX4srK*vvu_IXHz7Bkt=9RvX zVmUm7zVaf*0o8cto7z}&9g&ii&0!kjgutR()3=OKbJiy_4$cq-HgZ<>uv8^3Z(bxl zInr}5iO(HTh&>%6N`S*L-EI-Llf zLFPYP?h#}`9kj2QgQmV5nduE(m0le)fMk82JoOv?4DfONOJ-12{u(NhpQG&hdF`k= zw@y*TUa(%6o9qS_!#T_ihKu=2P_yA!rvX3>5KIBf!in*{Ar!qVgH}(S--kjC;ypw> z^P#a|HsQ3G&e5c202R#j@j>d}X9&sZuqx8khKXf@z2MN`9xF=h3`Xt*F!dgjfHbV+ zFZKJL@nT18-j{UpH^E|A;);nw`WL9m?R})=PucJlVn!bvoz^P^ZPoDgw((jMU#m2A zB}C**2;@TWi)}xB?RI@@P4;yal)TE6=Bm!IH=rC;sO4&l?d2H;=>3xR=Bdy&4bXP} z>jA#ge6|L@ZpLl0IVzY6HbBiB;q#=|LLPDDGx#p#&n_GiNlww~`2bJ@t_A2Ip$@P~ z)CnKTKR)()qp>V}+dNsN(`t6kr|H_El=5#5MoP-7QRwxBiX@(kn$^3`+uu zC(ujaHuMg$2^uxC1U2-2=`YxC`BzqauY4Df%0j84yb&VpAY6^mltok`_S_c;w(MN|ID~KScs|v+c9qUeejA&5Z>AGMd?4ZLq#7+?o^my>e4NH>Wz8XJ-|~%bhg|Us zbfFq^kuiS+33No0rD{T*t@UG_V=zs1kbW2r|sk?B0ef8p=YVOz7PI zr4tKv=X6Ej-oOG!l``K?cqEC7zX(+|6^ZZ1On?fB?FsW@Y{tT-qw`9E7w|LRdczD- z{F!m&Esrtu8~*c~KxQ+wtHUS#TrCzlF{C?(drae}?FTGEGKXxS;?ImLSb6!gObWk? z+1IMsXO!KN3sR<6XflJ;F~cuH&+57k@GK%!v(G$zcYs#p)_3! z3*%k%(8kA(Qe}J(2}jM?*o~Im~m%Sq!in-phioA+^*BAXDm9Nl`^RL8+!%o$l#?SB#gw3fK_U;R#x(?vspW@g znI?UgKq-grhsSQaS>}XP`oRwdw(6M8HL|wdsqRbXZRGc)!y;dJ24=KUly{79!Ly$H zJz%T1!>vEX-M+%_)y(!iqf3`Tdn+af9BP$ymK^_dOPf7_cyqU&f9bDQ8#`;BE2M^& zelZX`&%l#H(iqGJyu}ZG2lk?h$_Q&Dri^dgnr?OUyr7pXGiDGVOGW-#HsTTjSfoy~ zz*k-kV&0gB`}*W8ub6D+3rE+9K|cYVVvGwz1l0FIsq+mlWPS1JNA|JvDG*WJ`aK;) ztAs^SOYjkAzZ{C>r7PLhaE#u6l5j~?{zd9>VNO+j3Im_M`7=M^@MH_?EIaqfh`I1~ z1+b|$upYRn;U7t{@jol<3D!Ryzi2F*X@Vg5XiSJLKfc6*f)tBus?^)p5Q;B2F} zG-=mPQJB8t@3TO^EqGc3-4WO|EQ1gj6h35*KcdW_T!g|aq!@Fo^o6WhwriR@;5Otv z$ESTXOI4cYDZbV%@3`uGQsmEEcgf_otFSRw35I){-GjD$>50?EMdg7vG+4kT-rQC_1$p@bzo3(Z zW1N621lb&o`Re}rV1UTZFiSu{^N2hs#7E3&2;G;rqy$7J`g(@y@c;My5HPp(f8V?~ zb_Vw!q9bYhUmqmhTy2#P9GK{iMCt&bPxR!vQv&H2C?b5md4HM4>e&y`zOF>bD2`E5 z&YEEWFD&+S3sfteDq7<1XZlD$cY*-`lz*Z4nL70!7QM=x1< zMk`z4WA6470>VQW>|nUcLE4`$ybbeSj7osTTg1wJ>WNY_<{|#c=TP9PWhQcVnDp?n zNaE24MP!U=gC)sS+ac0T+X0SAT=kw%;*N$3+L}wCz?%w%9==-`cvg-~X5NHgUhwehn$Wid)thRTQU18@2pr?C0 zqncfk^lo6RB?9wTu0&x5rnG@HEJ~1k1o8#o=7d&QNF%=8gTsbb|@=J+wBMxRq%Vy2zD)!b#dzI|ho8m3fnzlci? z(^w)vtD6pJWU)A2?karOm>2PlD1A?mz?H9s*ZBLDV0m?u=$0%BIfPHestkW=oyOTc znCK>2X$rT)KYx(Lt!=hkr;0 zmVwK`(V7kF(@x;;{acp9@ITutr1V{im$RsuA6?x&O@&7#n36qtnA5_=hGZuI0Nfve z%&!0ECp~9jZqmRFUbFN3Pq@JciBrCo1*MCnnji^4u3{_)-8Bc>-H>;%{L0je zlgI|{<9>Pk9Nt~r+_=*5QT}r}1@e@F9sVf3!=$j~0OhVEJw%KdTUJFhV{i#^`M~b7*5871 z-BNY~C5~Q~xXe7pKG6Kp1se5~+dYK-p9DSWM1idDf6hAbdRer@lApNT)_UQyEXeAb zU?}D&oFO!$hZ(VB5oU7P@uh(VZq=ACC##a=EZ za*6__hK4(I{^J*D_)JpFe!r~AByYUE_U|4NvNB!H=?Z($3F6c!U2fcuN(~AW!EdZ3 zf)C+RO{pc0hK@YFq}BJPG!wk4%l?@zRgG#%rS~L{4EC1kz!0w^0r%`doMAPp&wbme z`Orq2a24-|*&A&#DX;BcKs}(eMVO=?FVqz{38E`Lhb-c0@;oOg8qwGT44h1lcBsJ_ zs;${RW^}>V502`=6hd)igU43J0E6I_ipmHHbPMqT0@z}5D<6mtSn#A z%1$3VM)(TEuSGGbl4h6FKs#ysiZTya1ewxMOAX3oq!L&<8Y!=0(2K2dikjY-=#=De za({{spIWUe@%da_M*GhwRiP8>R%lSrNibUG*Uy7OPLaFGIjR#)`&Kz(n~=HuZIKAx zT8SJ@wy;*HexXR>kvkMY}OGUdgcRb z#=S%Q4sh1KFiyQD*HaizKffyoMwh*!W=iGO>rMD8^ax29_GLooiP$8oDHc9F=4`34jZ%N-vO7V7&ZSoG<-| z1C!~%_P==LFde~g7J$6$SO{QFD`0tdLi^oz%2AG_*`^JCa}Ar^D$p%vpq+p+c^A64 zO~S2^e!_@Rb2Y*fJfVLb-lgQ{%&C~s$x;nCirM_{eKuxG10G|wV!1>i071&1Vc$sL z&S{0ptn18Jphoz2z3mgQpt3Gs>qk#C(YW4hZ zzYI=vq*~D0DX^(G^B$9iD^-B*IbZNL9%gH2@BgsDK4%g9-AIT)H53AvyWR@ zNaYu_%%M)ewf(U{tj92w5IGu@Ut=0DW`g`vDanZ zUdgm}*a>&?>z5&Wqd^Z0B|(-Tl<2*LTAeJg_^vFxGR!^L5aq=4Z)Up4#aLR2()h01 z({N=D2?0^)m8EL*D3jDM|2^Jeoz^A;2RWcN`YMSD6H!#Zk2*uxk9g77&}06jLw8RN zL2mbbE!SjU`53P>tfNqVaIFG<0;cn_i>>76hrnoN-5D7P{13WH+ zg+;}yQ$lo66Sa~wdyub<64apF!+xBi5Q4hDs~K|h#=8OH`IuXf6xih;Dbt5u@KC`# z+I#%mW}It_^0%)BNBV#x6$J<1))2!=_gk_GIlcBMj-(%=f3RbhECh8XI#+;olZJt> zJF3tfQ1<>Wy+9%`P?otbPwos^;G6>6((C#DGJi7(XrMZ*-mZ~qf7DBcPSARvuP>4U7&D7Y4Ny2UVJlhl!=HDE%SO{ z-`(zREY$kUEIS^EHiHOWu#RpB-;hf%LBMZ9a!};f>oFQ4$>c>*(Owzb?j^z2nT!_$ zfLKe`n==4oec`(;wuVX)(AWaoIUmycR4X^3U;1&LRjUK_g${uO zy&b2xwJo3Imz}Ca-%S)!rxwfD=PY?DGv!4+&_HYS6|!&m^)-o>jy!IS1-Zwr2`Qql z(6xBzH=Jz^&*fo?58}Y@J zo>#O8l=$JRB7r0-)ck{wbtdIO4YSZEP#KQBn;r|U9%xUY1bJOD4FZ; zmg&L7)D;SYh7S4&=JTp+Fg_=sORO~}+i;N8S#ONs7(R-1gT)KF!h>#9)E(?$W>8`1 z`{VMJ-JD0lMP2HcKC0q=3=5_&Q-0ynZ<$&cWQtnN3qG`jky5C=gB;VNYo;hAA1wA) zeoP1xt`BJA4|41rt-icf-xmp`QEUVd4i+Tw`|haSZgZOW6e79E*} zk0=VhCvrpPl+c+*;4{hzDWfUTO+Uqb_E?w>p3sIU>k+2~vrdi3Bad=0W}d71$S-PB z-iU{LT>I%8pyB*y#42F^Sw)o?p)Js`GDZ&1{Iszt+(P$u);R10`6C9>QG0RrAJ}`) znvJoRmRnsPwJmq{1yodB9&Yk^6HuU?T{UD?Q8dUeGaA0qf8w~zg+5>4bBl9z%h~gE zn2%+RoCl^MiN6YwzhS^$(^om!G&e3QZcbVlnKW;xR#E1w6#W_#Yx81EnPFs`a#IqqS;K=u6B(%{a{`ZlzM#b!YH)-@C_Tng_3b z^uLJShwx)MD3F(wz;Vhz@C^HWZG!W_jJrXA`V)@Cp;GS41gn-;jY@O~FpXrIMhgG# zNhF!$4|swX(y>x4Qu3Wk6c1_%h8KaSVD@imy-fpTASkVG^Mr1mr`@(VMh}9Lw1{ z<8)La;Ic3RIwRmPN3lk`3i9Z%6f^Mfs>|#*X~v-Up}F!(+6f+az7@^0YK5&a#hKd zEG_QbeSu8)vXWWQQ$5a0i5y`T-LA|)<5gHL?P$&jIn_>y&p!ll!W-v8uQja(+Rkt_ zHkty&QshfHHhM`v=tFn&OC-)k9LYU1kkmlgW~J_m%>nw|C!Q_9WwvkG z@UBZ@|3l&_YvV2N=j$ajl^N}^Ua3>q(eH|1;%?$b$u`s18_*yza@1Az<}B3jlE2|5 zRH-a_{V~B6p<~2NtZ*+hpu19?*45_Re2Nk3*37YYkWs={ws!vt4z2}qH~!-lRQd)3 z1pNr{0y%Q?7;clo53rov4UfTYJXlN*a5|5b&<5u9uA|LpwlF5goL06P8Bm8TV?brQ zH-W0~jqH0rYE~JOSe`)&DIn6V80?yn43#8wya*1rrsm;xtwt6WgC$ATWV=iB`{(@# z;YLaVXbh6p=0N@8!c@ye0i&`=PhtBuuoeXdHzg%RpiP$;WrPtfH$>hV=dXg~%N}uS zZ2>{`l_1HY$cP-u2FDYnXdZw}Zx%k~o5@Z(4j>0%V62ZyhfKQrC3xNs7n_j*BMjUD zq{GV~&b1b{Ha2l<#96J)1rBluFC06o3F1yVS7*zT` zFEGkDM2YwD$Ky1u@?|r-NFgl{TRFF#S7kIu*dJM+a1Gr0RGkDB+#{IqrYhvB(u3o? z>iTh}>Oj5XpOzG@9Vd#V)F$8H27EpY+(#eOYL8`z7idtv0VVUL5d%;_D`z}Eem*mE zjW6W&!`het_!cAq6&32hzq_c&4u7jB?$VOUTe_16=U76LZQrq}Rg8Lb)e1l6CU9B^ z&ToqweFKK_zqmT5EkS@SiI#1v%eHOXwr$(CZQE5{wr$(CIX!o+`!MqnnUQ(Uj)()n zy7=P(XPfsH^GlC~N}Z8jzk_5yIb0yQ1|zj&wV?%An@9R^q1-&YILuwtdb)6i$f5S^!x(tcDLDu_CV+qu@> zmy9k$p-cbo#A?Ye=l5I6d_uoH!9Eqv@+ZdzGjBEDFs=f!+a@Sy$Xg>_uU>qTx*XcS z;28mjZIilZsoaF49BA9gYnd;xg9{}*15YK99fuK<83Fy9-HU!d)a4h3w#Ws*_eVQ! zR4H3n^43R#K+gf(O;B+kuNN8iF6~W)4cs453o(RBf6}TK(dSFfAZmt#2*<$S^SwP$ z_{>h*WbM3?bOv}uYr(h5o&t1R$$3!+>|y9uNV~}-`>@xtu}Y5TYk>*xU?8<;rt~0P z=PXBD(<@!MwO}J0>3-ML87ZL48-WYUQFfcsf8rYb5IpXxqg#Y_ol(ZUw6+xM4wPci zVoqE5@1|^_4g2X$wLpKp)hf7$cX7jkhMG+?c@2tKfTAPU&SiX8lw>6G9QM|R4Z-tU z!|4<{$d*Qwd~^6WMoNTjEzGQ9)q9Ka2O}h0wZG;hgh`~87~5(6o|LP4x3I=y3V)Gw z4VVq=s}eHhI??gEdW7iu?B62|pq{y&3Y0uR7wfOq1!TN_iIxtSiOEYX&t_w-gsNi# zmiSm>4JR*TCr#v{H2IOvP(-&9j~X3}kAAp+0!c54!e12~HzLJfYIQ1j^r0}Kit+uN zU!IkH2y#G#pgGo-vTE1wKznYI*Ml9%BJfQL`7HJu9HfbKbyOS+pV;RXpy*n$m;ETR zzgxW4@`G02k3ixes5Jo54(Sy0)_2E}U0)>;!$^-a;eW4}6SG7c!$Biw{xpHcHFs;6 zz4~0!c3* zKDOmIp-wXe?deRr^5j4TWzGU(LNTQq<*0=qOR~-Pdg_Otk%i9jGyl~|zXlFYS9Eb4 zD9*~43(rhTB`ZonfLE?9IMIpD!$gQvM%HjB;MKNP^c=k1&Qe?JN+|d8u(V!{LgQX_rDDB8H z7P?i%(eHym6WwL@PJUTv1=_#3%GuW3*8oY3#oI!&f7nY6VBY(Gt*53+8eZH7vPk3a z1um3uyKkA2{ka|?_5gZJKp|Jn`Lxa+Y3?+mhdPd^{f)WEnnnpN12Upqbggah;L~p~ zyia|oxs|43d#Z&zSkSV*uHkmmdV|LbH&Wd5ep<;JEz1#4mz;kTmk+V&`V*i(m}MOt zKC?UH`+Q}fkhs@COHtSKrzotHX-DRws*X{Bfe>aGJHIvOJxJ`c;IwHLUqI!Ngcyko zYoE*L-Huh`Jc!^-Z8p=f1=favJ`PLZX@pI;b(}0 zge(|2H0v=*f+?HIs=ZR!?d!2V2XuN?rjk)Oz(4GoCSc5}%ApK|e}yF5ZmO_@y8Psb zPLg#>#>A_1-4y*d#al{zEe+-h9MP`t?dy8ABLlUd&j}>NqtH}kWrg%UqCkh7Hd_QpHQ5u@u0zSz4-=1gU3@jhLGnh`H_Yb|^Z>WQ0tdsu1ZUJldBa zZz#-NuW?~mX*lXV2P~pJ8_-!917>Y!Xly`14-zsWd~4AOFawg+v>{(zdhhB4H$DK7 zqO*A3EW7ESS44_3gII~O14@NdR#eu5^WB6QQeCgN09_@yS1S{gXNzF=(y2gCmA_yHCI3q)bF z(O7-amoeQt9wT4QDsW(hRW2?V{tgB5-AX5?0+^{e;s8(mAs!%pK13oy0)qF`1~2Bj ziTv%9MSi(+iGY#tNTk;pvuXXX9iZf>0(9UNDgn7+*9s0NsTMxk#A63>OTew}KKpRf z?^gctvyn0fOFjh5Jv6?ku2hbi%V?T`bsNsk=t4h`cB8Ojy-||NoMYqf7mBl92LORX zz);&d|3E~xQxoOcA7LM< z5evs!zm)$oA`xISloV6AVqczSxRyQ*gAOf zziRp5O8-|TFqjs$E#Z)ZS$f}1%}D;7tj zZ<$XsQ8nT>r%jkl@H@?uU9QmPg&7hzsX+F=YdH>AFpVlN*XJdnTa&XAdFUJ zeUm|*;2rj;fBN)vwsvRNl z917eMa5$+A)I?uMtywL`sg%)RntyCT(|kOo7w__g*j~?v*Bf*Jv<;lcVuX|B zLU>{u?sAThN3jZz8hQgH_d+) z?R**$XcT#dg?_I8rlqgv7^bKQ66I&?u~XvE<1Tewf+>j_+R&Jr2#wTN+Yp3v;9uG^ zIR(MqKZ~hTjCp`ZdB-bEI$t$c$T+N$zIWm{OHGbDyH%XLu?er(|Iq$XQPfMK!N6`3vr-z8e6Xwp$+P!gI?e zsREJsbjR`>ZL>RVN=&9~4xnI^L9g*Wd&2m4H|Lql-gN_ceAXez9eV;6Cq>Ms0NyV? z0s(v;PWkBoOG|vxh5M;K!~yq#PJk6o2#r7P?uE(z7HXE-dDuu+_}Q*RMF<1MtO`D; zgjP?tKy3^}W%z7W?`fPv#dI1PGD5sWM>)~2-d;my)2okwpXgiLoFV2%BLyx@uJ@Mf zsra87q``$+(TdM^OrQwj>2Q+(xMIyG-hDlyt3w=kPKaVmlc1cB!>ZK3>4^7T9PMEFbY zOhax2DHe|BS*ocEzeNbYrz{r1KVZlX#mDHtFKH~u3CqBITCPGETC*w2g>8RVstZ9^ zw>C%ak_=C5>xZ0OlD7ghYMZqo-lk&Jt<{(nJWKixOe%L++IfB2O*sIedD+sF^A`v5 zDm^CZ9_cT+@1lqe!stHWl|A#&dVx4H1Jetu&KIV6^;NkBLy|6DA9Hq~tXsS)PB+M( zZ|i|TQ!3jDMR`5)kHw|Ov*0@a9GSbE8N6&D(2i|>l;0%&sgS(V^XCz}^wwWdPLg%j zgLT^&i=+%cjKJzzKM%XDId-*)$-mQ-GTQSGjcwLwpGom_I9R_dI6Nw%-v6>e4%@Z^ zG{bnPftLA1IBGgl1W~-eif(1HHdR?SjN&1^v!$3=_lp`~J-bje_W|5Qz7PIhyVCbp zf-2<;QKD`8e%02BB(CI8Jyix3R+=w`?|}OD@E&FOtJ||ZcmnuVBT8_@$RZWd>#|Ew zYG&?f$bM;}9nUCkV{fvE%SHl*N@OEwpDXbN@Jq&Sx12ezTnoUO_?MwN8E#NvR6SC@ptj$K0_m1S_9ut4`PpD&_ZvxkJyVOP zt;!Q7CN(kN<0Pt!Pql3idYyiHoE)eVKIMO?w$rI1;D*Od;-&yt38G*bhl$@;(l8f8 zYReyFe#8?U2 zaZ)&4#{ZEJehFCvX+RJPiIxD=lR7oTDAlEt!R5>6?F6$q&r?CcnzcUchCt$Bv`xpSlwsUt8)R*KalmVwM zREhe@{2!(n0ARRL*ED^C=)JG)Jz+DVtJFk}N^6Zzm-3xz{L^TTs2ObjE!%xC&yDSi zcOuGvRbNhMP{{Ft>!7;v3uI^$_uGW?Q&hykig*6V+%~xA2Sn&Lnq|y|RNq-~+Oxm3 zfO@X@hJo+KGNaWQxKSLJ^_MJ@(TTuK0^~&U&BvZJj=5m^ErXl6(S|wn)apzu@R5fk z`=2368jY{mG_)M9J<`p9)E1+(6K`jV)5A{Xt#jC3|6W;W_*1jLN z#lf>!apBj8!-1SH;0FbbgtWvd(dLorLAI>ahtK0#59u(iPITl@w-xsJ6p#NJdgX|I zZJ7Kx{f1W$wXg#a0z>l6sEn5AG{=lrx0DuA*!@fJL_tQN>3u_9Ck+?Y6_S3ErsB6? z?-ahkK`H33Kad#c0)DYaEdk+VKwNA+2EF@-6^yVspS`A-u@y1w(DQ)jpRXr&ouG6; zs|?KX2Hu^1(&LhOCMpQ2CWKaa)K{IyZHJ5<$x=kYvJIJy30R#H_^D=}#+s2b4z|z- zq={$cN)_=TD{ho6^CmJV*D7C{rvaF@eQ@9lsyZo3WTP$8p{ZedtrAl=PO^M}1&hzo zRuy3KNT!?c0n<1DDm*wU$FwKQ$*%nPi{d-WWS9t6vDXJ-C7U1tYV3&*@l4l!PVsBUCOLhGI9O$mK+c;$Hl}PAob+-{yypcA94bOlfeVXr~Z%k5p!yQ z=LabE%_tHQRPO_SRzy<) z*y&?Q18K+bUAJQoaX*M8`r`Six*M8NvPU`hnpq*=ln^E#q>8f?C*#U%GK}< zqYRnDJp`}wP2+KZEWgCrRjfF)9KwW zw?~WBaMmS(*v+g!kpBc^CJ`-uZ_`s&r9xU-$VGNTGO)lU^-lO24~7uxc^zHr!x4~r zx><=0i`P~_k^jvpK#+=ynfm7P3%BL+AeC=Z&`Zp>fCbd}tW-R>T%_fyx5nWFuSV8r zQ?N6lg^;$_%{qT!0+Te<2f-1jM9$Ibc?XB=Dm%_qar8>BYrjZGF4I6WPs_ckAL|Yq?zq%l_9jGJep)pxlINQ6rqfEYm)Qcq z5d^%5j~+*d!A}VB$IBxF;!3xAJ&pZd5=Hj6Ve zgyl-mA*8CpzJ`}Xwf%mT;pP$2s+vOqf+rQMq&ntP=##Zc!Q&K116>pQem_NM6{OJX zXpebQQ=vMvPMU8ZIy`HR87s2yIwc-q&k!RBpb@mosGHWp_qYr+Sn%f2#F{lCIiSvr ze5|e%{Ep%b5Yu7uV8sUHqb-ulVoZ6NUm6foQ|<*nlzFI|LaZ9sdM)^z5r+9Jou=|9 z!zj7w9SxA+;K`lP>z&OintQBp6NraQZ+MnVh7d0}UKdr1@P-ZE{2-Y?ZR0y2^KOQV zsQ4{#d08kM&^sPb!GF&y%F`=~5ue)mR=WE2b!<+x!9@=AbNzJeG-54i2GYso*wP)JT} zFUNXSdl5C>(P5}lnOhOVnr+VKVvd|t_AIvjXYOL45?dbojtL$ zhYi~+q4aE4E#Abw_0GUlC!e&i=34&!h~eE-wf}-*p?@NyX<1BnqiYEA(cUDI3tvNa z7YTsMWv&D4<%h7dc9$n)t zME0@fc`RVXjUX{`pqq~kxHktE)8s zNsGyh#nQbK&|}e$n4Aps*hvi3&!8u$MgaQxi>&2!l5q@U54}E5PuwG8s0K6=R&e|4 zLYA&45Du>i%YM4V6WQGuV#)#ZB}8Yv5tvm@#R@LDH95<0{@DWWWiLs`sQxo6Bs_Nv zNm&27)wXW#)3~rhJg3Tjr9uh4Ci)Au+`mRUer&`$$qVRmmEj+Y^;hiR`?~T zHmz1sK2a@F#6;JaHS88jJQ-2#3cbgGr=XLaWoP_`cV8;=X`xq-1w1ScqV$J2Ay5Vs znz=w(xe4sO5=6xZrsdV|R{H!r&V5cPD=~f1S9D-&#|7{AROTw(O#9m9)2Y3P`eRw! z5@urs*>3vt+b`clNVEyd!9nk#7wfz&;dR8_i!#e5@Q>3y^Ddah1-<9a0%8%cmh|}^ zf!GzdLG(h}YdZT5{L^STK8}rt)>x9jbIZ5|m0#FMNRZT|)6_iKCwm0n;pH|-i1z4_ zz-Y<*+~Q+@QC)ycm<+Lj3yJa{C#iL+5bR)wN4D;H!>Z>alTefXxum(h_cE*O%8#JP zxZlASKFabM40{ZIc?#IrF76_@6DyyPzlS9w06P#v(KaJ%-lg0jBhJ4YJ|>!K8#jiW(_5c?0Tk;&4_a ze}J&zU~g(fb&DTt%q_ZZ85PQ(q&9I|_&PwJu2<%R!!4+r>qzp#j`Rj^NO+AXAn@Ed zoJ^t%E40F1!;69VGiC%q)GWI(w>2@JFn&`sDT(M&1;miI`)MW5G> z+LY%T%Gd{2Pvnv?Jyu*}R=E}3ym4hlz-U5v=;;R#Zsd3i3K%^{p1umN9`c4;EC8|g zDA~c|Wy6OM8OUKhUQ8ztE;~0B#gxzIb^VkQ4gzEeE8yxNDkGk*FCP77#`GjPK(dJd z_k&NF5|1h)?RsIhs~=+*uNu)B(lmT94S+L_SRfZlMMX8ra|TM$Ocfirw(2dmQJI~ z=+4DH1|3{>>yAzvSJ}z(K=>0@0ydX~nIspIu#RJcHyT;-&P;C={dG_D_9T9whDT3h zw+F=i*`rZHDF}*O8sQr{>(?RXsPHFgs)>T`$~D!>CRRB=`&(tW_;JmmkpZWtB8l1V z<@~l7D(-xDjYiGQ{s~9G8lGhMbt-hiJ$o;>yMn%553g*hUzRJ#B@jSQN+PgF52n}V z+i7+9hLZ>$Lk+J$<2`Q5#5E&Z$UR$rv-g?a*W2}LdZLlZ`05vmu+n6DIz;(chUi(Y zx?cH?XZJ9$P!;3sV@6F8&o!A#oq60e3#Hb$#gk7H5by`zX~AY6?$v9>c=hrliXwEI zWFIUv@U&1GQ@qFyB~j)a%r}Hg?>oKXA};V@f3zMU;#NkO(B_56`f7Wugjz49Ka(WX^Ss=uoer%fCja?8cQ`LI?Qmzbdn6(n?Uw>p}EU zslQ(CaS(015`72~3Ae$HaM3*L*quAH!EVFoE~w>p(RxdhdS}Jmhn> z?<^;_|vf+D{Jra^OX5L&A$yIHI_B`QCG4mnV1 z$U8~Mf4~84ZDX}HNfC1c^uUh=A!KWGt!fFaxZUM2An;aH(od@&q0{ro6AJyQ(WDZ) z?R$^x>jyfadWAfm@xa$<>M^x0uHJEbF8gjA>S!ojlfU3Gd|&B4*Vj4^>Qm4`M{+UH z1Np%@4I*!YGs|sQ_lIR;w;s3jRHu$f+#p0fx$Z?Sx*2snGKMWG#Y8NO_B5aN&`e?; zAkF%1%b|IwOdzzPuAS*z`JIT0O0DJzjBQazb&VbWf|AeQ^H@fj2SNZR|KjqKiagr zSDnIgv;6eMQd4&#!EuHeE54pL?%ara(%dCQH|@9sQ~xkyp@%R0QH*YdH!5^}m^Jg$ zB-tfprA#_Gwjqpc207V1gdJ0_K+SVoz^}ve0l-z$v((Q$(YhS=&fTQOmL{9Y3i|7b zItk&pB}JXp@{1?_LAysj`%%GTMUac_k`;ymi7wM05o2Dh39d5Qb1{C_aj0Wr&N8u@ zt}MaZDt<*b2X-5Z&M*J96hc)C*x83~=|6kjMgWetb9X^Bs|*`|elY0ivRmvO z3y>3d;tw%p)N7uC^hm``xu_g^sEFoAbV$f%T6~FiGOXG(B)YL#Bl@reqYtC9EBRUm zRW`)QwzwGf@CX@}0Q~2Xv6xOV{A-LB4cNPUC>Z{87Wv{P-oh?EGL?I~~XA zv;Db3sL9@wTymp;qJws@hOB z>6MPiz~DW*-CX8Je;l+&p1aN#6EBI><4H@}wXW%vY=4L?c+5wmu#9G!)DoL}O^^zx z_@)^lr*sgllg`c*sO!mZgY9*S^vhB1kSua5+`^Jeo6SDbX{uk@z~&sh`1DKh>3$=7 zZC6XrVf$WT;cgI5;%~FdIDl}_v!2j^psHI6h>ijPSPxkS-LHh8*@mUfza^QCKrZh8 z!T4l#pU(qOe##Xx>g0Hl2CUb^=(-TjR+@EL<^Vl> zGWw>DJ_1G#;%1GX4~|ZtP8oN{Qa|6D2?EkLT&D>dbrv-r3!~Nl>Y6?ki*p|qrD%=` zkNSnFj~&189mH+!TG<|#$9oV2dfy8`z^m=3P$90oWyCk4Gm_9A&hz&sSu>Pa^~Aob=i19GW{0e)e6?M4EYMW^Qj}|9 zL7PO^TXGf~+eSv?*Uyny@daaMRT0J_AHa-e$W_-v>6dq!M}Kb)9KA8RlG3*B2iZo( z$EmCD`N34`hk<(?qUh$ zt74uQZA5tzmak(AugaV{BQiIBl2_S&U`mkhP0!fhC)lZ35_YfrtHP}Ai{axJ-_mZ6 z!)m7B?Ow99DH0F9t4_RH35DCg1BtJULg^_Ic0*c%TYy~q7CAzE=GB(=ti}WRu$xQN z>`HU(h(ol#<4=t!9uC8?qq&VS7j3Bs6vUc1i=XiguB;m7v3!Icvq{;}9SxQ`g-4Ai<5$ZW!W8DrcrW{dqPU$0$Q;mp}}0 zVr}|)QKZB3a(AS)So3De&6?VUI-vcF15TKkOF!TqDe}vq1H<@+nb!uFD*T%2ToAP4 zI|QeYurR=&;eg>dA1S&MKU_(OcLfH3e!m%iElalG1HhIgV|TY%7v)f?cm{+4+ITOvkn zRpaI*9=6z7VsYA*O{mZLplZFza-*VQC*EY!Z#P1P@ z{QP+U*nN9miP=cpqs3c?{x2?oBY@ipJIM3Jh2CGVQaulaw+3R_)~32zxdqaJRvJxc z?)=3J{%_yEWFWY<6I%l;i2$U)f;6Os*-=lGIl=LJ z)XS28+zBvqq5=o>3?bb`IFyGX4k6Cii~e;GQ)`P@9OR+vZ6>;DzA%aJI3=s^W4Y_v zl1=I?PQIrQC-}Zd?nj3xKq4m3S{hW*9btSpcW<&Rm7`GTcYcd~v95y}tiuQ-YoqpP znSM}qRG*k|ZEJO|vtN`(OuQ{hgMziq=hF1!KeIN3`ELW_Ig9YH;FI6l(m~jo zl+?cFOx03iiH=54lweaxtxn=jPTZcN45=3(v3=!v*J|KIq7X5Q^uw`VH?=VUL;qF>UF`H(H+#_HLKAM@^o&e%trBR&L998;h*3l0p{}j7o*g_zUSz{c5jHQCY|w%H3)@BRFyQ zn}@ZfA}2GGh{|DqDmG*QKtLpDNN&BM3_PaiJ2EB_MXl%_$2+Pc9iC%8sl2}}3gn`* z^ll?UOKf9Zo9Yv*lycd}_C%z2p(s&tF(Ja2^+JW5--WxW$oXRza^*rNpBho zAXJ&T3dM6^f6w(^*s*eR`g*r#XPrHz2tXnx?giR1=x9I?T+{aoPvlR@+R&Kw9lk9U zbB<0zQYTN2L~0HS_&cb{I($7K9TMn?wqqO09!(AQ$r!q1fpyI1+`0Ml^gGGy-0&3Kj6#_}FZzsy+{NfWn{w32fcGg`=swmZe9h=FeP35j#i|}w| z{>uhUE*CgCq1o8PV)-6};U(w7*~Y;yr;CCsXZ;qEc`mFErcf^%GnJR*Y>>`8Qj0o8 zY|Zs3D$Ir9uBBG8p-tB2>x{K>dPVQ&v7bp%x#qNS_Ua|k1-H3oQh?D`oP~u$z4z}i zm_6m>Gfu0sO9oL-iRXjb5?@nTlOWO}4V9=6ucc6pgs5j(s(vYkt5RAO{lFTCB4t0o z#cl`a_B;fas758pbhC6Vej8|*)n>nh+Ew82qA%h<8z zl_vcR86S!)61#c+Cmsh!EGKiz-$75{)jr`Y7n%KmR(WFc57?$6a&M2)@T8%J@3TZu zSo%a?Hp>-|^5!wAoW-d`L5DS%2gZ`7+;kn{?nXZ^zR_xVcISA{^g?(BKMH`&+S#kF z+8Lf3`A3Q(S%VfM1>)^0VqBo^6NWUVmSTSIaj#qEy@on>yG&C5Ps+HrE6ZHyy66#B zRkE{m885W{A=bd0UOBnm?$CDclpU0d__INGitlTthc;)48tnL0N~6T7RYRXvS{vZ! zk65DQq=gW0B$aV*#fcUf(z5?fKZ0K#N2Z`Wx~=PetcD}Ao%R(s|0C?<8)^-;h<2%K zq%s#+mF3}OpiY3~>dRKHOh9EO{V|Lm{=A*|Mmg>4?}()x7rS2$AeyAF)k*OSKKvkF51J3dh+{w=5W=WeJe#*_?!~ z)$A9Yw0|20c|6W14MK}^zvsz4*p_@|_uXW|hA>H1o<}5POeXD>=15*=;=jUhw-u#S zD35khX4&Oj_XeKlnP-UPBIuVPRJ|$j+W`s3f(WEdxJwS^+;(pr^TdjN1(7ys@w zuRFTqbex!L5rGTS}QxI^Ula)fa8eLkQZXg)bPkW)l%6(!*4M4I&$>+uc(lX?*4eusE&Rj^@M~?GvjPd1KYDjU82Mo1@oUSf}8!vTnFzCC5O28&nZ*v*i zd+YHZ-)L=J#Y{EY;?q(6!+qOP9245FCp;8N9d(1e&v>E4WGiDHng9*N5we(B<2>75 zeb9><$bGvU=PIk}xq;Y=zF$0U>Dm5?1w@vOBg?xX*oVqTFEVdOIyZ8i+R(gRI43YN zXv3Bkh8hx+#PXB^yCri~_;x8f;g0L)OhQ8q5%P{UPb&{_i!Se|@pa}-k{B_9QrY@% zwystZyCO;XqOX;>b^k^xO7YYoL&rw0ewE$UPNK5YBG>wFUxum(df&8lyOqO=>?Qc+ zJWz!xA7}G^9ETe;aNUfh8x+5!UFXdFi7!EPyf#|Gu3hSy?Z0gP@HsYcS!hm?p^ZoG zdDFl4fudg3az=AbU3p8%7{Z|yX(J*H`iL*I?lLldKD*b&gEd1DzUqs{shrhb9vLk! zl=@BJbYn9q2!0@Oo&&?~MI(oCfXFx}jaoYLMuJgp zW35BE!!jM$!4_%2LLKTk?!5xlAhDzr^704jaUG2j?uZ8Oa-n5_P_(;dSwNZfS$YZm z9r3bv>3pY=B1#TQcfXDYt*306oclFFSSU1A^m|@TM$TPfs2&G}wf1SowkPzzBdsQB zXXkufOv%az6!}0RjjtwsYLYHv9gRP5kf#{iJm0l)kGqMe#^~az=|O_30fcg=k5y3mWNf*s@gGY2`qW2)b@u;m%dY4sQG#ne5tIB3z+QhR0u?EAr=u;qYvNRp zb92R;y&_^%xv~IC9@$+auO;?;ZUdApdh>9OYm}h&Vn-Q}M@R7Kg;k#q4jEE1rM_@C z@(!^o<6!ci6VYp@`r%a_$}+rFeLDT9e+NY^M$-*s*I)JJtO)y<*;|5H< z0%WS?(C*Ad=!0WJ4O843ReFVMZ#xGiz+Gd6flwvd=4Nh(OTXHeeQW9Hn(>z{vw*^+ ze}lJ200hgRyrPuE`zoT-5nZJxD42%H`{EKvr|g3%#QiKZZn!Ty|27|~O8G)m(D{nX zlLG%}sHwsHDBv7Vm2rE4Vzz_S^wK=rq?&Ojs<1Bsg;GCqo44Bdcd)hM0VyFS^TjHz z4}4HaC1bpPTSMBxyA_@ud{gVtJTgh`RXmjwd9?OtKpf>q;TTeiXKL{plz5=SWO;0n)y{As2T!>Xr%MXP zysWfu*>%H!X!~~e)H%oU7w(6gUxF-@Y?RR!lSN$K^Xx3VsAhRc{>M1>cC;D%+bkOd zb2B?+;lMXT7lgPJ;(*a)eDEoa-Mu)YrgQ6xKow&9Fi^|0e)|u!EfOggBZ)K97U;34 zBmt=_r0tj{ey`xkV4Fc=%WrgKcnzDbDHX+@OCWevWvO@336bcAlF#U1xh%HA^Tc14 zXI*JtmMex(I{1GmT_33_x-mugl`k2vm!KsY;*XQFYqbY^?!eUavq_Klw+JmQOc2ed5XS<%KR#IZ6HDk@sLNnLT0|{(wh`7 zN)hHyvw+0#GLIPXgl-Z@lu$50RAdfcF~7)v0V4&!CztTbJh`2cY(n&BDG@!T+Ont8cqvqYJv6L?#Ze@gp zvA!AqB@$OgFsG{Wq7u}yeO(P+VF&Q{Rz&PPR=D2i$8PY3>&rs<@&j96}mCVbA3;|NL zwCUjDV6n|UN@v>(I2Fe}zzW4`G^z^lCEqE$d!Q~zLkGOEZQyQ1s@!-NmObNL|GI~; zsP{WuKikkY0UPC^2+9RnasOx>$L&$JmjhoMN;fk<=rmvF`LPXzV2VwXy1{Ub;ojZa zG&f7O-hUs$=;Ye8SKRoBvj0O-{E~m9Ho7yRdU?F>61H5EgH(Bz2`K3i5sZbwVbQKZW1I+kzU0+iJ@~AAmFJGlRL&n4U(&Y6!?I3tOC}Z+v zpT7xk<>P>^nk7+xZ9Q?=EV=R*GSm9>G=R)eYzLJ)A`tnJPV)2SHBvQd8_bBd5lqaf zS~0%=fG23}1Nm5#Fg%EbCPkM;A(h7QPu8?xY*4&%k(FHthX6MD;bi=ui~X-JB8A){ zc~$s@nNlYq?xD67GT7En5^HjqR~BmPYGbxab(jHNjwj9G{6qf#@RyEpE{l0kd8(&@ zt~z*vdy|RssecpirMZ4~F#!OO7z8qj{~vwH=U||X&<8pj3|2cim@U>A(Cw#6+weQz zJ1P|ymV3IS)9qy;2_?Ij(5{8wEe9wl(Ug8NN103wbugYM(v{%jvr(5nex8Hc)bWS? zzI%u~WqD3yLyu3N+35Yj43Ax$y+v9k$>sW@=M?5@OtaeCYCg?Zy3~N{Oe)b?e{R~) z!$=+Rn~UgLR=}Ep_CAY6+T(ttM{}vXi^xKP!Gb7HMGpLhkX%)$pnD)>rJCquO~uC( zWah+6i3Lik{K|9W@D(7ybUN04?!7=q4NI|%vwTHu;ie$?&9Pib)1XSY$Ln{@CBE1# zE;QGiC?Avoqkgfa*k%}lMMs6hqjcSN>kbBccG81gxg-IaDBP2#i#K7?!Lykg{hXez zTud&4e+azdKt(OWbYf5q^PV-euFxw3I6KHD%dBkn*fAzq92@qA<&B3FO~h&Ow<`&M zPeb&0A&68n(W}y~I?4T!jDPmzqi~SoS@Q7R?H0A<5D~gIeXdwOf0fTH=t?wxsy0Nv z)`WY+<|a#E83w^UQW>Km>R#7NwkeEJ+OyZ}f|qB(jo=lP_mOBDi03sTGz&MMI@$_v zV2qk}>n`Lct^yAL&9DqQiE;(Rt57qoQ){xBw{1zG1p)K{)R8-=Pph?*4xg+k-%Cmv zRDTS$ipC=TJ4FYJ4KmDb_t*>b#rlg!imnhP3Tr{$R*K7>iGhN**yYG^s0mrB~mfaaudB}Lz(DSM7g+87v}e|$s(PY5+v2*c9shlH=MIk1(q zu-8DXZ&ktwi>4l7J9QzZ40bm9IIbl)$UBce>kijxaW&mQ%^p`{b!TJ)OuaXOn1bm; zX(}v1by)nVIwmMRB1H}T&y#DUO^6>^xCbBj{Ms$<(Pspr%t`?tsk!j77GLBF+!%Gf zw>&VXU=%cdRkBk>-ZsugiDSJAHST=-lt^DnQpgQTG0Mmn5Ho_AdQm5=glR$sr!wS4|D;G%e;R4Q>aWk#$TRmI!bg!a@kKUj0?DG0VgytFbG?hID6FSx>urc`9)D25@zCK z1)TQyU=!a6aWE=xdAVU6?&^0l+@<$qx)Kf9<$uOCu3}@wb9jsv?@4 zIn0M~@MeL+HB-h1?r);`?s&~Qmo(UdW;>90H@-pE3;c1<9=|U;(4&~3?Z<|YN+qP}nwr$(CZQC}#v1hXXRHZ7(Szke~?)BoyV;?2LJZRi$d`YuA zPF)^mw|5ETQwGMZEZkv(EuplsTDv(3;s_Shsz)f>;}ui2qicFF{`yuO7ghuUf7ZkJKfR*=DH=TlAipC&oF& zvpT!vuyS+UFT^xl5(apCX3tov7!~0MB)q=q)B9I)CACf0+&?j1r{s7!fL-7_kDO1+ zRWBWQ@s~MG4>Rr|EEK_CP5{Y9h*+=7YQ7mRG}0JzttY(@*Z+{;Y=+Wz3SzL zYr69Ir)az+nzw)&5r0NjkYh*$7|-%vsnWkVfbIny*PA^nfNnnaVGr`-mDTn+Hj|7qA#| za0Q}orXPxljO8dYnEZa9X*L?K)m}>KPKq=pW2#mn|H19pL7g~1WNI}|Khh^Lh7y2; zZ8tm^FRK{AEf^{msyjcae3HkUJUHqH_?e9$063e;Zz_d^9|%lK=So3g+PeS}PpaY) zsCKc_oQ2BxW}69fxQ`h{8_dl3CKqn@0kc;J$wW*#`K8 z1-c~j-25XNR9r>OIwPtu-}D?)5%?Z+jtYYRg+G-UFpac1q-?OG#m2pu9uw=>B%Jew zE}65iZFz#slPUYb0rF*8B52#q`uM5)PUs;K$mM=j^k{-^(1=;Y4Ppg1Fbm48h+K^;#F39n9+Rxiqm=CG4r(?p?>4hg@oc@AqL>d6j?qsB%Q-?vA2UoXCcYMJCKmak+rnUKb zARA*ao(djW>gzVyr!KyGM+UT&FS^r;)R)S$HG zYewsJ{dXKQ$BL=tuUMTbOAJIJxekP?u<>WPf=wnMTII8c@uWpjL|J|#?8AgSUQL^g zN|u-=Qphy6sdwnX8;t~KV0_2dmVFjiDu1-4Uxgs@Y%O=3esqH6928J<3!^AKWs={O zWDXV^;?g8wnVHgq-lBB4p~u~Tpc0HqMesxzVN@dar_IJOt*+1^zH^2hc`m0iwCX_h zCRgrkA3nLP{ytP^<)ddE=P&TQ{)U0-kX3a5p?du9`+eJR!q-edQjmnpfY8TWa5`Ju zmT7;_X`}8ONPvvwKhi)|AzRDs%1oCkdbSiFJ8pizx7)nM?H2O*7cVEk?5`6HXxxQ! zPcX0bt&g)SS?LAhcf?!e)lssc|O$jb`OChT{{1vHV|cXz!gz*LFG4=FgS@};t1Wdp-U z!1+?@2Og)_n%op&s#b#R0pu_bX#ZDnDd|?!gR3+U&QhU9>#Yizt9Bpfcs&c6;unl_ zhaCNeF4#5X#I@UsWoEW;e-bKSHl~F(i8Y zLke?1abIwpVQGWn7&1*&f_?_Zr*FtAn4mQ{#a8ype$vMc z)S3bD&ro^@ci{TsQYm|Tu+P)D@hNe~|e@_Kw_HR0%N~^i}NTZW$B={*>C37EDe3>NgEn$ieg`UW- zB+2?6Tis6o8sa-gNUPvH_X!(2{5a}#9G|!PHGWvb?CevfMNcMerz4u4vggQ;Fgz?t z20Dn_V33_)u%FWQ^M?rI{&|O1cCURH({r^@cd`bhE%2mkPH;bmrzC~9`w&`T8I#CXw&6`LAdQ^(tZMU zlPl+eU!6cYcvPoz*KOp-Yx%K?YdWc=Ue>>tj8y~}g3;@|f3ET95$mhhnYt0Yo31Yd zc;RkS7tZE4%leVOOR)d|ex{?dw2{)QeT#=^q-82#f=bz{~d`j5)zeED}HeEs|H z)O(G$0#C$S1}G;3vL4f>PL8U}&9p!*qX+qz>)Haupi*{f0BkrP%#G4wASM1v$ic|c zt^?+7BM;}lHUVRj&dr;IVvW$WP-BAQym$Ugc#bZ#`!myV#=v8hhtmzce?jHDkO@}! zqpXeff~Cy0^Bz$t&a(j!nM`tu0rG*S9nh9INQ*&YM^_w5Q@F$EZaF5QF!=oFxOjm! z`+dT~Ov-89_VL&YV(kaVr~T+2Q~_bo?&>m)#+nSWstd7~g>#|jQY@RBsPx71HN(aL zOf4aAj)zi@`KhYh-yB~pDsO&C6jn!KOl-$HqIB6cf%kp2#KLHLJ2-RHs&O#DA&2Tf68@rFK$EVEBh`s3lsKeUpoCuPzovuPZ zOmClh?XPy&T5zdib;{LcK)SGje)j)(AvLGqgW*~*X|OT}yLoxPC-njUv%kvz5yr|X zufc>W2c0~9=>>o8d1vOA(fnfcJT_JKL3f-uf*!rMExM1XkZYh+jtm=J3pra@j?0c) zhTClHTaO|0f4-V#ZX(e1>V(hTba8qM7pJ|Z;j_@fRBarBYa(z@R&1fdMId)+z53M| z;0!F`s6D~Ve%8g6?-x4I$t{WbkQGk2gCFk(C30Ag?{m*@9=*t-eWNPR8N1!fewLcC zPA}mbmQv2q6fgc;{<4i^_SIn6!6}Z>USg1g@DM-l%#9ZOBxQP-#cw5m=8Q&IfI*2AI}Jk%PaD6qfy zpwqC+gP(sWN2#_{<5xor^zK(@pRD!oE;-)}kZfa0YSP)1Wb4zdmf6Tf*~n}6j!1yj zR~H@jg>WmMVq}{Uku!?l16WAxp$F_g0e~2W{C(Jr&RSK}=$Dna;jG0dL78SmEM=Z5 z_g-Z*K_ZKULpip6SJ|3h@QG29-SU|GGX5c6a?Cbxbv~C$N`~a1 zBqRYbS2&)UW=Hx3?tib4fB`W2;R!Sez5xJ4{%f{?5ERT4`hQJ(%P3tc7|uJFAYOtq zak>Bi3-M*}dGko@&Ub&KzW@Xqtj*TyZ&Z~%q7yDDL;|lEK`X8NfdD8HUl0aev8|Uw zDbyeenSco-6P|&5O5_?i=gzrVxzmfik&ji>9&nNIM;q}4oit){#s)MgY}krTULJ95 zxO`e)RN2S3ui<4eY$6!7CFjY`QwvGVgRSwPhiQdd5&;otc0&Y>$=h!d-aiwNLvc|` zPWmV-u#&K+*(Dn1H5l;SRySf&vXnRPaYp2bzV-li48htJR~8p>7jOmn^h6hCD!pGM zqS#yBD=Y;h8$KU5j|&#E*rphLAJ*+Gp(~vWx5y-GEk7}FE2>OgnJB?voJu)U$!PYi za{6431UV@}xf2d#uOtZ0s|#L+0{9X;j2wmxm;+6Y1H?9`pQMH3!bnw^YeNOg)6dre z($%*sj?>^;-uoOhYJ?D|Ig@EAonW_xU^qrNsjm^(t`x?ZBP@3+90uamT5jNHnaJz$ zlq}AqGRDUrmh4F-ns7?ojy!|^j^F_~)!k!1qr|WcnUR^_2Sa9s%(;Z2Y*X?htR%O_ zWjzu!sa5lmRG3m zEkI4r!h89~nTYY=KIU0yxex!!vPWOXGh}(cWF&LWumL6T&Ylf&E#L$I*>p>tW5QrN zk{)gEu0~_4@F%X~W%H-ms#L3$2aCFKANt;3etS3e!+Cs06sxR;TBCyn;(XGzQMQ~#uYQX{STg5 zAsPV8eK)2apH4k2GB*r+e79yJqSJStPA#3649(HyMrMSLT84CzR8A5L%d{ z*#w>{AsaX^ekWu5i<(FI#Uoxv>IhD>{sU(VGNH7xrsMRV ziv4$ER_}7Ug_QqBd-+qlfwG!xZM*hXc;j@18YZxkg!z1fUpwmfIT>fJ@3%wg_j8H_9#vY;s6e^mg^Zbe3Bbds%iJuzp z-b8IcB75j#3KNSj6Z=4vcBcScwhkCrUSI0)XI;go6*0(FCNl=+oI3Ye<-~Ua<>O9a ztihUvZ&m-BEvVq#%)?*B-k!yW3@j}d{CZNOYA^d?n}aT|A%6AEfITKDiU%mZB!Dby z0lqIqLIZH>DGe!?dNz2EVe6rUIigvXimTT1Lh7><$FBC1XZ|(b{Z|VO`I5KSX)nxp*7E0V#1*U7;33* zgF-6Js0X7L{GLI>(GhAf=p80{+N91~f`F0gG1uJw{Yh-^V))Tvkvsn(7i1++0Nw9m zh$5f4E{Az@bW?+r)bpK`9T&OvHw~Ujzq2GO57AEBcv6GM8?Rjre%9;(Q$FFRgak9qg0ZB^YKK zL}5TqwXB)6nheKye2W(wh4^=`NV)2>>+&I#f>;-c;kH>G(shRIqHb8)OBI)LOl1RN ztrWy0Je{963JhD+Z?W)Lyy56!2ImRBa=|e4HP^KGs`3{QoOmMm-s3Mf`243cfVk!7 z2ox}l<>{YS(&j?}Y(}yWairslq8xrT%+#LCn=eoN0lBJvJh|mOxgF3Fn}DBeTghqt zpqwR%w!d|{W7|j88}ixDEw8Q>z~I)_JE=prV?_r9gT4gRblvctHyX@s>|SK@u|z-r zVbjB8)vhnfpJH{tR|<;UBaa|@&!zORM&;iEPAHZmWYZxqV6iI$A=l#+>Rs`B^bll# zS1IBQ5bVlPJRxxKKQD!JQjH!nxVHfpKmrTN*CufDPNVx~+L&+p(M709?bHUc}aXb6#AI8YtGQl2@16jZndrbf`In&c1vPP{*Pla|G zNY@`M$HP{c2hx3MWjT?=d_S>oOF-<6ew?SeN3R7ppDs-@#ALhJIu?bZ%f*fXn;GRi zf2h|`Bw-h5vJFsP5zZG6Z~C&c`2<~N>QFl`(0>~rq|s4Z?*TqyH?Mh+9rnAMM4y8T zQ)3l{$Q7+%0tVQww z1JIIoz3#oEZ$o)y92-90dsjN9+=|rgD0-$d--z^uKm%c^!Jvl+B0{{ct_A0bQiHrc zXTRa@n=Ient(chNY9>-S+CM$Gv<9=6$3cdO_!7DY?VWLWJwQ?HzL`$G)r*88>3uwX9GVJiv^j{v_{l^o& z^ZORzFIcRn&NCqHA9&YQkolD4ePMlvCeOfc10U8MsPva=r2eT-WCrkg(J^a2`w^zhW;lat{R~wsqcm;q zS^`-AOCm-k3*VJ<8bk0kL)INjFW+`pM|Hdh$3a@1%G?zYl(hKi&s7w~Evgze8q?1u zK^U)(k23(^g@)`$lsUF1BT2H-u5Z6faLvhb2DaQuFDNVL1b||S;$r)bN$Wv-fu*Pi z<3B6C1wD=rTp0qVF9{dkS@KxFuK>lB)eR?yu@U1?B6?p|Ao!kiQ(8?#oYe9NgFPx51wZEdbULU$dr2vx#wAc& z^{Xk~Js8OVg7tR`l#EHlfb_ErI5e5Db^OQ1}Cd6LhlO-7ENbP|` z>fOxV+c=&6TV<9n^&|9PRXF2nfJwaJ5v0```J?vR5%L4)jt|U4ONO^X1WpKQ6IUy? zY2Emepeqnh&zr0OYgKP~zpD4tuBzE+j`A4XZOKb3eq2JG_IP?ah<|zqSVCngmqYrj z2LEUy2?ZVrBQievVRry0*HIJ~3vBva6B5dMQNHOmO${y)h$|!D|CDgWl);3Se|r^= zaRp$BZZYB&jLWZ@U+LBc8!*CVN!bJt0_SR-8|TgLwosQ9oqAOe3rS=(atOP zA}teav2XPA^zS9t3oLNyh&m7Le{Pgj4&3YSa%D3FsFO^M%7jtML^{}k0I2RDqN>b$ zPWGSsvLUBem1bWDeH$FV#|3MwZ%F3HV3Pl2)J8fU2!z-Soks&1;^%T0y(dACzyLnJ zky_TJr(H$OpjS}y4j%EC!QO(j<>SL{H#-s6`m5sd?{1!U-d<`dV7G}VqD4Sj7dt&G z$nRwYGRM5;CRg%bEy`aQQ8|*%hYj1;`Y|r&*HmsDZT2>c+eM?( zs_)>Hfwb2<&j*7y$V=S#ZMmLReW)~G@`|9(L95Z~ZDG_w>*?-eowpL7tf7Q?G?v7CN# z3gSBs<-MfDsq%APYPnDJa?)q8pA(-1{l)(2mW+kWDeq~y)m~q)DeDlQ2;=FfHP$#b zW@kML0BU^l%Zc-mST&It>+b{L$FZS=@;<8`^j=OhDQg@8JqF>CyG^E}6H+uc#;3HB z_+KCP&4n?bg>wR?#oKTpgX|t_(!^cBD^v1*!!UZGEd`?SsDB z`{;alM^)<$79O;ZouxDLtDO*F9z^@Ff0X1)`!T*=b;R63{d5+8dSu!3w9%lxab!Ry{(a`scvc zBgRVRAWIDYNATUs#^OCJ3e5_yQpO^;i77!R^^AZCbBrD@KASsVC8_(%{7*7yhC;Qb zhZioiVm4(jRrBjt&)D7)6Os&ExhL%d48p4S5H_6It$ye5NTpdWFueus?lhDm(D`Sw z?g9_&*%O3NzA^P8ROWB9*b>#;ElQCqqBa@q+M|3pMh>CyMHsuWw@-{ZhXy3+-p0CZ z%e<^qFA<~HvT|o``K#1z|I9~9Fs@00;_X^N;@~GfB&hQ3pn5kwYWjq_rKBgf8}-o zwwXNt_GsIa0p&dI8iUHL*K16yv*_6+qNO<7C~o#apq-q8-aG&MVUi}2@r&#tn98Yu z4TpOMF<^^*GR9zn&XAbEgFiHVt3a>`;>vMG`v2US8PHZ-t`5aX>BFGr|FDJIzsqVo z*LqZ>Y+W^0vB$0z^H;da+-?lnPA_A!VRB8+h$w6@x$7Eqt=OLnCqD3l4@w`qd>R^f zFDkSf6j*rOeaeu!LLj-nUsnT@$65s(R$=pF;V91oh{3w`o!^{^Y8dvok_+A&!pj?c zmkgzo=6=k>9)DyzN|?+PI(&Gff@HIWbz);j%!Hnd%T^a|!eE>C)O#U zTf{hUw!k6lI%YJF@%WOrju?$=EL_V+gp$QPN>lTR7;U57=NF2jRELV_+*3$A7-4kn zb(etL2C@K?4s+fCoR#;|?2=H2zz&hPu7v6v-UzeP2)7@0<1ve#q$*|P86(V4^qTJi zUek5uXKU`}Q`}EdH~;IzCdL^7(mTsBG&m^4Tz*qv5gupO9rFLP$<(Lr%gnxzF&=Xj zr{dG9PW93)B@Wclqow~h8B&wZlKh&(vBEr{MXkkyI?>>mZ{FTu%8{pRm@V8^Ef|qy z|Lqyo;HkB4zS;Su-CQ1r95apFtv1Vv^+jk`k$>yWVGikc)s*@91eE5Q)fGtQ`cgQ9 zNS9{WE96K2Bo5_3(8pN6_6vadZB`P}<&d6X;o^?-C<)PDnqX>15^$XFNvtfeCFet6 z{!}`P0uo|yLFjdMYyo?>{>T#iVj(h@6eUdcppoi|GaU<~cM3++CaVs2N_4Y_qY1&C z=OO{OHD9_Y&<*tNu|xdLM+a(3YWbP1D(SPA%X+FhEW-arRmUUu8YPc{Tj}Y2^3wJI z86{zfA{?`NIdD(azAaa0T73~|&gO$`!nwjqHL)XYr2o-bu!_wxNVMlKpmX%a6p>%L z?;2DK6h_$T*Fi^(eG?f(_bgP25FCm${?&g$bF!s0zu$E~#Rz@HUG_OtIj-DhbBFxv z=A)hn^h?3crtgJumN-<5>CQX$2IAK+S3>S#W}Bl8P!@_dPLuQIHGobgv)aL9zE#;l zaV$%RM|{bqrTO7&rSX{YhNVo>3(^ABO7|%fPY5oVid+WTG6#C`2mv|aqp?ZOji&LSF5|?XJsL#_kCPqjzJb9{ok^ye4pY!dg(HAWtwSwQSK* zf~?dPo%{USD+TDlC~CglVbxaq{)_QR2lQ9V5J@KTcF)LXH|D~0T!)opQ+35jFys*p z144U753r`0^yno(eAE%--$h_G;s@OYSii|=jjdehw)>T4c~yWKx~R^Hb)3f{Fj)|{ zE=@%hEMT+)$On(jAL*}N_a<&vrTcc z_GV15%45MhO(*mb;zQ%#J16<1e-m984Q2bEYu6$rSF@r!u>9c_gOpD@)K zZg}xZ<6lecq}p``k{nhjNYpX>2>`au|IAeQrWO9iA}Xirpx=Zp{)S89Cp?B>pZwcP z#zg=COlZL@i~rA!DOgq?Ct!e*ElIPesS#X7iDXQN!jGsD=Pv1w)OCrhRlXvSOXEO zlk7-jwjXu%Wzk`1EL`+C=@z0IF2WjQZH3BG&wKXDzMNQ~!X0ZVJHS#X6v*p;JF~{- zWC=ZYo@y)@v-*8YACKx=OmUTX0t_DsV8C@VT!*!DBU#3MlC0Yy5eyR5k2J1l^2S5E zcL2Sy4G`98p1`lYO_#KPxzZG!B626)euLf5u=44Xu7b%KWagt@wnfkPjWB*^6k$AS zUj8z}80DpB9?>~WYHRbHJPb+PQe-hT`C1H-4xQJAx4n$2MtrSMmI;L{z-a}fjc&6Z z@f6=UN<8p^xtK;rWDYM^@>Yx%CvgskeQ;$ma|AAku&H_8%x5eNM}<{t#H`L2c^2ua z-pwEEe&`O94kV061rKmAidg?LZhw*OEpGP}bR*T#B{-GYo7po|Hv!5mS9llL$z=-n zJj~idvrrspmrCs;aj#vRytbWXVMI$Jsz#_nem;J@W z)|y1P*8tw=ST+c(lzcPnL%Nj1P{w5dAT`p3oP&7C-*@5Q8vncLdkpfk6%jC&pulv- zjew`p(f)`nP_xzKb@LlftDBhMpx(J#a>YVl$Y2Pk&C6rO3i78SXqFx`j;yUgbhm1z z#!+Ujz2oGi(R^`eIvdyXD;j5YfTD3bY^V_wU?GO}i8BQDrlQ&vn`umAUw%y3e3b7| zZ#onZF?-3iJ+c`9gugl^0bQB|4%^49whqItQitNo`AIsJ$MurIQ6~v`+R2&ii)XQg zWo3g_^zn<0mvD1!0tGSu_wS{i2y5Ncn107w-6#eKgk&qqvumMc@!uUR$i)qUXG(?o zI)U47_SW^ZtpJpqfou*IXJA>bQ#Qc4l?n41E=)!prGM;Jx#6QXYEAFPs)DCdjwjuX zzn?jlXJO0+r_T&un+&IwE^Roko!dviEoBd1k0g}|2w;EY^`=YJ>`FWP%3kv1Xb&f8 z{sd%RC2Es=MFziwLl@*edk{%j`h6r(PuoLhvvmY#3As34XN}jpl}}UaX4n1KtoB98 zWl(}qVIBg?ym0h$I=m^+n67K)eTYXn^B>Y`ovw$Ub|+d(-$rxZKD*X9nk#|` z-^1YK4F3E-8o!RAEPTDNA@D@c>)m6)`>+s#guvkZGO3k>;RdyvB^CXs9%g-=>SXWF zcF?W*Qrl-Gsh+s^y2E*UzO|gLjN+2?|8UC+t&%R>_)FCw8}(y8EN$CSq~Vp7L^#8A z!b&i@p~rpOmJ0h75Ec3Qn9P+YdQ`2ODAH(r4fc^@IAM;qbc?FD_*_4QL|lK zzCdDrDxPy(m%6t#Eky&OY(a`1Q9DwCO{%JVJ!Hvv`ZJX57Hk-=ySuPb* zv9-X4&@(G9kB|Swt|E9Pt%(=s-`_^$FRn&_5%^v3W+&8+j8&lQFc7fyf{aOJO_!=} zOM6r+9uP8V#QwZxeX2sKz2=qttz9pxzjuE{z;;_s=cK<+d0g(ntbTIL9SbQrx^rE*bjy&R04NtMr$`T?&w)cEF60_1B#ln6%8@dn24{}_TD-PIu? z*}}efxJ8dpD`M7xDqa98j9WOe&law@;bLRl{}A*tfc{_;D#;A~`EjLX+fJs@qcjEE zOygGjC`GpEe;wXlQKhk^AKVirEQH0`wW;7@T!VVP&~bAZpT(nr-w-@5NjptRvwUgk zTu1As`yyKxwdOgR&kplrEmH~Rv^4X5HpV@O`3uz|EEo_^74}Zz0rJ%{W4Q`I?5QYWS2zt+llmh=zzUbxwf`r>(#g{lBL z^2ckhCAk0Vad?;^%}0=66`df^;7P0_N}B?!f3RM>YnHS1x~-eh`J|VFf+k2M6U{YX zWvvCu$FRe&Oroji&q}lW?Z4DXwQzGti(K%Fn1|$xo`oT$-#?I}Fw08o;f!uqdF><* zHnW)X976h6iD-5AdBOmHUj&ebA30{*0>?xdHyf4Git28DO8g;B$)X;0q}aQ9r6+*Y zFiEMy>>;R<_g8zi6qFoi{kyMWs>6gQ-4Qdq8^?Lpo<2{Zq6C4&wyI$%uPih`uw0}| zMQ>STUnA;VyRvZNdfb!BvseoIQUo#raKy2raT9N|dQ($fkG{Xx1}*|enT^sLIYn@I zHt0)u>PO%yCp3?=V~=p7JchSADyQT#xKW1WF3xT7>5-~{`rBe&3=0Yi40eaB0Mo3z zcJ=MfTiG6(<|R?yE5&YvHM6p228gl$h`qXlY6T&mt#$ttT!TO3v}*#(Z>~?#-LRmf zb}HPdS7yglN;9yqIQeCH7r?(Qf8{BR|d!N52#AcSz#(Wm@n1}wuxs0s0$cb6;N(#BW{%cj z92A(tq{9B-ipE+5Yy+QqH&y>h`iAGI<(Z`?YMeKqQVtQuH7u}H?3OdFbkxQNSVo{F zvFVgl_y5PG{gRa}$>z@VBR(L#`*w1yr9c)`vHuyDfs;38> z#!<8f--E&`k*j*s+g5(NX+~6bET03OPwsj;457(}Kl-AxsbpzDA|q32!{>w=cyRUi zO%|`(aKlGaG=v&bn7%nRwwXn`wLD7Fnrr`WpBp-V4aGjWwA2{PkL%}JD`T?!R4H-U zhjt&tLlNqw-~%I45?6{DZi6N$7;W;!pFY5@aUZHU{3ph@H5XV7*mb0YQY^-~d_5H; z%;jp`JvOy!>Ak5&R3CAeylr7P>}Agi6SyjtVBXGFk4WinX8$3?POqJn_MPlgg${Xr z<&-0nI%TsLyg$3sLo;xKjhyz9W#85(aw;Dw(HA}aR-W~(kmVOWt$mHELe6HA)Clj^ z`SeO*m7aCu58#gxp(2&35hqk*8N`DgRwvheKCz{yd4_|&xEDo5W@}mIq6-S{FgocrA=Lb{Upj~>`Dzr#T zO2wZwbv`s-c2*-PgTToN#>Z*(nOf$&8>oDUOtH2`)abLF$Gf$6k#ZG)3nmraCkX72 zq5xFfr@u}CEm!!2ewtZ-A1JNo&ZwHjar4qlGa$_(%Tb;20R>?61;OB!BKDFDzO6~znKUQ$srrFi;*{zATLF&BHIq}NY}E}_bSRBnMJ=s8@DxU;Ph@{dxC#8 zs}BQVogTWv*CWdR%O)V@-`dEx_^$QhdcRfmyaWB+ycJ6OBYDB0 zE29}XE?WoBT2#-jp4muTH9D#g<7scy$8Y-BD$G~Soz!MZ-QGmVBf6|IUm-v7BR3BT zv;s+rMUrZ6y6HClX}@I$!q_gmFYh?~z@(GFIUDi?7glJ^1)7tb&`}$Ge3sDdwr^gd=? zf*^CYlzsrDxFqf3zyTG}!nO@p-q4cQKzBqnRKC*3n`Jg?hv*P*b`HaDuK=d+S@E*! zEquz`$_u0fs**~TGj)6-O|saHzVAVi1PsUhyt7^JRBem-?XDMHeBt942I(1daL5J_ z9~OtI?JnHDUyi|IQnta)ljHWO1EPU97eZQzOZB7_(aY)S&W=O9MUIhP_%?ot?XOzz z7nwhPT3^^)SDFMrQE!95Hx|zQ@-3G9W9*s1C$r)N!Ja-Czt3}>v8}c{WaOtzOKv-2 zevktrk8Zf_4Cv}^?-1^&|E3^q5{UW(`&`1aK`vwP08UGFFo}>8`#}&8R88Smg>{-# z67~AcYrTxNT}lkLpmiOdOMJ-37jSlg>r@{5zNi4_!Ji;uE!6v~&i+<6$SA?}+@8yM zrgAF|Alqx?YZ6#X8j!)bGa|1S{E=VtQWeDJ@ql|WG0LuxF1W1GX0`hLSLpHzX5Q6} zwUyRZJ!#P_x33f+ho>;O&%qfdXTUF~lu4t1VCLmvI>`3#A2f$JObC07^dauj$UWbV zbU+s#N3y!9H$p)_R!JwHdfzKu{WEBAkfq-Ig|p*YQ2Ae>D$35r&!^nRq{?Q_`t|}) zs*@Zz4Yp2|p%MnoH`W6}hDw)wB-OY0m4KD(*n3Q_q#x9xOUo%X5!|aGpB_9?`-bV) z8aa`E9AGx*Jz!BFndr)yL!6lu3oD~5m(D&WhhcP&rXDl@h4Y?ypep$8=X|Sl&7CLF zdfa+p--C?Kuq9&1o1fJVbI}s8vJ@O|a8|+G1h(#f>`+?&xoA@RWL|xdGsGm&(dQTb ziA52e^_Hi({C50lYFo0f?hDm{+3CUoF z;Xen~l+U);*0zDM8Xeu$_sZYGq`pns{jrNK)%RF!;&oXX16-s>5Y!|nJXc3iY7;|# z#+7KBIuRz?#e8=wcN7Gj{a6r(AJ?2JumJ{BY#5g6N#L@PTEBh1DEY# zf^`(GeitXzfXhyqNiULBeebk7-d@EPs>~@usaFa4G;>7q8?~`Otq*nfs-{&HF@FWb zkn>##+UOms?w<;Ig@lMZfHAYlVIk;ChPzxYs{A40oq}=b^Oh*if{2)rQ;mT_UH{21 z=hbRa_fshp$$#hXA^%K4WW7FkL-O7*nK%0;T9l#psv+8USj#C$f_GHxp97#=Q`VCQ z&;4YYs-1Bfl`lRdlZjkLQ`qJzsmDA%_KzJ}IZ|;=W}Un-ZY++`Q!fK|GSV&t0|GHF zm>;RiX&%CmToAs3j3BrZ+-R!NtCJ`qrt{r>ThRmg`)-0W<{F2q@SvQSMAphC7CbNF zp4B*2`jaI*`<-PCQB`#uEYR^cv&m0M)Ss%Gy0T87Kj14`yZIfEgQW^OP(r;ANg&FA z6w!K)YE2Q?6{2-r(ck(u9{_KXY12^Y82=XNCRJjK*QY^m^!ZC9RK^$JRJxqu%Y6Q> zats3LK|B70Q%BmnJe{bkv0Z$D>IhuE24DjN5#q&f<#NY{m&8xm(K#8FmSz|?r_1k0 zO)j%CQ*mU1xEc`5OCi?FV8mumddE}3Z)R-VS5{%zZ(0no^K-*lYB3}=5>tPf?V462 zgJd%l)dxDmTM@CC3T)bN200@FE8Y{YwFl*s!z2G;00;u_YxK$uW@*bMYqKM90V6cv4d+s>j~BRY*o(s#cuGZ-5*2+ru02k!K%x6 z_sL7(R(Hzv)EBZFYdx8hSVFt+N9SfZ4hPMBrcHt(v@#~;{vh%n9F`P9C(eAC7^!zo zpP*9~^G7ofoY70+GF3NN;@wOS+3UJr|6Sp@C3D$foy<7ZM6}ZT|0p0COY@@c7Xp1Z zX5}%Fh(9USCdXfkdI;;dB=8QB^4^0vt<)BvBP)^;X;_wyWOkhnh;!K2&rXqG{%#S& zo9pJgDu4T<(<1PYAq5Omx+cP~=%8=)oBDN8F_*QdX{o6nL=l5ash`nf~tq z4RC$z{$};%{_8CG6_fLaZNQdk7zMwiUHpU8d8P0XR!Eg`hSst$_%V4R<+XRK`O{j@ zYtUW1DS)&}6JXzKBZ2`g_qXB3^lfE7q<(8S6d7>3_>7t&CS&y#m4}3NSj=!%Zy8XF zYQ>3ywYP&U5VMZMq9VYyJ&6R;5^?yzIqbJ?U6(<%q9Pudi`c-oLE0THX(>yjEU_~k<`3zB|>FCqhUQqr%-uRZYqPW&?LRR5EHphv2J`o?}^CC)m zlVgr@Z&s8Y9qpp=1lP)9dz{(uvP7P(&Q=3R`v;)84rI!YTg!&yn&@DCLaZBKQ2CI71*%hZ#!o3m0r)h z1XB9XMEu#vHISon94D|(uIyOr#dPao%K>suS!467guPinT#*XP1nA8>fUTZ7Fc<~x zVSW4)`+Kw48~gz;GY(JM=J`2%xiHRZi+HlY=EoMF#^>A4BUF|M6G)AqC~t^G3xz*| z*~LGZaI%vLABA-7$26JOpnFB=LNR``-;oN~*4kz-Q|S^-UgOe9+#>}024efv>thQ! zqlpFk0uv|*<$2}T6m1HU0qoo!X9YVwv)h65Q%pN~>U3CM>UAFOU*VMhhV?W{`GZ!5 znnE(ZGU|DYx7TK3T3OMyzObI-8L}YT;Qdy{jLYZO?#!B445(>%hN-LCa^TbEO-T(1 zXSH~}MEvfg;V+)3k_+0^e~&FcXRY{^cN{>>KzEdZ$TZiPMV>jrBs&#GNX>6ZhxPe5 zn2j`U8|?g7Xx0q`B04xwdExbgeb>%%hH*`(v9q1JhFVuHVG=jm%!eiLU(bQq*J9_n zM#nF#g*Y8Q774+MWFjnihZr;cKCqq9gY2AH^8R?|4iA&|f^QUWQWk+m8l#Q@$d=s- zZh81mXO%`&=x(x#ys)dd~!m z%VSAk|K@r)@4TY3q)W%FOI=&x4DA9bj3Er}emWd+is7LBk3M5X&fTH1u$vVKf1tjA zYY3giK#!uUk||Av>#k)W+!^0nz;xM?A3?zQVglX@wJOG<^|eVuFHE89Iaep&;7{B& z!jR?ZNwgIbUre&_S7vVUSfE@bqn8{M_PufTme6xcE5F=xJQA%bS#xdCi3Ys!JF3>1 zYP#ld#ct7pt2iXpOhXne?XkFp;!`5rLG;gkBlUbSw5{t`3d=B@2->$*LH4RHUbUF; zKxc2YTIj&hp%U=jkQDW;xZmNX>f?-V5m^2Qwl?DE&x^FYR=&X>&()7-qAt1M(HLG! zack~w7C$Hj2;KZM)w*60(GgTKfY5=)B<&ESr|dOG7F5DZn$#qjJ;^0VHht9@qDtrU zAdvtvWva$l2?78JPXGW&62ZK%|0iegAEM2Wi0IVNu$lS&uh{eeK(nw4Sff@e@OJTR|6xPVD$ds!9tKl6wPgD{S=D2w+&DW&=> zs$(#y%7*xOK=H>x(^KT^-E0IMds$zrDX_~IJK5RaWC-6$TjK}h4BY+;5I#O9Qr44K zcWoasvQL(xpJp?f_=#++2r&=SGZv029g;NcV5Vm9LO_s>eRJnLhAC)S%<4{8=|{oq zLnZ%?U1irWduLY_S`X-w0Ag%U`wQpd5n85Nx|a!mnZPHdk8jFSU$I+kdV3ez4}U%E zep=MY!sewwxvRLWWgMMk;W3lXd0Dt$)(*!`akQD_;t@r=t^dzOLXWz8`pjQ$9a+*l zdiW$rCtgko%UtH-XT%yOnHJ$fp_2WopT1!YA+lsM)r#HLbMh}8{@fdF==t3b@gvmW zr{DSLDGEAkb%dxE!rr0T28hVHKWBPL2F?3+a~5oqaLELLT2zS_Jk=Ag*Uq}p#Pntr z_qV)moe4B`BMsx8_xNmdQ{jv`7#xKjA=DGD% ztBWP}oEpZOHjGw3EhIuLs?duQ`L??vBkBq@H&6nU>#83*4@GduNP|K7Y*CsR;=Ly~ zzzyQuA3>y1oRj04p=}k^&wj6k*HgZ15+sS8xh5CWnML)^K;1tIkRMd>UG$!*vX-dO zh>iWipwgs%gA#-~f3Jt_h(^2}6ovIG4~^ztM|h^aA#z=lz7eC&E2= zcP6T!X=?VPP$;IICu@4YXu>Z}PW_EgyS>5IgkgC&KtP1Cm(ODPG(>qjJ>k7|-_6sn6VdC6>Yj`Y+H! z54-2QZ@cgJ!nXT-i8~v%HZO*CcNzEkF`#V z6a7xKicNbSuDyHHoFFRoaiLMd=mx8Aus3Xfy}Y0$;;K6&;FpOPDq0~jwq5E}ksF{M z_d`P=8TB`XU{qasqeun!-W^QS3EP0Ppdr}hH9jKK7d!55bDEndL|4)6>T?0vppIo_ za8(G{Ha%{!7kYkrQm;Jh$U|KI_JQ5_3^g&~S69PV$HYsP2rc}t@`K#$A z;0I(X%;A?lAs32^+5=j`C*KJ|e8X!JWQhSRyQt(E=bAonZ=xcf#0m*YE3%6T3hsKlrJlu!C+tF4BQL(z@r=kqxU5|;q+~1T-;tLc2iO{Xa8OF z<<{7ri625c7$)H0Hc1d2WN!#~!V1NA||%v<{Egxzrf%r-5=`gB|-Su~iqtw8kj z(aH|0FZI)RN4#60jUlCs?Ly{=C=H-69Rw>>=aia`%u8$DuM)T(Fm`3G5g9z58s^QU zEl?fCe<27q52Ap1JT~@SYn+LGhqDnM`Ol?Qt>Z?AD$O^Rp61Xh|BUHFK-m0kFUASlC zji`Z)$kk$SL~&>VJw{k~%+tW+{qMIen^=D_hpNgy=G;K6(Xn3Er2m;Lo~uw_r_6hLebPULB@wClsF@_q zr#9p=l0jFd7@$Pvs8Pm;d#40^reB2@@@dbEvGpnkBSB;7_1CoxlSyU{n8i#3a1*$G zy6!k%QXq^Ryd?_!XcnkAgo#m9(9-e;skolSQ=p@tzef{ZQmnKE35eSOxY|u<5mt8m zDAj?xuJpz&7YDhL4IlYirGNkc0{{ekai2GDnfJRsIfR(-6cqix=fgR^UbPEfG; z&`aLT8$s?G_$%rp0}}uM2g?DTrD+hK002*q9cEKjWvkS-V9yzHRWn|337KchwkQN!DCWg*#FhzO*B)RpuI zdSE2Sm4={{Xweb*e^v0xR5war;fVlzVE?pAM>FquI5scpIo+Nc@xryc6!){%-I5gh z40v2wV(?o_fpa(h?HKoz9zPHq!z^rwTy6uHp^)ZrxHdN>m@2NrTuYr7TWln1lraT` zGXxJrUu?xz#ue&;lZ`S`u__#~0&sE0he*8@ZiErfFO?L5oEyRtqjXOEBy-0(7fRx! zsnK`{c@gT`Got9)HrzATJR=y87_W@CL&2loZpVZ;g(|flFJW^01*HC7 z7%hG}L#=+(dH53*BzW{nZrLD!kox)t$fr&uN-xdF`v!iSn*y0WAk zysA(=LU&}9V_dbD5NMDTH>260&4gyUS{K@vheXDz2hJnMhJoF^1CO4P9rPqfJ?_Wy zWQm>Y0##zN6k`*>&RNMbmm!{0hGMrpez!eV7cCBbmTBUdRdo^@gEddu^`Pnv?Bezo z4FOUp;q^pBron3-^_*GOiyT2QVE&y(It-i01{EQbhx67XKePG8qa2F)_rrf9=`PZI z)&3-KgJaBl!GF?PubX2_d3nc#BdTbWinxo}NQZWxVhz0zXB>4UWMHykX~^m;zi3wc zr)z{Ma}p?fNiwo4|5*(X8^pe|&nl*@zsQ07W|8vk1WH&8j$4ehip~>Hz?8MMARI`nYYNpR zmGtZDwt%<)=KH-aI~|c?%g<3sW>V>nVOE~zjI5z9>%YJRih|c(36I7xh8-_T>Gz)_ z5G~8w>+B9biVCB*}`*-@eeQrovT?qV?`h(ksO}Zt;K6qyp4XM+k#JG{lDAoTynPT4Uv39sN z6I{?3d%ZySN>PlQomO>eDecBZes5l_;@%02w%O4Xk_OW5JjEz2Sq(BBTgE!inIO=G zuTv7}Rkorli6B@CIKnLe;t6)g&O}y(`{I!c;<{`Hm210C>>twkN{c1Rx;oFiuP21` zm6>RChmOTr;OYYFoLp#7w?lc3?kITHIf-o_9-!<8m@qWPW*_f^Z#|>@KGIwC(xF=S+yQ+pmA;lv zY|qa~`(ZzeWS|4F0J&?1MX0Y8O9*_pU|OuOc$V6&=vO2i^m4!MdE-@6%aswcr|9;Nr>2~E`i;& z7qIGeY%>{M5<%uJqX<8WORDArc&Z7CNrpu=$Gm$>Hk0r%E!I^#9ZZV^{8S@FU48sV z#rp1x(ex$R7DUh(>xK$m?{NpQNE=H!fg_bxIp71`4bI)E@C|)C)XZMR@xBwfedWy! z4W^pvzucgpC@K?W+ZoFCAzb~h7OGa~bobyVZ>D{Il#zI7E(nPCSB;E7)M4fUNebYyn0(fOaLqisKzhH2C%o8>QLR-8{c&7Y zOX*s#-Z@k?s$`Nk&DKBvP(9Tn)$a7N$rLhW$3>g=e2X)2+4o+k=?%Ua0cZp-Jm3tp zq=*)PcjqH4i;#Jq%E7^>mPZX7OoA$f53H9Jyd~i?U|DdY2HZJ^jD2>=QC%AxLrf}( zL8vEUx4w;;*ML<$QpbEe-k9SA`eR&R^z7g9FV=23o^q{e4kU1AVwd&7NLNh`%k2^k zW(v_>@{JJE(0gEW1qFqYOC3!ByF7B-h(CL~%(vQtlcq&Wdw});Tjfx-}PbXJ`D?jU+t5-G@^m&Y!?&6g(brnB* zilXfRTf?}zhp7?i?Zh~=9#=r3ne1Lh7&Xf@j%?f;fvhHf#g8Ckg3aAIURy~s` zO?pypFYeH6=V$Q@cz)!6>S@~t{=o1_A_F*|%w~39S#e<8eC`Q?f_^13YUQq+pXsG6 z!BD*1000932p#@5HJBIPP&1~9-lRvM+8b^gY0R>ueTOP$#Q*>YSOK1=ZbE+m08gMf zMa$xZvtx{7LY2w7XwP4p;K4f_pct6oHt$!}+X%xLA?T93Efa&_OorwXZ4QbU-tB=Xn0Ps~yjl1M;n$4~LCzKB=D| z?M1HLC%?{i@KkaQ{ucYmfO9|0x5UrQ<2>$((X;Gow><{s#OM^%x(Co zr#5#uP0)2#i$*kQ2@Xv<_l>I4PgFs@=dkjlAVdy)LAi=~_?SwMpaww{vYJ5bOg?**`mbv{N0Pp0~ zrUPhit@gw#zNZ^cc%YuYIU{`$(i2+ou_?m_j7@S9t&{&Fe%rZ+TLhh5Gk|>iFT!8v zb_`4C|E6Ri+ja*_hqu=Jy7{vy ze`)l!+?kS0Hsc;p?W_>0AeDKHRwpEbbYq($m(jN)o7)4ZHQva3p)v2L8DGuQv-Pus zCBwYfrOh1yubssAq%|Nb-pB|ewpxwYRdF7XB4rh|09F}d3L2CY&o%9aiP`l>g%qb^ zHPGU`yAo=mS@kvdxpGXQzkg*Y)M0 z6oJPp3@yY2%&$V(V8w0O(4FR6i0UH!*QBB%O&CW_N&Iby3#BmKqmqx7A(272n+50B4cYXU&Q-Qj(U0~PsXdi#p9i306a~rXHf#nSM1R&+rk)1zr9b# z{ddoGksG*jOV&7Di7K|`dZnd>Ysa`vh&=~vsTuZ3)k`TEJc}VD57@gY9U1+STVirB zkP>yZvGenDlfY)5b5{v-E0!D3Jil1oX(E)3Y;aGBLFi{!BO6|~`Zr(6Q#7v5Z$`|n z`@75fV`073!ymw+xr%mFa3@=loeYLv=G_1uluj6WQe5~rMj(C8Ds{1UHCTmdtRBa> zyMlzO3q$+V3Mo?08DHuv@|-CQ9Q|K|D$ri!uPTGao@W&iLDYSq@K^z3{v-5WC~_}f z`O?QYLm+FNex1x%C&yz#(d{@BhD1N~U50WxKXHN#rRcV%Xnr)eKiP{PJO@5%_j{O6N*+&Waa zmK<~{nM3GM$H=q7&-$_EoAc2Ugn8u)L<42O)q}_)aWez7*9Qmyzcfiifmxh-g={?9 zD}{s|<;Mx%6>VTA=$E=G2fuX;Z5MfGd{D)8s=|bQ8@SVcSth-aI3P&`(=|+&xj^y8 z0fQ~1iS6TtDdKoJY&vP?K8s(18=Ue%#LcGrDFZ+R%0eW%$B(rp7JNPLq%2^uq7IE$ z0Z0$i863-zV!&k&49B=ow6`{x60P3goN`0R45;bMT21g-G-q*wH_LBY+0)jC_-La= z<|4|My%o+sKp3!^K!Wq6000930GcqtQj`GaLTs!S_&HJ3#Ds%-6{tR`_$w@LH~;__ z@j;rbH3%)KGMEH6|Ng2~000g-jY0qg1iK`}4`NaXxE_L1;je-+eH+-|{&$Jw1=qQb zg_Lg@ZU|6U-F)+eNmN%heRL5|*=HB16Pw$x7`TYZ6H$?t!{{YaoR;Olm@VTx3m1RH ztx%`^EsLj|_z9ZW+a^Fs%B558WXcRVrF`|X_ewpyG8=(#BIuf1|Fv*Q1txsI&Q`hM zg`kkPg&a=9|KLWzA+V-$`c9=9m_xp-2Q|KYFEn$jjeoH0de@<5<7;@NP^HYPgtHG!;b0KSG z0xeb?7?^RJTBl75dVf^xE7+1KwrTt0aPPB&nGHE^gbtr`dJEH)VB*LPFLtq3+GMVt zJd?1_>Pi3KmRipNBc>xKSmgh%CHU6Uyn)e1X$&FGQEKIA>?`uFUIL`Hk;#jxutB07 z1))Tfe)--HK-y-Y>H7_>uilqo@%R;ma57%Imj5|8LQZfd8VvIgF+Eu*U+i*q#=aP!BXg59S=GEx(Co-wPPK$4c z;M{O1Z$7Cvov}?pOUgsF-$Lg>5d1b~tI=B;K&`KdknhzZj2C4R0f1i7g7ES?u~pFP zSRv)k4*HD8r$F+gjIV*Z3Hi95J|-VMIKUxYaR-`<<;)3I?IDMGABz1{&P!1#sOUj$8Tj z$sXQ=1jmga>sA|cQT{Ba0v;}{z_@bEeB8E)K%auOtDB3l5jZ5N0az(4n3wF}b&OZZr2pxC7TlhGID>s+Bj6LoE@zSWFw|Bc z5%Yr`IL-d;FZv;qFM``3-gr(aLH1q*b}f<0LDlJnYZV!~4{k&%Pio7UV-gWOR^QqY zA>=MO@GY2v4M6kb`9WF7Lk8R=4m=RJyTSF5jEdz&5t`&v1G_`a7FugW5;MESzRwP) zX~uTzz+~3Q>wZQ63~gu71lmD7NvN8S%HLHR*3y~FzA;PB+dJxz)|ULhpQw_lsfuk| zKtB-B$r9Zl>c)9JWHbS!urYC)$BLQ;`Kz;TkE^)efXeu28R?KpF1a#};uE3eBH?2- zyyN5(Gxm>BCVB1R1ANU=ZF^t>>=GHuZXf(ITHN{q9k9jYefwX?m;*r7f4AJ1y;}E8 zx#IFUE+R)1O9{N~&0{i!DlB1ZL}<0yC>;kY;qmVtmh-5iR26SGB~ROALWtwKmmuwN ziWN#3XbL4_u<77tu(dyF>fWgOdK)%aJ06QL3;fh8rOHwP*dlCaWR-yJ6ZNPpSzng( zsYVMW;sB$UCIMx?EIF~h9t1bMuCYf*w`agL;mTs@$`ibI+c3|Ny~95B3ZFwrmvbWO zIgwwt5-Ai9#vSTA{dWgWltBzQ-#4JTgO=5_QMRN37%RVvYoDobwz4pakTTQ9Wis>t z2H`QDm5W0w|C+P?^1&1nPEzVPDEYs$dc0$6gNuR}ga95C4X20t{}npr7-A^N`pq1# z+>eumVjI_Xr>-DGy~mOl2svpZIDmn@B`X^7p+RD6iKyg`3jeijg@DmXz<2RtGjy** z67c3+=G)N?0S0Yn7$PPpWsPpR**zdT;HqI*kz#E`9nIX2`^v`(i-Re-S!0D%n9RB% zg9&9Arli}R<5^R_g)HrbN@kODv>CCw*Wt)Ywi-0D>Yj9ql~7$pY*(bbhaC=l4c^P+ zmAeyS+Jedmy_z>C!wDy1n?c7#1hz|04%{lB%d;5bAb1#(ATAEVf*4RRRM1!3EAcd_ zcEoC4hWg3+jnoFKaS-M8hJP7&@qpuNBk$y9Xl-H8XkIUV7nVTQ7KoMg1>71)^)0^x8cgxC73J|+NkeOg z(zN!6gDA9>hErPfs!7qwC2fAkBRIwBESP%x!1wNbMI zs@=Kd3tMoP*Xb2*3G^rFO8@yxgj3`jgQSd1lzFQcYX0_o3k}GGFq)fLQXEoLNGVBP z3zUN2B7e(}Z%MtHG@9l^&yt?!9MDNZK4t1L5L;q>$E-M8a)Gt0GVxq|fft+;5wCU_ z2POW%BQgfdHxe|2Qg(*Un9DX?<-WsI^%=kWIq8xrt-<3g)=#k9@cn z1zop+;pF_k2d&*6lGnx<$=OX>d#R!zk_=#%&|Ql5I_f#?3s0kM+h5TX{aOB|iPz}y z^qqrw8P{p19dIs=-soQY8%F$Nwx0f|%tDOMR*gvE))7Ag>lQg;t6@MpJMR>zRFzz+ zX=%I`v_sw37!$DrKazJ<>`|Sg{_m^Okdtw_8I9ii9i_CKpX(3=yZrFx_qd~WLjNGj z_yRBI2FkA#1!C%XQ1o%)WRYYq8ChZ7o z3MBRTK&pvKWX93FH|jKMB2Yvuk8`0nhF-N=0t*vgl^%jS9SRSLbB%K1r`aS(TWz4m zzkI3l+Q>+=s%50va?sZpCMs#Fq2n4$b!M>ne)%LFwuWnFP$EkvYuM2Y(A7s+@NOU# zKx?UbwcrU?#pnwbVJkzHuM=W&uQ}?&6QRpeMNdZdBiGFtV@a;w&$a4&B3!%>z)P;u zHZq_qf1)3fWlu`{P%&aNQCTzN=wumk3mDB{b$&8J>+e8pxO`1Cn6XDI??itKTu=NB zXqR@4(EX3r8RQEM$gVII!uhCI-6`e%HUPEZlC*kfILlVIe=+-ve5YbmfsfBe2s|I% z%q&5xCiK}z*AHX%*M2@$JkHyRn*?$i1#gFtS=sA?snfi6`bxtA+m>n6;*X32QJ1MXH zD{lxIwreIO$rM$S^io6c-Fv9;EnzPCGTPbHd8*LIAOH0_y5>EG?2n11Dj^02wv?ky zPw)^44Mmph4?uUC@@bC{-5IeJY0CcQ{J7hXB59ewkXIB zBJ&Wi$2bJ5c-@SL;dQmV(<64)Yi7pCS^p}*KIqRVY7T` zc87G66;zfdd5Du6uN@Ep>r0onWjX^yJD?-a>@ki8FW_Vyt(YmGR>!BR`|C-Q&>8~- zZ_~C9dsY77%QTJ*WoL}^SFn!N2ER`{GkxUC#iu!q%r{D&hhoyR7a2 zT*~8E0h4l^Qy+fMj}YETeksa61YbJ8)8Gr7*pfUyOO;P_C(}!GJk1e>Popi%u(Ba# zfE5lL4!UZ6J(a9@08$9ISl>@%OLR`bz;jI>BdA5c?``k9Vd&lLJX|1jyr7BCZ(pWe z)jRSKqJ3X};hIpW@?4#&>(Rv5HvTL{?`l^*3e9LJ^qSBbV6-+$@!P?;eEg>@2nks3 z1nFQeRG1z?urro$$NjP|mdgUooW_m_9~$BWgy04#lQHMDApHRvva31R5dA$sF9s+M z6y7bNy5HJ<{$8rC3A+(+#g_;RM|QhNncrUTILVP(U=Kt#DPWSP1#%jvP<_{LKla z-6))liUL|k^ZlwRPE|p~8HN7_NXy*;aBOg<62L-4Ooy+OUP<$IKJp7z;gfgGPh_v{ z=sz#P%NsY^{KfLc#fq*1XS?U+|JgL#|1S>$s?_DNnl(Bi<3~Q`C&mccQVO@QWz9sY zV7ST5fWlEa&H9U2(LML}%mmxN6zmVo9wCZbrmo_062w++5ayHtZ7kR*3B5vNdXEvG zLL?Z1^~U1R$|LT+DAA)3;|*iS?bdxb9mi~kjc^;NAo3L3lK##74Ada4EmplRT?4&+ z3o~%)go+|j+EI7LT>IfW?DVdyOy>c+(YLV*7W2#4jPJxlk?rA{yZrTd3$@|XmRH98 z)HHMpX-#MAl~ZMv)DCa4+1ORU~!E3z$0V)Q-uhvZFW5PAP@+h&*x^v z&Dtfv>K7Ye6=;rAxyU|Y4LkBsnSPQEN7-2`qP3E>b+ItRjo|JjlPNaIsxn*Mp~p&Q7aT6Ytz_(^=g$ImGlc58;9{N*U1xnGhCa(ISj7GP z1XhnoT<+#8fxhF#IWpQ+0KWp$xJ9Cn`|$C>O*!Dh4nc6lG`Yd>*EV$Wk)#E-J7c7U zwULq5@y0=Lt4>e?v@NP#%g3$1-F{O&3E0BZ2%!(e&W12mwwXMB5}|nN*CYp;)=`YS{`LP> z1M3YW?j~sK;J>J21UqcL%2^N8b>DJdpMwQ4(saMn_j`1?qYmK?P{vrAwZ5V$8=ljD zyZv!+RkV0yNbe)NE#$sU52t+tT(SMg^`&+TA*XS~HOVZaM7Oz`g$LGju~d1qZ$|C0 zz^`Z}=<2Adr(EH}8#3e5u)`1LZc%U>!fJEJ6tx6O^oYqmT<`@lrpZXhbhQAcL?id!Q&KUi)*TiE` zOaf`O3=w4fcKG{gh9pOSsut@gc+@?qcZCgMLh6CWVwguT@H%PMjI7%Thj9*Ouh5Ek zgP_~Qqo2k_K;ktBC0)k!hTW-y66Q6HXiWKahsa)Au8?%R?dZ}(oOMIGZw?h&*2 z-AISR9I); z%2n(VFIvAQMk~H;SVB4dKYU(k8CTO~hI6|Zm=cGoruR1iRTI0^Gv=b9F`aTj5=_2f z&K@(FY~2t(pbiIumyZjpD1I#-BI~4A+yS}5qe^1-EPk8_K_`)7Z&k`=QgR1%CK#x_ z24Ie`KXj3%yUKd zF0dQd(r+sUg8!=(zMg{FLlys1muPSq2!K$Kw+(PZd}lJIyQfT>lAp`=V?fV`$m`-6 z=Z<9}j2r)dL{geL*C({pPCf>nnU&zY)^_a~-7BMQAFoDW{E~kT;0^JL>on#`fVQp{ zZGQS8-%=leV#1|W?AI(Hl(siER20Pft)a5-{oYOx>Cf)Kk>!>0JcgwBibWy=^lxq{ zhLWOLttG5}7^swfkkJz&mKOU{fhotqnU%pTxjj|Sd;$G&7(M8%pmxjbtbL&EVL;&g zdC)*^{Z$ytzbkmsQCaZxXfRX$3}*9gUH<(Gt5E^o4dUNt(NhztnqH>4*&U#wn8%TY zCeH=Ls;pygMaQ+Tt7!ZQYh zfI1Q_pKZX#5XLkaEkl9ODL}-NS*1tKx5lgd^1ajd!Z~R0a11&QDt$km2RI>+?z10u zzM5V^jafF%%Zv>uJ-v*woN~WcR8%US!u^pm$?kY<$kp4GtG9&aX1pmHO{~lmquLQ6 ze8vLiZL3$vHlZiECqLF><)Quu{lGHbxv_DR(DJF2a(%>8RkYBwe}ar52nChok;+>E@@< zSk^V?e4Vp@ANe8MCrB$~Obfl5~^T6>IG&?PL$f%QKJ%>g^8>v)Ein(WDW!3zF|%BI{f4D(m?8Zdc{7~DNv z4~B8?pji zp&o@XulSVz!fv~=2&35;%zr(CMIc=VvERKw`Nd0)!pF+*izsI%7UE6$5VA3gS(!Rx zP2S?NQEP&NR#6)B@)NMEARA0iWbTCNo*Rf9UeoGAw6?Uc$2q?wWu1YxUHY5?(cMpMDxF8A|NRGZxS}oM9I->zn~Ya^6P19!5x-W|y}UHWZHKMTjO%*AIT`REJJm5e}H{o%h%%+7HAYO5L|2f>^f;tcwLu^|{iZeekLjF=zk)3PC}h z%4C#8Tr2+o06&UWSOZQ)S8)GC)oXZ5sBhZUy^!BO78Fjxi&%UtR5YS?WFfl`m?01*aDCd`0BJ&>Q38%JNv7%1Pe93u{g8(0R}S6i@GNXHa`dR69%Q zEJa&trXX!){rpolGQBBEfwSnI+54X0ryyLWq(EJtU-Vadpn(4?pGmx+0i$TwEj8_l zP*q?DUqwO2D)^J#>WAa_1zG;LMOZLTt)a+9NbQvIys;y-1J!W-G<|zh>qq99wOw;z zb&YNjLZ`ktF0`NV8rxD--kai0e~HUgeTUxq0Rij)wC1%QFyg3BR7r>u6NE`t+rx&d z%E^EKPmQ4sSWf%)7Ny96sIs(9<%~!9cj8g6d{hlT&I+ zrYZ|rIq!2MJ#NQiV}KC-UB&aN+$|_+Jj#AI-?*_M*(Q<~&j;4Cy1c9}q!s zuocN#xAM&Fr@3-;Qf+pvitW0Pp;Xq#~#UfATZpwQ+4<4NbvhE98mSQ)Ol1j*U-l7`>Fh zH^^C^a*xp_$ZR>U6l=`lb%u@hy+c?i=_)X%HS=Gf_$EMhpAR2U*E+LxyEGO#e6Yl)S*k3o;OEBPz5o7hykooQ5GayIR@kp8h5Gho`cMoH-rv=J{U})p7B{ znn2t(%h;Ec=&jJ2|KPV=6TLAb`F;qnZsnpI5GWNpYwt2pbx!$r5&rP);oh2Dw1zSp zI>MCt^HO6t5cNK{XNnXRX*VP?HZnb2Yf+nj>Awc6@SA6Tm#JXhZ%j6}T{tm~D?C@E zchEVfg${@hk)hJk2s`d{2=Wzx8eY6(D7c2G_os+U^SW;>T~7t#3y6O>+cO}!SVCM^ ztM*oBwd!Lm+MK*nc2x1J{PLI-J@et+S1{6n7sZd#SJ;tLL~yZUo31S9-U*C8`7ZB zB*fLSZG?y5(G^oiOk?W-nm1R3SQhBPTSsD%|rv!630%J zosYO4;;xN=Y2if3#NHmt;|_E$AU7qThLIrnWvIuC>Hw zdi-nW&phI`OaNnuuN(DcRn`UnC}ghyq9h1ysQQX*@`|-u@QMV@l`jn!bL~&tzARM{ zw)WxTfAUxnMgt5%^U*d#JzmNz|D*&B0hx?}RM8&cA|fJ`uAa5y&~$`? z_`YC4*cWzn@{9~8bPj!ASK$&LHgDIk|Ay?52Mz{SCu?AKDY58P%h4c1qQoB=8_%ELF6e8e4=t;HUnOARxTz+~ zZn5o*lq2izo7wHRh38|T?je<2cEEmYqk=lnlYq}4Ad zl7!KD+-)yu23L4kf(n3MDy?mSl)x1YnEO8uty2ON^l)5(i(WYh`d;&pAzXt^s@oK&o!jkXFwSCWuXIw1}L3;^W_U+Y?c0g|Cn&bKMH za^<$!0g|xmOwP#`xmp_`nt>Bxf00!sGfs&9(h?vXu4ATXr43l^uaJJX!5Ec~bo6Z0 z+ALihk7$Odm2*AIPys$H^>Msxbu}bdv+O$OFN>uj000V#B1~E$tK&}>36NJK`Gx84 zUc~Xsq(pBhWm`RhKTg(!LBrM}b>TYz00%n(p6O{2p8x<)j~!s`+(zk`gUINclEX8U zwRzVu(9tyi&y7Bb02g_p>X2QOC#5MwjVkp`PPfc|L#;2sKoN9Scye0Uu#X9Z`k)y5 zT?Bv`YJtYx_zeq-%p>*G3eqEJAJMU1YKG2~b0?$JY`I_}bFoHq%K|bX_>F6A@pob% z-xx~T9x39#W!fqYV^gX;EbLk|$K}hH)U#jgBNLd$WDs84=&mBYW)@dJ+HLj?%Rv#V z4&UVfywG{fn@zBz`HmjN75(&+ZEv`9LsDhYYICCNd)Ioci9C1NPRNsVmeS~f6+IEJ z=J@%|#-w95+G`KJ=<4eMge&jXZlZ~83t0i2r-F?wMm5NFhKZOr7C*RvE|MUKe?(Kne@S#R$`h_B4_J> zkrOoUJ2j(9i!amjb4-@i1(Mf>$j>v_gy40IDJTo8X#KSQj5n5VaJbPIJe6YCp z+z0nbH;Ke% zeHFMiy2Nq>rU=2u>F1#01w4bHvFOJ^<;eMYZ^o%IfCmz~mW#V{Hj@v_D$E}np$h{& z1KhK>5*o&^>W*r!BKf4+a~YiESjaPlZ*zL;II_HJkHu7cj&Cn-M(a0i74es=>{!_Z zYT{sibC?0oqmqkx|NQDTGS*O!uly+Ia4`q*Juwa7Q%Bi|-6AFK(Dp+rr;;g|8sFXz z#ua>Q2I2l&k-QluxL&D(Wr2FGwH>smYcq&}D(z4u$;jg36s#DF`2AJY=)ysN(RD@u zE$(4kSJu41@TzUyf|L4>y1GvstnjGVoHYF+&#=v@sNCO-j6ZV|AQ2sqVio)a=8Wbzi2>{q z$WmV8`qm-A>xas>_KY&XY<&u;{s=ChI`{xDVva)FKmw}^xl=;LKXI|~+^%r25j^^x zn6rV-X;J8rp{n3>Bi-f#o6}s+7`J~+N90(jW@EQoVq_T8#4chpGS9!NO ztNIYnnZAz!1@hbW{bX~F94sPm2Ztfc0Bumb>b-w)K3eoCVdpdw^aDoxh=*R$5kYK~ zaiGh`oCIHQlp%PU6=j4a7vqeRhBp$M7e>PTT~4P;zXauU2B(v9?=#eT3XSn-slf1@wc6 zf)z2)4UlXx!m6$>!nC}}bKsR!VhuqbkXqiRg*9sS`R9q#>-D+zc0!2+BV=J{&wj+h|9W-cuQOeN z**`+GYJQK_4s3SnCOln?5Tq5uxMJk1KaFA%OXKLGR$0+)T!?*Z)Pg}l!lCZ?tiC{P znyrB+ljSnD-9HOBk^JFSkeKjoIS0Y4IT~|tzp$iDB~^!l8@(MHt|ll&I%zSHc9uD} z>o#AI?)qVAc_PopabU-+FswZm+jmoDQ4jSY@HE&Rv}YQITZt>RS)_ZHa6q24G4wEb z(J=vKInzy;o)t@4ecsKL9=F5p%OC%`#v9zJW<&9A-|(6rO?O1%bG0*0h`1!dw6iud zFY)c@pn(&jLR~hN3~l-zC90H`Rx&el+M2yeT(e`Capi`Pv8A_U=K+ziM?)fPecbAD zNbSU<{rSarl$~K~r9q#eHP3I#rDoS~O@|Y6ze(5_%9aL-X&`(P#o6xZ(5f|gZ}Wfv zLrc#ANATYy!|f_UCG=T``llvyvvEoT?``Y%`IV|akaMJ^A?t<@Ej{djDot}vk1p!X zAv6cVgfwusOM!2J7ZmcB6Cmc0aECF>VxTQRn!2Vr(%PmZXjJ2+I8&t%1kU3R~%ACylw? zup|D5OnzhmFq`znSyw_*z_fOU2DW&{L7hkIHxPjouy4S002**IpMiK`K&J11AP-_RGksnRZ0pK7$ID|5CB~$bS)tl z2mO|eGH0A8L6(sYKqe`lnPe~`a!EEh-FhwX7hcWr|hUHpAaaejO< zDvpJT9YOm8n-vlp9wp4;>k?YW8oB5VekL%`eaCb%H~qR$upv>&#Wx3G^RrPga@(FE~Ux$FQ4Lw?Z0VdN%H8=RU`p4c8 zG}&%<rw5 z8oHKsLn}S+=r|DA+1MVbMnjV~!;qKjz%QMxAYF(|O~)w6N4wDT_!I$1(L9RKYSpuL zHtJ1#DhSZ6{{q_<|FunjVYu3JSS5-2GXRS~bic3c-#Zt@dKNfijUK0NX$mN)=h*ka z9-_OVKO-8lMprN%fe|7G1d{fabrGt015qzPw)5-A>Rx4ci*^9gG*4%RH7mR@0++k{ zstYoX?UM4iHv@#&C_CQnblk$F)_dN3;nngz!fN1MrHl>$nZ;NW&7eT*4}(IUq8739 zKGl>Wm(;ymnKlfzl{s+RV$-)Q@v5sk@sBdjC=9pfUXhBGlkkqjy5UyQ094NO8V;;3 zG=T_L3RwO!yWAQd7R=s(T+E-B$5< z-QEqqULD&kqtB!3$2)dj7`Vd@S5_bSp!j`mg;D>%iTL3Ya!gf`Juo=w?2np&KjL?m zO%i7wQ;*A01Y}W6EIvJ*9tH#2tV(Ik)-2j;lF9G+(gsoI{EN`9Qd5Mt295 zGkI1AVCv?a?3!;%qQxYl9^~VF5H;#KX_@`QZmKvl%FBfw_&Dg;yBLWYb6M;ltQ!jt zeV^z~OiyqpBvT#pS)@kp`y;HXDEHOu>M<(|vFNzQozMz(S~jc1PD8gO+Ai)(bE{Gg zixxD*@wT=G-2zEbpWI&2Zs?~#8%^P95I>n@_{j*l;jz0voBJ{w!uM9p6^L%sC)Bgi z|B3C(`4M*7<#z>a&=q*KsO(irR%J!oJs(S>ESYD$UM+o#0C^!d+u`Z^o1QvS(>A8IC@!a?$t>d?IEL z0B6#VCQ*H4%o^7PGKo^o%O4QcgU)LYowlG{lAVDM$VuW8s-q}#E9$l$yqd8Q=jddD z7s1Yf3;_UZqJ*YzMWUSe7YLRvTTot{)rG;L<)isXxm^`}s&~9iYKi8?_nB1PNr0CG zn7uJt^SE8fx5<;Y=-MgWukzOb%xY9q&W|nKzJuK)yvP#i)QN89#ss%(=0Rf4hYR%t9BQi{<*Vy4(^^OS1vpPT0Y|Jh&*W&S~`KM>VO|sP& z=N&-wcI&O2x5@ZujW8I(<@cj3;C6!;Ovq(gW#8r{g=2eFI;$Lm$_X7iRDE&kpNy%~vWainkP5 z#Fim!_Pc0&1OPCj)7;$%eAc->eiKS+BI_^>SW*VCPnPkR` z{-F<2pYx+2001DjL7MP22ra2Hm;^Wf{;E{~01i0Ff3&7}fB=N*Yolw4kRCZphYny% z2EP&?7b;+c_?lbeUlPzWM_Kb9*{Fxk3K*U}5M7wS8C_TjhFPiq^uIpI9uG64WS3^7wAg#yBZTK!Z@r?5E9Rd^L1ZdI|uZ25BO#Yq***8y!iRW|M zlzt0a?@IE>8tH8Aqq&dkx=jzB?^WlZ{b+TK71_|cQ1efgswrzT3?pxVl%;5gBQrzh zcV`f05rrnnCAz`jw9e1H0JpTB8k3~p9t*WT-~8?cAr*?T&8QM6jeBj^wkx6(5#6IiXbMKxlMs-D#HX;;{FqG)m`303pTL&sNsrpVnlOQA zDFwdD->hJPRL#m_We(s4PmYg%IBqS%sa}517jC4l7HS1?Sw6B`Ui%gv++)xBzmkT6 z$sJD+T=zY(q$&ab+Em@|tknt2JnMQ{UYW=_?Q6cPjK9;sNH_a*SQw%P&t&pBCi&? zX{f~Q^lECh{D=mbctw5EU7Hy2S$d4d{WRly8;bS#WCQ0c?gt1L9I`tE6U+CEAW-w4<9DO~Q8@{gmAx^b z3kpjBs2@mWZbOjF8d>?yS!se+7H7CH>V>;`=)VnPvn^jRd<4P&LG~NvfkS8sD7R9X zCVy)9c&G@U`jzPXN>FFS_2GPyQ;977bsKv_W(V3!Qqe>p)gt1Bu-q-U(`@tCEmPI=|k-_D4LhMV3>uFEKenPA9Sp@xV38kIa8`f0>Lb2 zvb?}&x)XDIR&`eFVts*?K7tZF%RTn4g6NUrXWA!TV0gCza7b^F@AUQbLS@ zpTg6I<*!^@8qV9z{n`DKaZP5cah&KSRuh4*@s%olWNW!1h6RRtxfW252>hEWWtwS` zhW9>B=JD7PWNT@DM2_Qs45-@WB9tNdI%Tap5^k{~8cK6GUCXRl+9bDFrKuw))}bxw z;M1oc;aj?qc%~XT&-7-l&}F*f5c=7)cE~Sla>g$+ssc6HT5qLGY!`L1$C~y)j6(%3 z!68WXjm9meZ!Ob?nUn zY>{&Zecr24B8{ME*Ko>&^%%HlQ_ew~ZIb3VD)(I2+V{ZHxsi43?5Lw4_)4?wy9UXt zW7~<7?;Jam-X;_ChMwqJM=nR)rUL7X9tuJH=Q5o0FO(eWgf6vgSru?})m0>7na60u zp2P^K>r0=o(BMJ{I|q(-u7b_`PuaEoHo#iHZ=FQjA{RWozcnj66;_W8$U9M8E0WW4 zvG}{n$3uVSBX(vL8kAqja6k`N!@)AVM;9Q{6*4Q>-U#D}|Ec*M3^ZcGVefIOfWfm> zY}&q?)EK2gTS5RM+}Kgi zy^Vftt?akye1t=NDi9o7Qxx+yp&Dz;7VFxPzltzko?*ZtJ>|tjEvK})g6D{gA!FrS zu%Uq#LqwuAHZpi)0Tu_VTp#)#YkSlF;Vr*4Oeqns%kJ@BwQpg1SnY7!+R)7*x$igy z(C~ly;8+>r_&-$69TxPtP;i3`cvsP(;)g!7ccrFVd?ANT%NLdUb}A=y>&I~$D(3CU z25qSIdjs~2)+OfMd~}irGqex(L_Ia1T3Df8;!#poBU4OtJT?WD- zG$i=8k(M}VSgD%EcU6NQ=*{d_JaniC|o04reZO#opo*TXF{ zPTwRPY|5}Tn3^d-WmjFUJ1{a747%iDM%qVNJibb+j*zsv_t((qt@&H%C!ftY?sx^W zaVzirgFj(p2>X>ttbVAl%#?9Vd0enIh=RQW12%h$nI?r?IwLOkCRMqQFtBa~1D zg^4QRtN4oJaqE}NQt%wgTRzF)T}P!PAgiyl)p`>qgC4AYc%4#RINkbcEv}S=9!Yia z8274hR`IeE{H)aS^{@Pf0@W~U+pilJG@=FdhU0mY0n+J}GDTX?8bj@Li|hL-zQ-bn zV0acYJJ;Bn_B*edyBpuP$MOblEn@_qhA*YE<*vG9m{N7tqe8Tnh(+JWEA4~$OAFpE zSFQG9o?dG=dnq!-ssNY%Fa+qnnzfuC`7B!|x~yan^m~0)k3S|5-r)w6JCZfM5t|O$ z?kEn17c+S(&M|)=CJt7j!j_+^Hg-IU=4bvX#AVvAsOx}8A}GZ}tkdCzWj?d{aZ^@f z?8|+6a5%bahD<6W$Pt40GZK!L3%7m#r7cPq>E54*AKx?iqL>6pkc2O-%S#6Uyfx z@Wl`VX{Gwl-AR$P7eW>nG3*oMEVl^<;3ZX?zVy44=*2BdIR?36<9W#|(!rn+aWZ@; zq@U`?`t3Fx5Ty>lhMa0q1rntMj30DzWYU6#{uy6m;%<*$f+37N+}^Y~1(C!KW4h@# zZD452`Ar0??#U7(6Qna-Y|6n0(#Mz^trACEHl6S&v+TzTn^4Q@&gJ*|2?V3lX<1o9 zP1|r3?J!@N#C{TJ%?6`Oj8tO?-uV%BDDVqZn2w; zj-(j+A|px>n%48132(cLs42rA$Tt;}tA^10Q*@ylJVik`^<1#1*L!P-B7((v z6n>Msk|y4kJZm7+F0y-M8x~L8u8?4Q3S7qJ9DpEY+v182=b1Coyr&jx{KL=-xB{f? z3?`vWZ=%{)Y(kxpuS4SAkJhcpmU`$}$b)Wg5(Mo1;>Chg-7_{GdS z>>rBp4N@1dyj{**Q&})L*V7KnYc5$&T3CrmNTbtXMMYx&W{I)(}pXMLw$GO0# zg5ZTjf1u~_E5KvcH37U}jUv6-BzKuD-~>fK$FV0qJ%Q&?Hwv>9`AD?dbBhVL_r98+ zqxenI!M^91<<@Bvz=6Kw_|HF&DOB zM&~)Nw!{~%1-ZGl<1f@|B_i%ts0&H9SC~Atg1)OLhnMa&=hIB}*^OpJCgA2&hgH{h z`@#^AE3i{2Mn;SP>^lDvS zn(MG=YWc{qqdB3A?;0{POMCC+RpG^w@GGK=KO&_J>rfOU6H(G5u;~$Ul&J8mXhl+= zLfwTFr=Y@}npJl~Y*d_2IzjQsDp2;mE5D14hZ1Vz{aJ)(S{mY)qts565Er|z>TIoz zglv|hGJ3zZI3|2xMOzI+u#=taaA%N|KSr{h)Ya@?4{_R+!`e5=MDX$zD< zX^mxz`Hu5Mj2omWjKmOX<)dOS(~WF%pRX}hVCLgPKB&hj51Z&_t=L3U zvBXYAQ`;sP$@_7g$|xUdS$d7ha`$uh8blzVcciSxyvdU10jFHx@85a2Pv~yE|M`Ud zWmx@ittlCN?1{s6Cjv1ZhhSAFJNyT@WxK5jW3l_|I~!jB@ZoevBKN~2W8cyZ9!yCO z%B_C*Fn41Txsrfcz2Cq4JDo3E@Q>rlLy+tPFD3t13eH>-9pLU@I4wx<-@^wNib5^$ ziAPQYNRICi2)y)PC|!Mrq4+^Gp$^u<=5O4nKY>IKExR>~d~QaAS(H8<54hYW;X{(a zW!GZ$OI2nrf|cBobrzf!<*m5b1B8@(YXg)YE^=g#s9hY=0^}af$IunIwu-3=sg{3j za;2X~V8@!k5n$^1*c{A$Yd0kwD5tf_%k0FSsUI3xn46$KF21@vTp_q_;GH=yy3CU$^)j zs0{)WZ+CIS-}!TQ>GrDf{^nwEcnjSJrQL2mAqw zV_ba;;tWBNOt^1+?2h$pK&&~oKQi$zFxqjRAJZ=JA@RhGtU#zlp4nIFOck$n@kp3R zcSBVV>(83$B#`i1EZc#h0 z-m};zsZ^URgnfiC=0B3x)Inn8B+ksao-aG{s6jsaqd%Ahg>WRWYZ4(PQLe3rXgD+p zV|5kKfH|?h6t$g3%Lbur1y#v+Hh6jJkf(hWFL?Ao<9ERg=VlIC(}~&zT&eO8?BdCr zv@)}??eMuesO}!eS=hq&2J`p%M!o>m;0TaZ{iY$osaR>fLn*-abxJeOi%^Sm{$`5} z@c>|D@?lP@3Edy7>iYw-M`nGkvdC(#rMwTKi%b6qli{hnaAQn%Ee&V7|7t{cvcKI8 zB!X^~4NoC+$((0pBn0VxjrC(f*Dx!l+SGB`3}ayP2(9=lP0=is?;NBVL?G7JgT{P1 zH;M&P3n6L|J&Rih9`i-4rA4C9%PTSwkBNdz0H2EIUr_pDHvRxo^n;3}T3g%62X(DK!;=?1OhYK@6SckJ zW}_s2!@a^v!-;?b;l6~k0hz)xwA(uMZg}bS2UZ^iXr~>iPJa6f@llUlc&RnLMsKR3hlR89a3~EY!tsy7 zV1sXnNX9aRkAjlKiHV$|zK3BXcOub7femEX53VPm#k_cxMn*;2GOW`VBzX1jx zpp;sX;$Unzc}@v5`#dHqSImqhX?X05A4lfRfPJUJurN~0a!g(UzgKSd)N%`B%JXZ- zQfJ!;dd#GM83Hp$3sxIsveL4TDQMc1+J0T2C;Q4s=D9^HJ zv7~=cG#Ed&?lfdPlDCk3p!dj(4t1ut^poQEe7Lj`+LmOqz+8^`Mapbdh{LeTbbA3J zM$=`k^ai(mYsY9$US^XT7;IlrYxoY{CpKS$yn;`*hqWrj% zwK6adTaZ8c>}fJ8K<$0uPiBH$@2yCtI|w#F@*Aii*XLjb$dcAW1cRMk5iCb=kr+3er&lcW$d9w(O5>4L53Gw&0{MM_KhXWqp_sg zCtRilUF$5rLJj7gy_rl|rXQf4MmkZO(+iU`;gCWLb4-btK7t(R5FISznXb2IF&O_YFPI}p8n&NDXKy3pf||H%h#soG9jsv;maPvzqHB^g2Ceey|<}B$T)?A&rKc zPXfSWQe^fAELdyJlf>ru%#`Ph5noaG666t4E;=H-e3sWMzpsl5$OME#tWlF;9v57e zvU>vd6_`9KtNI8d_5Q#rbTYX-1H8iG<~d#vjRJSkX+XyI4yi>?XUwPo5DHY{!jfoG z-WO)RpLd&|;1AW<%O{uz&T~VC_;==2?{l`@z!lRpSTt<`p-&}MLJA`AWMW0Bzm2pE zH!s?z9Mbz9>DvG|9tnCBbEcf+j*mDt>FD)PqhZtlEU!WVB+IxFs<3NOm8A)P3cSt` z{0>kz#=cdQ!tX+>sA~CtwqkW@%-?)9`*bXk{A4gfBHGC+!(Rj@#d>x%lvo1~{8zY^ zE>l8yGU4Wnu+{R;a^zHFyw-^sU%t?aT%^?~(7w&~9@k$VXqaR>j21O&_x+KV{f>nK zXoWFS8OIFqkfZT*ShMIe;8gs7mmIcRSWXuB4qU%G{fH|Sf}~K$0b|y}P}e%DvLj7C zH6B#z-mU#`TmF0MRWIzyV~UIAPslzrPgB1>)jQ{l5Bhco!8uMFwfmw-TLImJeQ(OE z*)O<4As%ZIxS7xPablbpP-gbd+;?LmEZ<^gLEYdIx@4^;vzvH5`NPZ+j)*a%Ftts< z(%Z*mN+)Um+8Int;937R9%vQ!@`2^oK-fOMxga{p&cBA@*-UUgmwN3yw%G0mno`+O z(f9cweRzqZ>m={nV9@Qw*O2SUu%F@mYZE_46l~jT#QW+wFIXui_rXC`y2#{|^0;i# zp7az%$DW)%1oJkNnQf`67d z+?}Qwn0&dC*R8BmHZE$&eMt&QEHLk%)DS#uesoNDwnG%{1~BD4QajWFig_nXin5(~nQWBR5XHH+|L#!*x0iiWP^0XkbIt(?^krFjnG ztHS{SKk__*ZTbS8j&$&g3ahp>4Z|7Ek%wqM(hJcJrnP)%+GBdfyU4I#uM3v8u5r4ALq0e%K*X3eJeZ(!K9EqmHj2^0x_%8nkP@R z_L2GZ$5rndyq@9_F!#hdSJ6F)65GVoBdPEDNNG@3ZQQ+t|&Q_BHqn~2k|Et7> zE7Uy+;?}ct*!#7|adD8mrcyy*BH<1nJl57C2_tp}V0V~N=dB19J z_xgI~l-XB2RCD#y7oX!RX$CBfbP9Gb^<&U4YAo(6&Z3GzMr7iv_MI@U)r**)F-lr! z{>5+}SIC+J8@;bUr%)L8Ffwp6I?T=6H*|WHVbNe`zr=1_3$+`efWMpwk>Ec0z0*oK zWc8XFq^a0hcP21<9jQK<)6>$PfmcgHdf8iI%7uP#O+nzCDrB++bt);>Y*SM0qk--$ z5LC0s(*H4`%Jpiw@5+pxF~YJDgLT42EU}jzt;1@5%-C<$dLMN!Mzvnwg;{j1kNLRQ zLXLq(bS`LLS@>H`p*V!S)&hP{hXQqCQc5%lr9n~Ta}8nKhkS4o?y15qDGai>66-%7 zx4c(tMNDKy`a?o5-wwbE>1iWrNmw>Nv9D9hkBeTg0R}j9&gRgcz=Lpq*`+<~ielj* z5av_pVEQ8!{boT?FEn0rV0tR#J zYbwiz3q>-%%QLTntPC@Df#16)!IshfWPMRm)P31Z9gMMtRKw+&<#MU@(9D5DZA_-Z zGLH_TVd2oe+=nAa&*@v`eQTIk7J*-%BY_6dEXfz-_Lw=qT7{Gku4@lJZc!-(WY1aV zF3QMPQG$w4O%e1?ix;9-I_E0VxOdc)Xgp?g#3TGPhYKqbj2vKqIaj};krcYPIE4ax zx_2=y(GAloRIYz7KICOy&}CPHb;xO9zjUNm(o;yq`^>~u+9C8_u&=F{44?I#16X8- zxhs5hu}T<0!yMTiYi2M(dKLZt_bL9r8qefYl>oLP9ZF_6c$?{LI>2=4rS|B04e8zE z67Npm+fHPWq#M+@wCPggK0OPXb8Twwo+N(_;q)YXHF%@d+BA1gu}i`0WCy}p)j}#n zpTV_dAmI~JugbyCLSIdZL)x=I(*4PKZyqD@np%da=>}v&vXn}0vK5^br!ja zKRqIBekUsU!y;q004);$01bjcpAKY{L|iNX002LVR#*d0(-itTt9Vq9{v>N8Cb=j8 zMk1G#xEPmu}>zLEerA6dn&x5z(HfOjF&VH4W{;XT`d z<3rx1`eT{Am>6ho#&LUI(IbK)-loJaQ9cK99XHM24o8iL7^Q(=Di;BfP)gb_z+8 zlMOnfqXZ^;wJWyLP-n?&vF^e>j1I@v*iac}f-E|fy{kVhg4}|QJ@EaCsyDT8wJ!zB zlhuS+1zhzN7V#ambf9ic?d- zUHP0yTLua15|G6D6w%_QmG*#7=DoL&nP$wX2C|pD{7yS7I}oCUq4ayvtA3U*R>a&b zUw6xUba&H?#d3VgPV|DGPTCRfThd1DSaRI_WL~k=@CwRhOZ-e@uPci*o#KDan<%3= zMQ|A5?28}y(1G>k6DTuZHFKB%Ur-RKyxi zXy~Yd$(6?4M^ujbk&#-SMbwj3{TKhvM>+Ki zST=`>z0Y1F6t^;v8!<)Y_P9p~QTm-VPRkmMuNqu#=B?t<_y~0Vw$cnoH%(ga-)_sB z`Wz zrr2Zs)cCv5GqL$CaCKFVU}8aX=2f=>9EW?pQH5*`?cNR;AAZ$Zf%1?^h;*p z8vJ4%Tn<&YHShOE{(=ua#Sdz;OqvS@ctQyZZoTlQ2n}Mj3vsN+?yt}lKWYOJN%4=u zzJ_A+x6gBd$)~(j({SrER-&HfWL^Noz&HS!@ldtJ*@N@SaL!k{tM8}NLCRy|nf2j@ zyImg!Bl$dH0VF}}NhZdPf>usv_Ux$KgPa2pIam_s&V@(P)p~XY5$rBnaM&h}JI)CX zJ;O47Jg*Ya#?br{LASxhy$>(M^%%IQCQQaR8mJ;fkgfEZRRiSwJIg>|wa(!ci`G8C z1mc^HTi3(9Z_3YQCWQPGlB=t5AD^J z&w^mG3!6|Q$F(aO%%^1=9Rl;dvM`7A(p9j^utBO|ZRp!FxI^u|>J^eO8K~PxW<&M$ z&jw%QBizsPqHhVDm1#=KWv^%@C(E0in@v-l^uQgL`Sud+e#8DkxzTI8@1RgTW!yM< zo$61m53DiogW@CF?hAd1v#u4_;YkwKD!t241*ZePiibDTW=v}!*$bHo7!Fe%AMd!e zJ94D2TGFIWk38=B9BeYAKvwu2OaRE=!hV}h)-yhkpMPqbjWJyQe1a3wD*^!$HV(ib z>a2}#?XIGGg0UM?Br5nfR_2pgJr?2xG|lOi9Y&1^As5znfz{qb+m@-tMy*<)D90 za{G3Q7XOL-3t9?K>+se@w>;UQXQ<0C4@#HZTh&q?YToRz@ zTp6U~OXej!n=MtqmK)GfqOE z5vj=t6|9w|YX|_(L+h%B8*&r8I7}PvKBLPS$aSY}^sr)SrBjapk3})xp|68DNsqIj z7q~fy=HWUb%1URCLi>m>xH?h^^t6M8x9(-5THmY+z02tXC@OR5J!{G=5^(OdA3Noi zl;BXAaoK&~#oSiR9zP#s>1gI+VO^}&%MYl1>a{_x@Bj7N%;F*7l2g;F+cX3mF;P)* z28{ba<5!4Jph+K|*3a6e6LO@$Mq)q|{;Ws(f&G{r^5Sc2!0%@~*_I|&IpD`QPBx?o zH-({nf`fuaW8E~=6QLJTpm|s_T@4s^o39yg3?z`h>sZqX7#f3a$2kuLSj}RQENTZfp^& ziszYr-M50R8*eZBk}kDwEJN-8tpXny!*zNvj}w_$;!m};A=`tzF-~B%dN$31pRb5$ zm?`L8Q;x6av(ahS&LNNSce;h_c{DmuuIyQp$C$^G%wRcfOdp`n|8& zmoH&|o4J0k`zuaP2<9W?R?t}WDguDqS<8B7USxnmxHEff!3-!NJxo??}Q z3LXkREoL=tryaX00wI%oGZLPP`OyjEI8zceyUI|i{;+UmRtap~ujgHTgNQRW=}tnm z)6jW z{wC%zkka$SPBK?us#REMGpx9s1z;Sg_8i^w9H%AZnR?RHztiltu? z6#BS@e9F3(vzg_Pulq#sW6d>L>Fwa1_}dU9<7v#gs;OT_`N93IhWsGRe<5aE=S-%> zl1h?FuFL_YC$ZT#3|OG*%!lO1RXgW_RO-pg$YBiTzmI3opa zDLkn@_})uuwS$Br`~CmyVE)6KPaLZ|)YOHDEw+5|zwL9NXqkK;mMcJ6%fpNGoW@zA z0soK!Fb2h$A*a+HhI%GZA1|yYZXxb#B^+2T7Y@^nR8~h0drw@>eiKGvFR+ZU z%M+?Anpo|+3SNJze!Qcv;!4N#HT@CHwp*>lz>){R6d>^#s-;(a)4v8v)H}yCVIt|! zr!$`wju#O2zXMLO-Du@wrV?$WL?%y;$dnQOYOSC9S2E`k0P`4~dwtsv>(Dhf9~}TJUir)a*AW(${JC465-g-C z@^6dHYgU$$bt8=XaQXHdjT68-NiXDCWrG;mTG+*U9kI9jSx$U=stZewi^VTR$TH^| z6_J5o2!G~Pg%kTa68z1136@{NB#`K+S)a07EoAH#PR08E5=EiVdRGVWtg*lrBrc0?cr=XA zhD2~j7Xsf8Rd-ZW5Cgoe*mNv^MNOTjeS!}@UNL`e!#|^CC~^CEH@3gI+voVY0vCMi z!hc=PUiPLSTUv;eXMag~##*6quy(sLT8YlE?0Uz~bD^m%fXRRfxd(azdhLtv3IG5H zM$nu#&DD4zuf`RKcoAVk5ltLAz+~BF#9AU&!uM>rbDk@rq}IW`CtE0Bi2d_uz!d zCI(nL$HW{^zi?Z8Yi{ug&P?7@R?q3n5UjR=jX=fV{L-GF`NU$1UBRU;*0tZ>cH^#@ z_Z&ocLo+eo<{EF$D+K-D7wqlYcm(tob{gw~mqy0uywg)vM*WCBEr<}4Ze3D$$5y&Vq{-LHW4CJ^70df3wpG=~qk(4)DS zlLz{M#pweSdd4wkc!z6@(@A19TZwxC9&5MBGKse!#g{#B>~65#J(C%?7pE(I5cuhK`;L=Tk`I5o#CI?+u8v*eoN>JE9 z02y9LG}sL&IeG_+WcqJXck@mV1;|F-5UBRb+KU`VM1m5>7!O5>_pRWKg>+vW&g5I~ zfLugXK>t#=4ffVDZghDw|73_hlv)`;Cf2>w31kh1lnsZi+P&ZaHLvr;MM#P+4njL& zq>CG`*%To=_0%*%x62(I6d5NW9byQZfVJ(wh_rQ0uu)b{y4wBVE_p>-?|XDoej?Dr zmEdCud)*F$iAKQ0eh=bzWpM(8Qu98&FT%4R*}$by-B)49dh=*NMw$e)jPV}r4bs$C zoSwsJ$aDjM##G>nO^TQr_IZ$~iHmD}Ypz8O3TXfE&URKM=P+uTtLrR7;LyIuw%w4P zll`tXn-6&sy%_WHoUI)I8PYq2fx{FWPW{SX673eww$O7EURg)?)1~I)=#^`$isH#a zk#Nrrw)}_Jwp>A?b%fYJYD4U~6O7rzQYRQ>Y?RnhHk@f}D#wVsQVXuI;T`>lM|f-- zEP`JZN}kb`cA6;MBqvet#V18$P_TKP`aw9sP@UBwv%TLsrgj_>FOVzC>}fWTIL1sq zLE3dcMc9i{O1MHp=b{Jgu^tPO7=oI>Ff%ub@n+G*@jf@fgml=YBft-fd@wHzARcYm zi8$JjwW5{X=cVgojAR{cRxnkHAt^S0*^z&aXM&;r1lKFOH^Z6&ie_;pWTi#cCrLy{ z9;0@|V;7}A-$t>Q7e>Ib1=B?f zh6@v>leHhotJwyCgjow>Qq*lb=8&D;PX==7W;NGcW(2*GcQd4R1E=yX3sWHaO*^o{ zeyPEguqynWus{iG&DfNnA$9uW@={Iy_lh39+wosQLx9VyNCnu;y7Q=hz{4UyLzod* z)$2Y&rNK4&roB!&BVqtTgr^zC51 zDOe0eHGzpk>`9l#^|~m`>vl5^Tls9EFc;S~tb24=)RW}zWd2AtSrlHS7>P#V=0^U* z9u^#tUMsmw6aJoPOIK^B*|oCVx3ie}i1+{DuHtBhVYAoqo5Oo3;MBJfRmd~HmG|HNr6?dnDFE=2Ti2RI318Q(ls zoB#_>F*yK8H0t7K#-eS1nN}r8lHI2efOt`N09mk4ELfca(h?x`k1`D-E<|^!F(J)a z;rG}9+$c8!2rj`-$=#GmywXUSkDywK3v`GGSHDE#7{&POKvZtkHJFt-GQf^6x~H$8(6e_q4sM* z{MYzt=~+(1_Ai?p$QdQF&XB{(i5?T3K(UwKP9t|=q&AkKZ(fv!nzpJ+*CR}vg@DnZ zSwiu0Uk~ck$V|i~Kw&x|7m@qTaiEc*rh1fJ%UEqXgVQ2x*DZnK(?2z;?_rWvJ`eNr zbGnW7R3~qZ=`txKhaoi4vs$e8?Px5%=olHP&sA*J%L78v&tqdVx7(CD)G8&E0 z-y)1w&|_Gk1tHzW>4_x&?M)@Uza7Yf51}UzY&E_HGPOIt8ni5I` zmV{9?{+1RR-R2C%`OueX;sy7NiE6@nF#U+{p>UW|1h|w1O;fyML-Eeoc$Ob(p-!e2 zev6u2FdlYIHiKh-406%{GQb7@h@4`_7oRRkgDK#ZhmULq8EP_jHi{u}*N${`=n+~{ zJwa|g?jVSKI6kkB=sxXHTY6bi<4)P-)iUJpUQUDm$4kx|B!)BYPY;d0dXsjP^6!26 z8sFA_hFz=ReQ_Qm~CdNTZT~T4^C;<4YB&ni8rnk8k!cuSw0%D`@a9 z$EK_y9gXg_dJ$pWM!A%!#4_l5`n8HGXfnfi;A0$ag31>0XJv?WJi>0S_xNBFY0pmb zx+o2~4GO^ZAB-It-{nB#k*6KEa2Lw7863ltuu_IW2-GPy%{ij#AmAN-VzwLjj#r@s zuwKuaMe3Q2!XzCnPm93RuwaX`vTwoe@9tRFk(4d$mOiC|)>Pz;>5${(mZ}W{vPc!o zD(nqXqc5z6Hy(!Cc*ZApx3oU)I`=6khr=>GB{6Oj)2VM|bPFT?;*WR1*CWXLKR4lE zB*RCRBOa}{X7-q{94&%7wE$*7nZF^X6Cu{mY<7T|S|~v(*c(#9GrmqSRcLoeo`l;; zGm`G&_j=!z6fvh0pW(jVKGiGt&$5s{(uSeSwZ7_o&Xq`Qn;hgQNWw_O??xs1^WiKf zJ7NxNc$)K`2t$-b1XD&?X0P8vq!)jFdOWKo)Gz#(W#l~vv7%6hW1cdfKsJilvggc} zPM}oc=jd%De^lTZD#P^uh(Am*-P+6bTc5C=v*31ij(vOW2z1bA1&;ZsW`yf8ZJ$ep z!RsMMkRt7kDN@*gj6JB)z=~xaIfg>l&fCktyfq0nLa*+JO6x=)z(Czlj( zC!6L91m6l@wx|%f5!A`(*lM zzd3%i`77`AB#V_}IsC7mNWX}VtL}$tU>>f5BxwVJ zcv_hth+}CW2*ZHBi)La1ZHkeJ~lR);wV$iCeHtW%qDOHkq&;)8oNW6NoM{ zEhtp%E*rSd-KdFq=Aj+3)0(en)M{>1@F0Ud6_^{6$*7@*JI#u|eW8_mw6hp^g?pQs zywo!4m3B9W=McWv7JO%B#ehr&DB6jDevJ#(R4fWjcobB4F%a@dPnmElkEtLDdc=ZX ziGbhK^)#Qxmnn04$r8};!C<&OEgd59Y)TE>H2)msgGI_|sb>{nOa+9DUMOV?xg|h+ z1h_WDn<#7qf?dcqmn}-o)J#qy+y0}jvdl? zJkiUn7kAh5X(Eh1JKU{drpF${sTG-@0;krK1}q^K6eBZ1m+@i<(>F+cV#KeyMjWri z^*6pZv3oQ9>Q$OP_7&S3GQp$D+Jw}$C9Rgnb_68W~ zMpvz-p>1{7`k^^w*i9`~sJIu}01L>Y7!l3T#PD9yUPUs2hJ`Kiv^x%w=e!s{n9MFy z1_b<`k^Uv7;^qKTvK;j&Fq+ny_oO@(4a9#oGswB^nw4Rmy|@eKh9OiSZtg_iC_K*e z1S`|x+iZwZufcBx5?i?w4WRMJQ_XD^5`W0Pn1e+=6Ged8rt8Y?HNpFd#s}&Mr;jk{ z**l&`pyD<&-~-=$B&e7G00RIt--1MG9`X{w3mmdC5hx$5cabo5Hrf8GmI5s)HvI*5 zpa1|O(LtLuH3%)KGMEH6|Ng2~000j^y1TihHOlY?*dc6I@XeGnAZa*qIj@zA0dBgU zNEKpFeeoteNvVR9%&nj6KR-r{LI0tz&BXA;Aw@5Vi1TfEzV}$7<7!4bg7JKjbPsge>8?AAKMB@4dH8}Q1_iOZz zgJ?dbemerqt9)noAwTpY-9k2O!`J7;nH6E?B;s-Auci=ZYhSe@m37MWym*`*uP|}Y@{mi3ZW&cgo8Gq zH_xm%5==qL-FnTn+z6u%OP}oqaiS6@cjpCJ4BBRUI&HW+j4;i3uy?rXa(gzq^{Kc1 z3{4BPFM;<~v;J80U@@5wH?5f5+lTKfeS_KB@y&mAa&zD)<-5NLpVQy*G!oz5N&EpAE^@X(z0eh%tu zqB*gWWKmE-=xlsW1Sxa3=K?dfj_H`qp#QPqIr!TRef}c-jTyvwED~B9d+?g{bOcUi z0*V4cgA8izcf=Sl)Ds3~74w(rjQ{JdY8g^0%ssUox;}M>6v|BXUoiAC&l+dCrixi#yLC%ATnP%6o z%6MqhqxnHcTE{_)qjQ9p@t^<&GAJ&|(WTA&(I_-?`D$&X{GR4ni_E?? zArk^~P>LGZpWzuL5j8P%XnnZt(gEv&aEHjgC}Qv6&yy_B+_8ATzB&FXj&#B{EQ_`t zbp8Wdo%%CA5Eg*8M>CW%Sn;g*-ahcp_rXep>(@`Eq{}2($v68tNGltA6}Y*0@x}!H z;oJGce^&hBuAm;;7F*Jp!x2VV7M0J|SY9-3;Jh;i1K@Q(+UTVEb5XcPuA~oLVf{-t zwnkaijEfqntS7gC$}0e|%U$>^(0M5Uq1%LYYhtnMy6nVYfv!0yG*3TJu=ubjmF;Ne zlRMRCk>*-nx4DBqk>jZKWUPum`EQgRV_7i3lPPcX9qV?Ud1f2k&*_$Iw1-2kf3qrk zX=gUx^CvNc!L8~YEt1fSqyoyx3CX2t;69AKlWPBL~PX5eXV>7Ho|}_X8$*j#CQEa z2#Qyi2VuKI4FnV2)_Gi0@NZQJ)l89p{ROx ztqgy~u34~cy_)&^tL4Y`Uu5PWY5j@RUNeV>y4=>rCPQ)7$z!5)5W#8|m#IM}dzMos z@^vT>e)PIBUFDHZNSDi+?3+`%z%f_RfNR}lcw#aKY;N?3+sNHuw{l*{F4~N5Y^B$0 zxPEBfEvV!lefMpQD+%dLWF|!4|EHk2hvtnBr5QD%7V(9ckw}&}hJ+nijV>Rv zHAS*O+!&S-E;7e-Ha7_0IJpXJu{F#SsY5r7kdnI9eTNljpmD!IqS`B>aUXI&KY|HW z{Xb2*rPA(+$wJOSKdS5Z4y%>G`k((?Q-czUUf$9RWL=dI4E^juO%v@5x@WhJCI zQA~nM74L%8d`m})Zad*u62Ub^;b5OkZc|8C*u1_IA60-=3#0d&)lGQGg097^8~bRc z1m;A*%zD9^-4q?odLa;O?0(aNtzPrG0|bLMM7Z=9EZeD#0QP4D=*rQ$U4I`DeGmO1H_L(fxeAhm!oK=5OYlb+4mr zh1KRNZh5itL`po(gh^^Z=g4its2Dh{oR7=D)| z9el+UNX3tVjmsu+0$JUL0PMsMQpI_+ouYRmfi$3eO6;eCp+ADr;!zUrR2oB z{9?Wu5i@aP0reD2BjAg#iQVlbc|Y~d?#d3!jdwy7Gddqv2(!v<5KRm4^ba8oZXaUy zA4-EfG4*muj_)64!P{y(s3O9@_3I*;TedK}VV)9uEOvM*Eq`MH|Ndq`3Bb7;x%(#J zvnA$!pXPEKh?)uWIBC6mA07=LhBu6VcCEdX?$(m$(1xd-G$w=8D_tK`s7Vw}olq-C zw{8Z(P!faX37_-v0{}lPw2zb(#;VYD0jq0FZ}$!Pov^)?D6V)DKFBI|f8CpKUv3SQ z)4yKV;GgcL3Zi`j3#S=csn>wJ@V+IHR6C{PS@8NhH2KB0J5Q(!2B=ET#6)M!Oaat- z$>qyjG=6tF=?E#WxxrWKwO#oTwuRzqq)9HT6jTH}cq76sO|+oHa=ItENLJ@Q|MrMl zl10`jThEO2RGF{F!bOhskwqBC$l}DZq9|c$sCY)RPSnu(VQlgv;=BJRL6QzHDP=Bd zn>AFu8cz$>nv!ngXWiD~T-ywr(;{O|*-iJQw;FL2=KqV~@Wov`i*^yqHZRx+g+1j6 z{mW5pQ+#uS*3K|7!TEHapuqKQDkZJ3{i!u*_GQ%_yZ&DY>ZUOF5f`0|2KhT!g7uT$ z)9;%3Hpg{(PxYRPJ6~d%poA29@QgC-cnQ=eiY*hbkhDR$6*ZHomt#K$zd$naFnByd@#6N<1(?J)TtPDe@Tw#-`(U4rv0b&Oe z7hdt8sQ^H5n~WH@Cn8_IEmhRW97TAA(hXpd6{!Xn`{6r- z!eJp^Y){Dqe7%Wl@{Zad&>k|&x1iz9ypH(kziCAG#O-k{_#U33zIh?|azsf$xNN;4 z8rULt4GNNkG-m72>cJh0vwThF!^g;ZTrRpqOnd2)ilAHl78yR!SX3w;a&i5j|9{7e z3u)$zisPGK0? zUqv{*M*`*dAANp40Ajf4%dJlVQ88Qiu1xi3vyYnjHI_#~*NwKQ5j>yTZ`($loF=Q( zhyuM2JPv-8N^D_^S9*=oTWnbP?}|wPKx@5|TwGDB!Zz;c6%2@yuY}qlV+CI48YEEY zl5&U;fiZws3{gX4xhWL;NBudIuE<|gF)J&^%-XE7Xfa@um#y+F@SwgJ4mF+uuiD*_ zCw8ETw{0G78?uZ*jHq*YcfKCT7Dlo(0{!=|YNuL6&!#hMika`lYZsey>1N9e>%dTp zaG}sPlOpbq{+}g-g*B90FYGxI&RA!=*phOCthJ)E-b=zagZWMMmw|{>FRV(=IJ}@w z!JH$}RED~p0qVcZw)JaWe=$!lmg=z$uD{v+@d4-o{3%95unSNwFSp6zGCOQbYVJ84 z$o*74$5+T-*VAE9RHJW?@^YnnakJz6YEnL;BEtAkxk=gwg?ZMFk}H4jB&w@q)ACQOM?cfL-; zHht>jmzzb2sFRBGuY_5Pi|$0XUdo~C=xj>g^`>=Mwi9Cb<|>Wx!D$X9wA}{$g13-$ zM>THbhWEt|LmAo7$@ZcdVKE$e34u%=h@ReCW}gmMOx6*&r>x0gDRh zC05Rg9K<+lrECeyblY^X7F z0&{qDQ#dwuI(VK*o&bS<7jO2XS}D_Me{E^~uJw@*-E0^4JW*J8zI!-p2v2jRifXD4 zN=SU$F+?ICT;^gVXOYDgA7aiCFGh6)js(p=QFuSkHS|X&7?)ez)-1^&9)Y1FTDzgW z8>cBp@eVfwj*TL0k_pfhJ@{2pDAQ^;6Y6~#$CViCb)SFwA=c<`7{XB1=7{lAGW;Z< zj6$T*b(={I*MhU#a_09_lTzLVUOKAoX|pR8%?l*I3Uie7ENeo%ZoCej;yqV9)LgKv zDT7CM2a=xyu8Be402${oL)^IBPxPflEWy@tTJm`f>GMiQ%J!bx*}}w2;LrU*EnSa8 z4b}S}`TW#iHbiqNR;y0(j;?3J?7DPn(~vz;R%hagf!x7UFMe9M9Am*j?zMR-`Tg4L z!)64mw8zgy9gkm74erLu0rES;+|%udMra$W7xFR@^xKo6gZX&3!tgwYU?V z5acM|=bu<|xIt^Fz;P~Ua#F-@U5{wkKKcvoug!us{!5xFjZ1U@ux2F=hX&YX<*6OC zTPLm*WKahYvag1JgV;_N{gxLYg6-W?gMf&?UcvQ&l^c*9Y1`S43{w$9fqYHP7F%~9G54U*Q03Xc5aLPZ3U$$=ae@kq4{~JlKMwN5t1$7{ci&*D8 zQK(_2ZDs%0M6SRifSAE^HYdM!sb`Cioulk$OzYxRVQjl;X&i5`PwI$GuBPo((ztTk zhEpIs`qU)s5x8wtA}($?^{wH07rtQ}o2P#Gt?OnV28nu8=9$yX)x623c%0r$@|JXft#^T^R0JWkB{D1#vqQu{~fEg z!u@e4x!4!~{QXW$EQr*6KRuo_z8@fR;lY-m*ByKAS63pZHg*L30iwRH2|?_-7tIb9 z)0`fJ)QZX-YqfCKdVw6junxAwvi7AWnp5L_SMuLf@F9w)KL!1Zcp*x_NUYr?Giz+pZNTf+&_LXuOtM)~33vDxA-L^#0R`z=C)&7)B%O6$GQUNm|LlQ-EGM+1 zWYt9|m!4wRJ(j&_h~`DyYy)z7H}mQ^q27y4R$(h2CdwuUMp%X3yA@0{KyOcn#wlMT z_9S6-=y$bfTXIpx>SXWKUzUaUi49jolw&o`&LGBOV~m(3LAsuvRpTrjaVn7XP(vO-$in78wMcr7I$nGy;E~WOmA5Kb$2FZ`Mfl{?Fu^j+h^&2 zBM1rQp074khKm`UCDh~oQ^`9G zO*5F{h*qGuV2?X#ttz#OLLH8_1@CwRv-72d`K{wWxGQ#ftj-*2e+ue?6%idCb-Q)& zjRx#6PxEc{>EZ8CN(!2(6Ip8GU9wg!L#h>f-XM~Li{G{>)^aGu`5A76vQvO{or+Td zj0TjBPyHyLa7D^lamo;V5r}ES-WJ|*8hMs5%*DRdUeY-};29=Xa4+M@zzC>F_@`xu zG0MdYQ!*Y2wd~ZrE(vRzf(UGC z(2(8;6!1!RxFba9j1#DI<^IcUCJ(GktX|k^xKVok#!(+lYQg{Vb=<=jgs57$PV8aq z2v#B0)do+C?0P1O(3_k)Ao~x#Wi`O*IB>po9^mxA!vRTU*{0(wOwgpb>Gq?&_N6Df zP303~5A7{e!qquK8Qc}soQ7(SLmhw`NclZ?G0NMeSgnfSaBWp+k#OAa{Oi}~J1FbP4qYQ@%C zPC$$F26OA~{DwyfmKDz>?V&H-KzrLq_E&x{f|ox89YJC5RzG59)RmPohqG{P+;? zUc4Gw=|Hc~y@KW~e<$U>;1`qwhWkRmbj2EIfVLoUH-J%{ba=h{3JV ziC&m$u3_$fH$20be`7gyH%qWA^R?f{|44wZ`39YXA=?@zBfdsP4D#Fh4G8AHmL$+C z36OEjXCUS1GgRKiI`H}zTFOs(?+M19i0W&qUGEasC!Yj^-lTm70Pp;%A>L6-$uO5= zl2lK~AEa=^z>WleW7{Sfwe^lFNfe9JU%x~Zx+Fe*RxE#xDJ#?bXx(z*tkNpXKK_Z} zYQgs`Lpr0MMhdJ(^kx^xto>M;39C&)WvfanIEI4K8mx29&~*P9K2z5~3c*;g0 zudN@)>|bYWJ8bzp>{S;9AO4S}M|_O}&WQlaMh#LW_P}yO-}1yVj{RUyUBh_RYqFi# ze9sz&DTG*N_>b=TttrFWu%-4oS1|XVkuM`zFg&mAWAV*~?bn6eaAOG^3+mrw%eYsc z%cd6pzZl4PZpx9Bcp-u;7NbxpDYV5LRzgN+{X)Eh{FD(y4Tfj`sKDzr&XQzsm-FG(3V({YS4;O!juFH0 zp2%gtN~TxDR!bLb9}He&B!#9O?41y1T1^W;`v`9bq`CyGy$EXMh!d3rlvN7{&vE0c zd%&+wR$cgI+$fqs$R1w<0})VX=HUaBlt;oYek>W1XFGI15UP{N4KTm75T{7%6IN&m zeZ+#btwDT`5$eIs{Z_Is$^aI6LLII-{^ztaA_L#a_xq3%4{{e4)@ztiLUCxya!%U; z`0>?l1DG@&Vj-?d`8?gJr+f$1B`XMS&5+B1eQWMMfb$R(9dh~C^w?y%{Lt^Ni*OJA zZH#mDnNLU$ffD9UVaFP|lid7^$wR1Q;AmiUm1;ruz0Bt@WS}O1184e^y^NCbu#4I6a;TK5 zD6Jyp7P3B`w5F5VfEA|+pT$LS`pgFNgq6$n5Rqh!Qy`^Ahg(!CJb+zJ2+d$3v0>yK zDuC|HirE4yfNqI87-Oy+_GV4%cDmXa_@6pNht({rZ8IVDgA%Z^Pa{4#SdwYtrYg_# z?l(bh>)OWkpt#sFqgA_6CUv4-;h*P3f?gl%5kOJA447LTCX|N4vIYQK*OHsXU;9uKqGM z(#;!zd+$pN!tm562}-6iwZ4L1SQWgjVT7Ij{%~rF8OBM8wV&c+4@~VVMixI6Vk+rB zBkHxiPY!Q+SCj{@^)&4#{WLLUFNW->e*hrbZy<-*e^Y?JuKYbPsl+Z&qc+8y4437{ z!|;#8AGviFDXd7eYi$nF$KO9_NLsK~9$G)VOG+vW70lKwO#a*zX6_^43P|1oUXzeS zie#99MKK=wlU#$c{KCApzC8Q$;#b9TY?^Uw{C^tGE&Z}4L zF;ZfQN?a5|am0(Uz!eG@=BbwjX7#wq?CaS&rgwUF>5BiKJ9Ar#nwzHp_xQ!^g?9@^ z38|AgE~Y8!UhW-{A3sUrIVnNEvLo8c?KZlea?87)sugXBGfMX*TX9tdqvAeUj*BH7 zoI7+-{ok5t+J^L1Yl1ruSY~P?c>41iD5ktEwN<4oZRP#q4|+e#g~7UZ@5D6I0e%K~ z3hl9e`igfV%$mw>_#OR{Xn?Ru7d6zTw8_j8u>?xX;qe#kOzbaAZA@g86|``?t1to- zz1A2oRNq%>le+XGS=RQ>OsGOi2DNiDXVP*lH8GzoStK1K9Nyn=d%Sd~@(-LLY#s>v z_mvJ6pa-@Y?p{1<8Hh*9Bml4j_m7k{* zmZr4#r3gfU-t6NRQr$&(;moa)3DM<&QLW@Ed!#Lh+;0vi%{93AsZT$g5fhHadp~ax zDMiBdaXFeg8oOT!IbZ}FvYTFd*UKbP_@g2E$??n?E(Y_4zXM-uz%m%Lt%9!k!1Sxq zQ@wlgVaMTR^>ZLqQzvF%@8voMXNF7GCbxD6knIAIMq3Tu?N1nv#$JYyEgq4;l69!A zG%;AauS2FGa`}2@g?`geIr24cVX!w!v}~s|o-!~lslxxKW%`Nf0ph3as0V-(|No3< zk@FgEmR_|sI#>P*j1qI#7pEBfbam#40K=wbLK~z5F7T85-R`BWb}QSIW1a$zwME%7rHJajeP8lHn+cuQgCg5g&6`j9bw=%gJZ~tWtpe z-C5vs&_^!7)YBFUT>AhE5Lh0%MX027*MI&+s34g&a>vFr`XE>%5wa<(2MLYp2J0wH zgB;SKFxBV=L-t@NuWdP_*ZKj4v@@^8Y ziAoKFORD_aUJih(!Q~WuURPP7dBmHjn?DMNr#iAeV!-x|GpIc%Xuwbfj8raPeI1vf z#P1jczee_NATElaNURS@*I#f7FUpl^Eu^fD7I!tJ;l8XSeYt>_#0G3lB^RPb%8C_8 zgST&EOJ2DuNnuhcGbx94^fUV><9{8obymyfPe=L$YR62>hw?<|;=^UStCIonF5h83 zQHiKuLw&-p#d2rrpz@%CrjIVGzw+b8K&|4JF%8T~9``yq(-Ef{Sz14^l4@m#(L4y4 z36?|M)@$U3jByrG63ojTzu*S(QHyy2awI594-Df*j0DL2r1c;liK$oTWoiP%a(Pnk zoXSDUCu`sE6#ltgAsBf|R@`Vd&VR@y3hSk`U~pf+H>JJNnP%YowBrf802(n0RR^S_ zb53m0>=^_lWav040UMAicl|?lGMVR>!f!>{N+jdYz-AqHHjf^<#XGHp`=VmleGZeS zR7-%diJKua$upSUO5s#W7u&*Uk_I)3&OC)XzP|n#$74;Klm6Y+$$L_ND z%L&_t%Zzi#uE3b1=Z3c%kS7G8iJ|MAtN~y7$3lgO;X{9g-MqASr@etjAhgygD9k&o zbFSjL`3~U+0=97UzW4rcUp%q-&Wfh$v>z@LCF2L&ukWZxm*Bz6NCdkqk$N(|pmS;Q zIX{>13wJG8rc4zUP%{KjLeSwrhhej`4mx8!@M1ARzT#Fxq^3Lpqn6_onLV}xe@ZPpx-1Jr&cp`INpU;YQe9}SMgBlyWT zHTr-r42a~pc>wKcpJx&AkmHQwirvlTC9$KZ?oPw(oTCt(MDd*s@_a|eoi;GD!Z>&e#4cCxQ ztt&Pgz{gtJm=&}%$j2)iPlpvg+)_{tJn*#_45^Yp#7mGA{>3`qpbKy?@jv%cvLwq> zY%Mgj%dAe7=B!jF;UC`nsBUsgnrqW9@tS`abEOFhM{DA6Z#tM- zOk?gK^E&EW6Ja8kuB;Hq+2f$%V+t_SO(M?R*=y7O6H{nANgEa_A#&llgo)%f3M;k@ z6cTTyl40CjW4Aw}C*>+(PA_@iiW=C_GKUWX^8^V)6}TH$0r7b3Egwdofi3(JIL*&rkWGv@2eXkB{U)FX%4(RHtu(HavzCx25Dqr6IrhoIBz^vaLZz4_+ z``D=8gxeGHh6dkWY{Q;)MOwMbak@rfB5^vhS{$TefntS=3GmF|l|Q-(G{<9d)rzVK zd4}FY{unk0k6rw{)tc`zzMm;gH{13H#&358K0)Cn>kp{M>r=Tud!*vs;tjdqf#aP- z6poh0lxPax6+h?U6jBq-hdvpM$9EHDdC1JZ^%mXAKI14eV*zHBOi{l5`ch|df?2*E&x&4Vh0p!;>rN`*x>7% zC4vQk>63A9FEUlUG+$h&&`yhjI-!w=b)p?`{>3{$L3tK^-Qe>1wTr2+o06&UWSOa(pewx&9 zr;vcd#@cjxGI~Y;18NrvMpG7)reweavofP`FZw7k0bUjP-b$zHcHZmh6mFU=18=J! zD(x_UuLZpaB{7DkN@t5?eShpPq8$3(yi{dNivt7En*7+iMgtZ63;@1B3Joae?c>+} zbR=?EsY z(Yv)dN|*E8+M+Q?oj};aJ!BDn{D^7aYLxM#LbZ;`;^9% z+L3^IK;$D0b8?X{*&HI_4PX;Ra2n;gKKTI);^1u768SmYCJIcO+#Wj=i)c2QtFb?# z^`;dvc9ZvkQvqccWW3^i8P770p6?1-wHk=?Xw-$cEH1%Hz7ZK`n|QFgb6DZ+EM>Bm z47(7DO(PV5Y@Bi6ZN*j<*+96B}7mH8yUJT^)nZZX36oGP|2U$yiU1`g~ zWf}e}_2yJxu51xu{5ZBl2*2rEX@^WkHmXjIGqQi3qpXFKN(Jk}-&anMI2$ z_cZK8hm>L^y|)ZWqad&ix``(&?@p?fSwSM^Iik}OFwPj9r!zDyAfN?mnQ$ev`L8Ydc zCJ`{a7}V^hyKdj3Fg72I?zuD4y%yvh?8+W&NKleE6n1g9hM?dRQIHH`*#G=&aqPWj zJ@}vAIEaxZpWXnFf=eE%_?GYq*)8M-&zded`V^1E zH{)i1Y%Z0#HLK#yrGX@W>u7zfk*PLX>!+|XHcAk1;}S$(vWUZMhixf)~6 zYt^1!K!<=AY7_b;(4mOo+On7~Zf>K`td#P4g>Q|C#_j*~i(EN4<1D!I-dQ1yF|3WC z?BEc}0cuoodd}boDy_%}YXgnF%YX0l_>LlfLJt&N4q!}z=9;@onz|@eXl<=Ji5m7a zrHB#>kxa}?lQGN|{a?%N8T{nLtNun^XXIzURy#f&vWf29G7nh24xHz3^xWqE3;uao z7OP9=i`19^+|fuR9cUWuNwR*EaQuAuTsTXppfo+|A?++t%HVQjh`EuD5%1Kz&X7kG zp5-ELDHymq%Ox|*(5KlWsr;w8ADFL9_{_j#leiN?2LWHVzvOxKyz|kRX6kAKIMF!~OAAN0cQn#AMc$Vx#vGX!-;@ zPh4=OZn05cZH;B9p|y%{{}`;mE$xy2jN(6xq2N7hho7?fbUsaMms@XB=>UZ-L@ols zq$0M!h*~7ESktBvsL?eCn{+mzugHb1TeUt2MxDBAYE^Ht!nM6b{7^;#jaeE843YGC z(uu4XQwy1R&X4?Y(UARKjc*?7<_tU1sQN0s;XqB?zFKz*R?I}4&vsL*PPKE;(C(=clmHSsu!_V^V(LiyFYWg^?zCKez zO#;%BL3W=kn=zTGR>%i7R95pB$tt>FI-Zjr%XNaeg;I`ad&_RKRX3>$GQtXt@Rz+9 zb%aYX0h96PJT_<3o2q*?SoNfTZn%A*wS~W&dWgt!5h) zM^-aKaLG&|sbO}*a^1P5`tNHfk^SeAfh5y$PQji%ktup}eE|*QUmmj8XR3Zj9b(M{ zbW0ZxwhY^*EQdwHbM%-v@$qj5|9%XEGk2|qZdPE|8)yHy%nD1WPgGa8WWV!RdVG!4 zaT~Vw@{A?+B}oPa8wyQ+3_cuA;}fk9)IbUstdHLg1*nF8hZ!6OSWo1TT=MB})2=t5 zm8i!bLn#F5nmfHP z=O4}6Rb+2^vir;e*t)h&kWntN?CrxxVSDx_*JPVw2#--(NLm8i1%IHWK?zu97==Jq z9N!~KOA#WbKvc|K@?a^;1jzoPaTBRf2b(x@Y6g)!A$chSU;LtW)4Mw4c^j)8md=!= zn0g_&-%JTDP#dfn_&cf;?u8>Y$(fMBsb~DZ)}H$cu8dC%_a<{(16WyF50fvwTNmzq zY=kRm&5~lQQ%l|bMG4^OcZ}t$2l#AlUam4Z48;!*apjZLR2;bnvuBS2<(q7d5}7Lx zdpYN^3rml8y&41w)XSIkE$Wfal=_gQ?^$r4J0Adn4+sDJq6<{2L-1?Jw*JLm^m0q5p3Tt^i*43OMaG;CNvKPiOXtX4vSB)s*>=M zHqh

57`!E#Ahe5<0+MZ3dWmGvw$LNsI>${Jp2&k(9rFB^h&__P7>J zC5{=O3j7h{45f^Vfg>CW=J{kO3DS{wu<(qaZxZTJ#*00(!887TQrrGv?LE|qN9_mQ zgZ@V8tJ(tr+AC7)?8;l$>tbDYsHU{AHsTOZaR+Z{=mAwoqw9B_#<5HeK(2*)SLP?* zx}2iTXwTuekO2a!zS{XI%{$jZu*YoR_~;piBQr3*Wd0-fw&#_gzjqG9zgSd}=FRlj zry+Y#{u%U168|3-5MenQp5r@7hb8-6)B-A7cUTaI(qIsrS*V5pgITG~$D4{!A0I(m z-E%6wC{B^gvYoeXPhua%byXu z8Z!b2AENY*UAhDd#+3e166f%^hHJd|d^l@Xn?cRTW>|ivZA>Q3_-~|%3qzja%~4hw z3E7#^*-4d#PMzR#bVn@Yd~?vhNv>8Q{*+_`BdrmWt;Cqt=XR2FG*HVoPXGW3ApxIpX%L?P08ft|z*LaCB-bv>%PDIh z-nZ0=HxNtK{b-Ow8UP)R^OfMOLBXbJ$c?A7Qx>scxLgLX%I%=eN2aFmXA?5e10IHK zVEl*|N>(N=!66N8M&>LW%Ac|_ol)wXx7%+={XzhbY}alrOy_E={f>J#c0`NTGzj3@ zG9aquKL>h;z=%QEj3FY)Zrngx@g*!rky12={DSols#qIoB#B>xAZCwX%Tba-a-{jM z$gr?0I+>669UhVIy#Ac@FKybHlC#9&C5z-Tc>p z6ccaYGzMjWzHJGDlMFB#(xJ0`7mu`CPk+s?nF^D>Y?+h2$VnX0p1tjZ6s~A`+HA~t zE$Je2D%F9;VVJ3aCd^4Jz*@?~$!sJa8-hoYoE}MfPL`PsgArZb9JOtYTz8@Tu@yDn zG|ldn!eq>vq1*h;5;Dhcwk5ueBdh=EJh3T7=DZ-+?smPw4h1(NuJFx|ktw;^EQ)Fw z*c6lxE(F-D!V4mw(PMEqEsHG_$*+2!;60)VBNx5&vThZQc^Ru(N*8gO73%Il4nZfV z?+#cj;24!*!c~}q6%~qx8@2qMxLQd%1>tBD$=+C@cs7#B!kLH#>Go;o`}_veZ`^7n z>uGSc;#rl(`cYXxRBZixFC-$WD)Ar36U{trPZx4P)OVyS-ozZPbz=MT*PN8YFkwG~ zB^!Y`jyI7)!-Q-1n!o?v2X!pp!aq?@5DsYvJ)rS%uGA8N?C>^Mh3aUE`2n&g+K+{S z7Shy+J!M<1c!opg$`klL7XN^M;x`a9LFj$GhtkA)=ha-m><(cWM%KY&R=;O0m~pcWD_}}5y=A$5 zej5ANADGr(l)9Tb*;|#rpaw*GF4AVho>gT#ozh2svNhmPn(@yU7(6683QoE{(hVWho3pQmrPql zT05Uw#=5+H)SP(eu`thrTmTl}aWjubgDiZRXrDE-Hcnnr6pl+jSGqn8>+}>NDa{fZ z<8#7qQ#Dc5s>TZZtW?X3?8U+vhysaCq9@X>Vn9{?CQNCDSZU=P9h}#mq%1U5jI^s% zdY_9YTJF&zFi{OD<=JG7>h?Va0EETKnLZe-)_)_X_o$I*kT;~7I%zw=Ozw*Y>BcRO zSK+>8xJ`x$l#)g%%pc(5iZY{!84HvOozV=jTO7XNWa@n>ql^32Ly(4`-+R?W8n2oN zXE%duGz#F3okTxZjONHjv$tU=Bk+z#zboob3Ecr}Okrwiu=QjKDKmp#A{v#ZLr5g2 zKi`k%j{o3z5cew^>L`~X9exth-F@<F@_`ZYO|pb#e9qNk1pW)5}J=}{2A-^)#_zw9t zy5OTtGv?ZZm6pM=pUh7C-wmGV2LAVrK59H}m$8)|dczfjgvuUR`a!3VpL(WhZGKM< z!SU_G6N9~0gi6eNu4G3SRKY3%`z+L1q9g3Fz5|Av8Y`?p!d}}ieMdms%}8>jb_CTj z6qM9-)XCADCKBAQ;AjU8iTQjp*hNAUQTq4e2@AfF8dCExzplJ(o|u_{m2PN9OXdya zDUe>GeU#X6UNbK7*r`3|zjrxNACA^N4V2o38=>!U_;YLmqfdJjJ4pfJsLig}bszJ6sB0m3k zepl*I-u*C<_H<>9XYv=*D=zww@YCGA;4XUWKK4?KQ+=!IdT!)%bfnqKAv{ik{rw!z zsi^8}?-puetVcMnexJXREwW0}ql9tUD5*_lP-!KbIxQ7ih#jItnAkJqFnm zPBA7GKc(f-$?D!F%oW_gdrPZ9ux!^QFrokVh*slOg78A3e};}vCNv-}!UiMZaCscX ziZT)8>i04)KwE(53F#cfQAu_`%`gMKFFDI&T%ME)?WjtKe4oLi|EKyXV9^=kp8TVi z?5>3EPHa1uN6-kpKlhNmy?}aGK7;yM9BNGdoUaV##SK^A<#MaaXYZTFH^BWOHd}}9TqX1vx<7EaD9eJ4Cp~Tp zuuE>Id-rd54(&Phv3oIsE8$mEd>28(do%DWs-Ic12}K3i8^3g4YUJChaVQr~xp^4+ ztg7kdxUw^L-wvc)DMrFI>uiL3y9}biA3%Qe4*uCX8oBJ6RX zPO~_3iRAP1o)?nBG@ydtck37-`(Nq;l-&UPgU@a?Dk7(%flvt>%poNAu>b%A00B$U z8pRkWyoy$UL>V{`IN+h$%5EUr4Ou2)+TIb8bR^002**IYrCjg%ec_w*lQV zgf7pY7z$V-Kn&nWxWIJVpwu5)#hjb>`~W%AM7(_Jpl_s zSH!a|5aeuI=$BxhDn4yD6>5QlH^OIrg@1If#&J;*5gj`9oC%Ocpt;yz5B^jmC?*yr zDxR?=#rwXyht%MMp#8E=%sDU$Wy|JHvf>Vrb&04C`PrVV1n z)-b#f3Ak~w6AYQjdEep!63zj3As1~v$GiN|qYdrOO3{I3z}dq zsv|l_e4>C8dKMmH0}?j55(DF4&cyVOn3CAw8)v;l^_|7gm*)prr9-HEt7c{``g zx}jD$f5eq8!AR&eP7&wKP(if$(cS}_as}JRGBiz^zDomK8S&o`c`CTv{Bg~5Ju)Bv z@VB}o!?jf)w=p_I9)c?x5>$q>Rg{A;Q_0LOPNGdkT$zD5s`{_7gVu7wa5)z%FZ$WQ ztCJ#!bJTgyh$RNj_`)2ZYUQT|-ssSJ6QzWd+`<49v%#dq7Bg0o@(rLt`+fp;;f_i0Z_hLi5It8#^&A0MpxFxROmgcc!Mb3m7P613zf5ROj2-p8D(RS*IDp z$4U0jhL;~KJ#@%#I$z0A4;*Mt=3LdS(@DL65bh6n2f#Fiu%>1B*$#Q&Q_v`Q%B;jm z7(SWfKeSZ=WX{YQChwKLwA?5Qwk!{1V(noZ>HwRf)S*zo)g3^dh1no(7l-B@lMsxqf_|c_sKd=Q_&G@~aMU0QBKxmvr6Cb`4k>||ayQjT3s$8KP#39H*RWCvoGv`t!JhAB zslqbr^%{?Ii8K4FE&XIJ-#gvB$7S_b9{F4SpqhOWHkB2Fr|Vr)k?E6zAklT_)G}%f zKHLi;2(!aDot_ERUyp{EhUyRUE zgHRqzEd+ni+8$wsPhUTAX*zcBwjatqsS~`a;vOjWOT)^l?s<$a6J66)t*nD#5 zk*umss-Z{J=p^{WL_8;Ln_P7e^#No3TD!FL3pu~*b`UEYN)yL*Tu`Rs#HcK2tlUZw zSnchz0s3jmesK87!w=w=M^G1Dx zTH?>utNfK@W zl-~JtB}~3+Kyl6@p9qsh7~C(;AV4!>LTwItn6jkVO{tcc)CWGRUmLxqUz<^|9uiIH z%?k&~Nw2=Rb*qV*Ff~RIbWJ&A7H_Q7KVa7D$O#SZ!3=8%0X}r`1SFB;xSS5T`u%5e zEV6$)D0GQY9s}@WFQ9k+3LSZIxC2Ry7VY+~q`yE&Xa1d-EgNEYdHi&yN!lpp98@Jf zR}#SV9%s&+pmsX=*E@Mx8Ume*R3qflT!*1q5aa*2O9q4OxbO-oCjS>!;7e+4|ve) zhXRbJk?%3t>4u8#9T+p7R~Hp^FK$u)`j6obwSt9HTj6*VL`glh+!H1Q{fTPZJ4}P* zvapVo0ujQ_xtALEGwZ>mDtIjs?MKj%{3TrlbQt?^i>Dx~e^YfhOzZFKY~*RaIw%){ zZv*xH|sBf`0;(uByC5@9IS<^Idad778?&A z6k5=M$-|BUA13OUEp5)#B;QY&Tn|3~0mr3W{q0N|daj8rNVjeZRmM@dNTmT-@?xpS z3~mHrpS2i_Q|noRF`be7Pulxw5!|ZDpFjlmJNlVo9gzrwH%|buWv4H@CZy5(ob>Pu z&;f9$bzP(*nQE9r3YCeVoCAT8YHUIF{I&PFGV4FHDt|kmddXTD96Ze>zg@yealY0Zf9&&Y(5VXf^EQp-;o>>enkxdf<)hw*V9{f<93^qG&-pzU zkF{4fw-;LtEx67Y(3k$rp&h{Dxtrl|vRTXH<)5kfG#%Vuj?VaVEpeOD-{5E!A(K6_ z024p%O8-aY{)5D91%_ddthOu^)kB>(QESg4SgU&E7ZMdDqX^wyLF@%_7}I?ovDKPnBhC6tq(fIQM<1xM7g(BeH*VQ-MBnub7^_fG~Pak2EGY<>w9a zd3Vbvd}Kd#>fRZEdUI8^@7eh}8bwvs#%HxJ?Cz~)MkH@ItuhGE9G*fpvg$QUd?Pf| zQ9N;2JnA?b-Gs9VH6}hxd_nczHWt_Zy)_1>LL8R&ax6bkG!9sSJ+tJ>YjOV4Btrk& zm3O3lx`B3T)5D&b6h?PPC6d z^vYhib^ufc0qgIN#&s-JHbVjxWoRN{)~c=4Py<&L&Dzz~w`HiZJ*;&eMjn!D)AFqi zJhR7(Zn}mh97E+;*QC_yDuggm6x52e(8n-dse`ug#!lo57PwN! zI7iyw52D}uR8ew~%?DPveFbeVPKhC#j8St+C2SJ$eS@;uyIFC%<>dljP+#B_;gs-SMsm z+Vj-yveX2ooj-i;;K(u!fZhK3e_u@MI)t;i`sqnTcJEw9`E$oA+g)--@RF;Q&GJ1j z4G~56llj6f7%1z9B51b3MXF<^_uTLb^Z7IsV(GF!+t&iCZwvhE6u53C)1z=z_*sWZ zZZ`EKU;luG;z5}|y@m9MU%(Y}JG5@uKEoGvZ6m70AC~#w->UB{aAx^beAR02%eq7P z>rbIkP2ac6P{+hYZURbN$-W`9@$vOKY5N+b{353FT3J(PP>f3tU{Gae5DBD@3PA)i z+h*oP_FGF??qrd%U!ApGCP?=+d7C?04E-6 z&FIsE4->2cOkNsV8fz`+?lHpuUps8rX?ND`hv!-QBG%!b2WHTL>&WG^_~P6i#zJt8 zLe$5{H0sVNWD;_5+mWbk0Ml+$V4*KckICXfyy==x$|L5RpBn0-(@z6@Ga3d6-QgEl z4GPYJ>1%h;wmg@O^u|89pZ3?|M_;T}SDiM_3<+gOhw(Rkm-_@Z^4EX@s>YDOI|Z^j zNS_vFHAEQ`mqSX)3l^1>v$=wYQh=M5QoG6yQ+yYTe%k^-LQ|B=gR1Miq=I^BE!*6h zrJ<=1^Vp!6{G{=g`byER?XK@EARnyJ?H?`ow`4V&!nRuM0EcfjnhvkdA>EJlX~H*g zqVQG>t{&=ab`ywlQLG2ntb3$qB$1C&1;;&<{pZ#4FT3gPO#qkcC`#F5eh#_RJ8Jkz z|1*L(FNlif@$ol5`+JXUXv?^uOv#y%5k=a5(B3ZXit;#pw~V^517A^`gwUo`DdyEl z60247A)=mtxwvk_2{L_B7O@l!+vLPKAW^_HK()nCO5d(JG78SKHr}5nM8vc0ZWa3x z4An(BZ;%LeQH4>y1#h|3M`CpVCmAwyTepA;{+YSHxL#n5i2sWB?Ei-rJ*RD&LOJJF z>Ffz95fC-O#_y3^i(gj96KDC`HDUF!gv&}9t7wWQ-XMszx8QgEZ9Jh`Q`~ag#p~O0 ztEIL#b}TG2XTs0pz-KmLw^A$ddU&-&Fqr!vn40V^d<*TR=XW7r(VZ8voD-t(6w?I~ z>-@B_&l?XT18o+1MZSv407t-^{OvAWDyz?vJqy?X7l0hNwQR?KoYSO#OAzetarLdu zDmX6^u#?;(?K`GwT^k#WKF&j3X4PnH9by?rNkZyy0#)oLF76<->cS1f1Mcq{`TZy5 z=Y9upu;t)dd7@@1siEH7D!4$i!wi+xB|TX_F=2&492j0C4Oy&*B1B1B+t$!xaFk5& zeKPF%c*QT%`cw~$ZIzwt0HzF3Pj^;y)pCKyN6)zl0cKEs0;#g5+!Rubbd$lP3%M>H z2MOVsj-eT?w7B5JB=de0x+tz3IPianRw0Cu-N`8@=dluV=x$fk`wKJe;R}=fZl~KR zg#<;z^pEZ1ld-KH=ph?JK*~&pu!0yN#Ups-1XjiE5Fv>2hT}hzODVCB4VR5y2fcWG zEGgcTeKo1h31YXaQ%(N>4cy3j5`270#;kZ;kTmbL7 zf2+UW#5_3^8q}4fW$*}IWKZT2_ruc+!^lF18?A4e{#(Kfrs9V>P91`jTBD!^8v4p~(GHsBfS?N#ZWL>aFD#45wVz8N zDUjbMT-m~vOL)^`qc%CX3e1MaU0j45jiRajETF>7aT0`O{PZx$U1N;`!U}_f3W2HexOfrX`Lq%AfMZ2r~P7g4RpWW`bGYb=|XMBl5 z8IrGON_DDct}XWVU5`0CLgePb8zaBArS#H&bs$|Vm@ecSRHl@NWINDZCD|QrEHz4E zZ{>2s(x-stlO0pbA-@aZUvG5xsx0P4{rIUq^09GMoFmE&{DO=pSX=!t@A&41Y0E^S zXsimJx-!Zh*dJ#JhvGu_Em}}p4^=KFiOT1I{4};@3YAd+>30Vf3W@2w!*>xF%}FVh zsZ=YW-p4jLyyoBkxw7;*HORIoC(=t6%HPj`tI}_iDmBq`Ikv%#QfhlphDSht)B>6f zVF)5C-BxOeP05aFJ9$^B@pmwTP9GRrCP0W0DvD9_&ffk4H!T%A?CUXCuUgd*X)BW> zN-Z*bY9+-J>hv;_d1|fe#K{Ie9h`EoEUxqTkK_0vXC7H2e^2nQ>E>Om7XOAZF z{ruD>39KD_fo=7)>e2Ha4Che^%$5H5&}vv431e3w4GC!0D69IqCgC}l>Mr!e0*QLb zg`S)XF2_U4LhIaDu+v5nO*L8Rv>ZL2hI2`zuuQo&6?jehOnY`U+cjW4sCjAnz;l~! zI2q*?=dmrz$Q0)FB1C$BRTW!BRHoVjq;fKd@N30*nH#-2R#ot|meoL46m7Jd)ZikR zsx-9XHBb_4%O{}K!)@QMPwCljp;m!D%Nmr~5YAG}cB@~-_wl^*YAS>UsBKmfJA zZTEX==0hKRQF&}Ky!3z^;Ds}`oVyEM5S@OhtK;w++71@7Y1BXbDrl(P_-3-BPkfBx<^=3TtRt!rEap$(_G>-XiwqrE>;? zBo}ZgPSY&1f-nSD`YXzHiY$?cU zc3FMd#Fykbi4v>w9xYZS%=x^)o6-z79g8b*tGjkrKf!D6_=;ZJF(WEAR8j3LqB;9d zLVZaPxPV;MH67Rlx&q@E7)x%2=30Zpp5513<)nrYbvslnTed~Rkf7artI=P6(0&+2 zJK6^F_iK!{^6 z#D9m%O6x?tr0~T;OdYW`JIjHnF%>DHPNz>VJYD~q@D%XD<%imIr`06vO(A2n)QD&Y z6G;(_(yG1P=CTqNrR@W;KmY8->^hh4X zX`i-596tZ04)~s);xm+*qp_@2y>xYex1XH2-cDQSIZla(&sHHaHj2D}0&tblokwn4 z#u+1zHY)E&e0~{jj-?}?5uOdF;5)ea=|Ic7^*vyH{ESM!w_zYc_?I`WA?jJ639JZ9 zXX|6ObiB{R@nt}%G`SmxrhRMJ_|sL{nk_qFYDuw%abL5-lz*GJdS{Io1rbn!;%>!Z zN!N9SlP2iCwQS%dE@n6#qa`V9bijLdAdFyBdY1Mk@ho^mibIf1gOyh2<|TpY#DJ@F zl!0sE{FD*Le}iJBgtWdR$sdd5yR3!Qiv2JOAeU42-@^?*^Yme@*dvDS+RRljw#b@N z9cAlhcCWCAo*~(bES*EyK#|>8^U2Gsk_I7Ig{H^@*h=S*mDaLdYZdd?c2+cy#uB=3 ziMnhYr8@R?!hiH8ad7EE8_Hr~0f@HG{BTcWNvN;I1djK%zk*;c`2-!9C$<~~T-pp@ zjHpy*b1$_QGysds^#6K^!%$qq|+9(p|3&}gee!|N4fzQD*UP~)GT~-bX)4d zUEigwTeC!N|NFe!-tbGZPo;0;)+#x4C1Kae$UAZ(?7ucbv7RraDO*Nlq~>WRyu2r_rT zq+`C8NB&1%ybY)iVR{m8*vzirqIzH7H+>mm5e3FNzmd`$V=EAp(t;7i;Ax0*WBMz# z{{b5CSbvQJ@VL=M9`Xd)U1u>?=5uC(Pw{TLi$CaL@AK6cG|tpt*Z1YO9&21Lq>3Eo zjCmJx^4FUBx3b1Y*k%mKI}o~kx+?&9;)5qE zlEAsPrvH}=om3i6lsPRvh`1@7{BW}`s>?W_OUr#_&`}qM8h$(bjOM61^`yO4Fld-k zUWy^{Q@Exn^e;mFeelJ%oGgtEc$xuj#K9q+aQ}f!$Q3G;FLma2SRM)ZuZ;pFj?|ET zf?o*J%@P}4%ZEAkQUEpTF^P6ussf^Sd#&v!DqXS-!2fgDn{&Kg4I^R}@!+6WiakuT z1QcMcpi8P0GB#1@luBjXIaty*BTKSwT~8tERLp2ceRBL*ZIigS*AIgTc6xPb)5iVn z5kJ=K>rXUa_baK41e0fC1EypZ$thO<4}N; zl8P)2GERuys%-%6d1Ec$wQjcVvo)9LWQU;=uI7VBsWA%HJ){}ZsAe^}m<}#M$qgkR zWWHx!P}!@h;Dj&_ptVTZO!39Jdxd&CI6F_m{BWE3p~M>uri!>(|`a+|!?M{2~Fr&e+uN6;ol6{b7K;Lu<3iM!oK)X@>l~!(4s| zOMwxCV5}E#2vA_%hMxDiwmQW0BBf3B8ajirN@}0^c!w+pV+^eyM5lO+m=ETVaz9{DX5GVUSd)Oh=g>{coFf3|{2UchmWM_oxv#~{XN6>;38{EWf8_VlyRl!1J{X3ey}!t$*~GtVdvHjwy5dZ*7UNqquu%|MqipK=X zQT#q7Ma}=?a?Rj*ou1Gs3AebHe-ti?(k~(&2dHXPv&p;-wLgvTVn)zd!KXRGC^mv| zGhc1cUK1pqwj);1a!iz&=WwO1vVCqY=x!|(l}u5S*NaaaRN^)aB)ICBu$RXz@v1Fa zfnOwQfH1$==g+m%F)q9yUW6O{6A5#=EOm8v-PIMuJ$NHj`XKpd+(WF&!uitpTO-<7 z*t0Pik0Q(>tG}F-drF?}aN^nPU&s7tNWyNY zBi(k(p}ofR#6%uLQy*)A+CMLEu@&Kt54)E(jFQ9T(8?*wI9^Eu+vrmL(M}N|6BI*9 z+T}~^Z}dAo1b9rDAYwtJMftp>k;4l;OWu!f(=-^h&}}Lh%Y+Iv*ZTBcu=x7+#~>^W zc-*882}}H=YiTqlv%`==JIn__I9(}gf+FYeC!9~@l>NB4>x+YHtQJoETrh8(&uk8W z84Cu}!qU~t@kCS_gIsikqzU_Mz@k#;W=C|_TmKT+OG&R(N9!RzQ;{B*;*+3G2_V4k zV_dAe*BW;w5eWJejv3gWn@?mAlyjCi3NypiKnomSL&l@sv{CB)=x37P#vj_C3f%PR z#k?QJ`i1SMurOP7;qh&92k_?G>WY&xT(mE}@hnA|_9`Xd*HhFd&xg-eiK|h{eB6PY z_|sx)x2rUzV7}WZbA@Aj&P~aELxWpx5R+`0(`6koKq=PZR=}L`KjSyP7J<&^V~4@+ zmI_yn%@SqFuBVn*9SL^@mpYlggD)~kxY5T)xqKx4d9-N$?u9omlL@> z%o`q%iHCel3X6f?T_o=&bpj&Pl`v+K*%(HU12DOE3U~}@WN`NT#l|t+nG2P+s$S7&b2Q$XTg(J`r}Wf13GMFlYdWgROu5WUvOH`uSNjk1$v8 z-hzu~!b3N#n&yX_Yg?-}Kn-v4o+<4A6063*gzu%4bXxfvesI53^P z8s{lahNKxS^O`C_ZS~rh&Gdbtv1Bpd79U#~fkeu(^p3TQ+@xkT6(;!jC_q21tSNSylfXyQ z;{(bcBTG$lj={V%ZQw)I%RkaF-0@vR)AlSL(s&Z!~KXv2UXkD>~9NzGTwzRp;e>CUn7g zlD)kooG7}C&&(oeGAHT}69KyNO-QiY?*Kt~htD&oM&71rIAuQSx000S+L7$dn zltf%B{{R3#idI+yNbHv%aCpK#0C6a_=(uweIG=05NAFe`5T;Xi(EsGU@I&R6Z&YAk zP-+ZJ0pO5U3igqIudkbvm~Q6nWqb`_LeUsM@JI^DCzY7S2+jDWo@B3;#TN&B&hcByB~KH z`IWiPl)i+Q$zfm(>DMIIxLvJxGqm_`8N679itUQaiv(w>*m614_TwLF)-Jb-HV;6K zLsE!lOt}IjkP<41^({u`6P)>~_BzTxSOtDP7C>&=fL!xa5e2INEWy+us4Cewg_`F8 z7?$IEN)sC>+hl&g{`>E)<&GpxQBmx+T&y8AYAptnfo{(^;H$VRiOSQLF83rMowc+y z=lf+;5Bn89VfQFGyA z22_l=k5Y+em`uT3NDZxbGVD;fR9Db7X*gDZ6tt`)b1&(5uVncIfSHeC%qY~QD43PmIs55G-5^2a1H#{-3>@+3` zMS{V{qi(s(fs53oL`N%~kc$yp{2V^^X=*AjI@AWF*|`;(Wz5Uc z6WQf|5-lYjP);c{6zO1E_tAgrz~>^=W=?Kx#kFefd01~!JmyR016IN=-Yfp!5J8p( z19E~*YkQ)B@b|+L8N`RkrpboyxOs`BT3W8aea^G`p|A9!jjim*fKjnj>IsG7)jliD zq!9bU%iQhJ)7a<#G*v#85RjTgaEJmd8dsE~w6YLv1uT@&v&idrfg2tc*D26>TnTUe z%G0wc7Ftb)z`?ir1679^Uk^a(>0`44JH?DT4>S#?p-wqD^Ik=WH($Vdui<^Hna*u> z-&MDC30$(=Y?gX29?~wLWEg0vU*p!Lu`~3(o>)Yr21rkaY4rzwy8@o0C?nWeqL#k} zRN`WXcs&h`GdmZIK67^y^*S7M#0Pl0Es|1 zme;4D=tWpRCv}_?r4*v>^V&*1f|9{2G`PSqOVP*J0}`1-fzn2E4#z)R`ojVO1_hqc z(ZQ|g7y3yYD52CqE6l}#o~$&o@7gQtfbGm3M2d}KRC<*VMLoEwhhVb+&sK)bvAP}U z=N7=yw$&;MDl+f2EaT24@@}yOJm=@EQuhYdx`kgjh*Le~RpUfGxOp$sj12sNiZ}fN zsKv=CTU6eN${|&8JH54_tVj8x4XtDhYB4No{x36}C19IptA=8EbJQnU@0)`@00N7& z%F%ccyD%h2x{Mg5=v3GNJVg0i5Rnm%`3&X8W}Tu1yWvsX5HDalO|6uFATkPZN$mNI zSsK`XJU>um(tYS5^#FrZn1E>G+_5i7f6AhtzG$%&+6+!?$T*%7CsPpnq5d}W@I}}@ zQ>4$ovweufE<=M_AnR;EUU$L8?LFKjeE1UJ zL@VhHZA+(j5DIUS?qKK#AcDiLuuu0A!Sik9l!a(s>f57xKf0!~c)n5j71r)wnXqq& z)TUQ0_Lw4Z$xf8z8# z2abcK?Z#HBz#pdXr8%EXk4gt(9u4uEYcua3k}&R-3&S~=Fsc>v3ur?%jE|dBsHZsW zx=5(Ztd5?`c{=+~<70h#GoG0gMUBv*<;7_kU;}1Jj)O30(M@xWKTLC%xfyXJ(z#}X zNakGyVjH`Y`SVC^#Lbb*nydVAE&X%uGkCfz&mfD(XTj5uJHm3R$eq&Tj3m?-JlR{g z$rB6Dj#q!QnuwJiCOLihik3ltq7c932ZN_hMoOSPNQ;HGWY`h+qb-&Cpq4{UiE_ei zbw{2`v|c7^w|1Z8MUCJlA>#_5OSk%@rJPKyGVV69nD#dy(`B)s0Ji*9O-}H>iJAvA zr&ebgj3Rg7cu`k=NJ;)KtXYRPUM64En~>5p4Gb$VQVouR$Cdt;jTR><%J-?^6hNIj zaDzw|XuqtHUCt=@ncsw;MBecZP@*6>?u_S3q1b*e*QL?!`nY@?u<8|^RWcTrLirh# zx=drdEvNZBrD#QyD3l}#-AbT47wOhoL}R&d#dKV07&jGgC^oYnryygi10U=E`Xzdw z4x@CLQZEiCi&A#fv0O`@ngA_Z90Sf&$I>n|`aQNPUbIfzxM{DnPIBmZoVCrnIp;JE^?Dkzm!RS-~T&>WX29wpE~4QvVkDZ;KHYAY)%Kl({j+#HfO zQ=Oq&&neefJ{31pAf>dzi^N9;?j@J1X$H_y~4Ip?g&#;NH*1+hLFTH-n zqvzsGUPI*1zk;P&zYGBPWut$4N6BI|z7z^v8^h*+tu^l9MIrXKtstM@j7v{BMmtm( zSyLFmytuRYsT1EU37i~IGY!b#e%x|v>O{7BX_xt3D?7fkeuJkWpHu}a!!hqQkFMe~ zgKSEB>lu6b=Brbj%LMzknci>iG#6~)N7=qLd~p+<72e@i$!6M!=V3@*Yw0^tqnkhU4E@NN*hOa(?r9|7YEDdnN& zCnhPYEXekob6CjwP_Ha002*q9boP7Uezu-`iMR!E`MTfRVk29RnCaG056$=Lc^w~#DfsS zZJ+M?YgQ34gSpx;VJeBsOUxrTwry9H87B)q0ZBdxCp-vYGc2X}9McN}e>l7-)s0;~ zM>94{mu5*86EZv)+9mQqj6VV)to^< zLP~fOk59N~FVL0Juc6yNa2W1$W11;q_i{S?_BL8t2B=aukJ&ay;!-D7bCB-PFy? zp?!Ls5!{jDNGjDVg<8;+*8yo7&DaXyKp1tz0%+==S!i{9`_P$C(i@jN90k%ilc zy+mHWaQifrr%(dD@F_b`r-!!!S1rmhO}(_9f>;CM4u9H7$9`j!_GQ}qdX?CX;PP05u9`+$^-9<<}f#Ywypkr$K)Y0cb6}``*dA%JK@AW zNQifDbkE8wsXHSDb7#J{MOwF6<@{DHU^(<=&e^p8dW#)>HT;iZWP-dkCMiV*Q5MtW za|@dt%o2j*Luz|JdWIeI3rK7Paoy@&_P~+O53cjl4udkepPnxj)d$(tQ~*$V<1`QZkR1tUb>I^JNG@0#c(%hpF}W<}y}s9JPSrsYkw5JA>~Zv06lyz@)A z(Gdh+R^@$JwzuOvya@q8;CIuhjjp*dy=J_S9fGW4=GvBvk!{7*scgI4?BYP)d$L;Q!jC zYarbTOYpD)Ej%VtFZrtoCu5C@Y1o9CXRRni2IH>EcIoFz>InS1VT4176p*?dFK2q1 zxEE0bFlV7)#k_3MqyCV_5>a+CSJypGJ;=w(r5qCcX!p9+%+3^4!upBU!ln#w{7@E5 zI(s+!o*5t#TU}DQWc&}Ssw>Dlh92H_N~#Hox>gp`R>xHi&>sz&>LWz|x;fu$Z->rM zQwUQy8k)^h+Ai3ubVS;SZD_nb6K?(tTdv&#PVBw$|8SBqqc#{o@j7Ga?Dc{mz=e_mG zOF8BB94Y@xcky7@DHzNiEOoI$9215`LtN3b)4|cq9<@?|9}j^(UOH2P0#XSMEvUW% zYRX{X=cB$LF$?R^Ezz$;K!-}(RE&$_@jN5Jv8&_QPG$wui$22gtQOj!gXeJsd(cQ; zzs(l$Sza!PV%JzkxQF|_S3m#&8O{HIYRxyCc{t>0FffTF_U{OYu=L#9k;7tEW3!&yeGZ$Xa9 zv0c-C6GC-);H5KM8Y67tPp--?%g5FqO{zF^_1k%V29#PmWme64LtEw&Gu&KL{%g;Taq# zUe@AD?XV5KJ_faH*g@cM0@xyWV^8;2g=O&qoa!afz=3>2({TLybhV{pkSw1%@*2-o z17BkR@nJA#b5g)2sXJd*Q3*bb?D3;XvqZZq+Kx;2V82Po0Peicov;pkuFU7VU4nIM7bg&-?}A2M|$@EhY|S5LS^2cFbe` zp%w3@VBJ<*F6Ki4wZq8`lw}>k`N56?w*M|b1abHc*r&10o5K)jVo%@Le7C)_58w#i zTWqbuHC(A;YT3ilx`4cpR+d}zhy=$a>ZPwh=yUf77*#~3n=ffAI3sV~g9t&<_D*CL zfM}$8cSwv@n<8xJtkQmXrK_{!iM!KE3l2B%84H&A2I}su=Hqh!MuK|ZK{T1p;&K3e zskjYbZDa`wU+V@|)2D%M5SL|v>qVEo|3}F_9N4n&5XA;v>8uX}qAX)eWQE8hs#Tu& zkD_ZT&z^W)0|&k2YHnfRj<{NJcitF;7{zflD)H zf3R^V+2!$Cq`2uoioCgBb2eO$;%ej*-X-+q;KJ>rzh&xwwBc`g{Fp{1e4TM04NK;% zTd%8ReGl#k;G6$Y@nxCXW>Vn1lcrZ(MvSM)cwDR@dxgDwjs$UfIO6yz$`6-^Z^zdCpaG+++jpQMdEnx77 zFPC?%)Q~icqS(6x&2e5ReRuIFTNowVpQnyg3LBi?58sl?ku-ce9kA|6^3r4VexB3||~*dUuo${N=x>AjP1ZDGoYcTQ6oIkGb;G`69sj*=&jU*b==nsued9Pr8%`d|dsqP*RZIKbS z2PtgD%tYWV53@f~q|dz@K8_&K&2b~vg1zD3NBWJLe~7-~VAyfp|dsWO-ZH~;>sRR91E zIiPm0=`lQ$31h}bTH82!uz&!U%S>3bA9fnr=pt}%qnv-^7~|Sj`O^~pL!0ZnW;Xa0`(aE!WzSwIS+euuh?P+V(*x5Iz1lEaIdt&b^2KcJ2QVQfmDQ86^ zuu}7*zzM9sZnG*GL?@~JL{$E@OvFI*(OdGV0OGMe?UF}b8Q-;n2n|aBQ13)qd;AAM zf#PKtuQzMLUt|dP+gKu$o_;DC|6XB#C@<7K7F%gj?kxPjx2ZMQ^NZHYJ2BdR?*DK>?=dBFfej%>((_333 zj9((L5l;PTqVXfj|9qIn2*m#}sZ(z)NmBLHCgB+z_$BHiH<$j9{MIyJm~ZZjM0^lE z9-BxNA8l`>Al3J6=n=b+H|Dj=m+F?upn;`R=#hogOQ;iWlmL2F{F*i(75L?=EtWZo z!=fni?fHM+|Lk=Uc=DGVKFf0#zA?d5d*L;jkqBF#%eQ9``kp9V{U$1@oAy*{C+*;e z#18elrFD7Z&9VBG&5r8mv!ZEW(EW&}-cQ&rw*(~>1LiR^;2rlu;1&O4Z%{ZR`q)}k zk>3Qd3O+(n$hZ3&SCaJcht38`{+z>fEn38WRkTur;wEa>MWfNgGQQZ|CVFw!MoThjYKvr zpn_;=%mrcFWa{5y$Q=zxQL1ysBWrp#Ad%LV}A3YOzzATUy9aWx+ zrr=iESiAPhuGO`|Q@-hTYl^6MSv#p>>cMbFBJP8l*zFn<66@dBiXXK`Nvu~=&WK!C zr3|^hr=P^~iZfLVq&2Y%9PJBVOTgm?52*ksjf0$9YTs=*7sq>Jb6}Uz(!|LwQoQg( zXY^eV7$g29-cO!Tq$dT9_5UTIsP=M%hpx|^*8Ckskr_RVB0$R42ST3QtogncNR7SF##1Cq?W z5$Z^%r3bSEcdA2$(1(Da@ERZb2F#s8!jR_y6_w3w%qqUikys(DRZ4jr?YDbd{jscD zxLJC++cgGVJVrC`e8n=|XvYf|?GeaN%X9f!M{Eq(Z}se6WMxO#1d;H7NkBIOfMiiC z=)o6dyhN*joRem`B6-op)X-tr@a6#_@zb)t@lL>qqAv>sNM_w)Gc?;PiXad^K1008 zf2?)&O=s8cr(2`$9hbABM)&TaVrxF*KPI)abIm@}K&V)}^1i3qQWFx%@Q@~LS~V{3 z@}!NCDu^{xz!+2wf|4)|Cb~jZ(xjZe&6Dl14>tqCfE|AmUC3n`*&AN>$vCtS#8~*y zIhf86<#*P#w|3div5i>!LwH1uWwkqDS>pQ|X#BX=!4l8}`rE>f4?KG~EK))3n=i;L zZPDGOXK`r-ydcX$%KJxf$(pb<_y0s}88SY%;$$N}o}9QNmiHnA=@C zCih$J%V0q3&O9nL#tR4CDlNJ!<*`5_aD7%;P;85)DK#~GW5G|02LAjYyPmin^fKmZMRY@a#Eq3x37QH{ukC%|&6m2P4I^iFsM` zfJcPhpsyC0VHssI9LcKFOp_QiDBtN+IBjy#s|KdvC}Dp!e|W)J9JWK4I~0Fj#L%Gc zXPHJ~@JIm5Mt>78(2afd(;?Wt3gIa##O*)+>9VLV3wg%=Xt)56qojHu)_uD1u;>dA z+d7Bxw7HPgWIm+uj4M9(#m*WC_2syo9hJiMm>_}#cFlk^`t~Fdfz?7+)hKF92x|}B z{i^Q^CZJBRQ7EOO^E2*#WXsJO&Rr_pfcE!ZXpF(h;B34HwK6x`j~^TB+VxM<_#UgB z)6|+!mrB5IQc7HRA)Hf%k7@9Zg*sdgSY5!HEHZ7@mMH}L)RVY29~NfRAksR5iDN=I zy;t{vgdG2GCZ5{8C1RRw#Zc_RJ}8-85*6C4UMHnRiowgB8o?y4PFPDZrztj_te}%^D%c zz}lgp*(t>GIz*4>gT7VseZI}en}!rjcLAh)$lt205LlR}PCwyXA8!xURt!=c9T$53 z`(z#qKFFv1YaJ@3d}QBNkZ@(CP+$xj5AGoXg72h!%ktHP7v{uTbEtxXv_uLnU#J-G zZ>TM&-wrm|Y>PQ`TJkN(xbP#=Dk6)Y`l@`!`-h9q{O>Y5NTTxZf#(P_D$$8;8lgX^ z>sudGH4&f{t5wx}nHrhpWrozdZT+=KNgF{$fY;Tv3=`fyyzdH3v@V$;f#EW!_%AQOkaRDO^zvR}8JEe#79~^|kGVu6!DMWljnc8V*G#++7k%M+?)uMNd_~?uO-5 z!4_kksionWJ8(1BiDY034u>3SF=*za*xv2}4ihVlvuibvnhI-+KYc#>X0yo<2!at3 zaYzF!so5_F-X7kXEq3x;d)%Z5hqCjno}eE2&i1T$owGf8OhXk-#HmmxdpeNh` z28xu{rs^<7T%F^VAW(Bf+qP}nwr$(CZFAbTZQItgZQJh7tS`xrq0-CJx0INdhvHgKeiq0k!CG_vMg*~_W8aT`K zvTR1$RB8W{FD2=(@o*v2bd^42eP5Pq!~7@%&1)Z*yq+8e&&-Wt!R#kWm`<>eeSM&4 zB&R_F!MSq~x3Ss&?tAsXvwSIp^GbjkD*+M!d-QI?e<1srJsSYF@&jwD%XI$`h>Cwd zo^*PHiUeWO+)lirAv*j-cyFpR5Ssb(CH&#Jek^l*RK2Dq{Bd7)USLNY!;~l;!}0Pb zvkA6I&iRu0Sy6`V!&!x>aAY9=e8))79j>8oO>tIKRNbIEHuF7Z>lg(ToS)gzbwH3h zBEHRN(pw8lIxbi;=Gu)t@lv-f#>`x>#kw$GL^DehdICe95o1W%Qd51&^iqlNlR6ps zO5rGg&TW1401Z>b53yNhxA>!2ZhlzprF%pH7$bbgr~?1gbQN`B(QW`NKlg~!G|r1*SUg$+auv~xuww3& zW)j0JmWR84(2OP{OGj^H5;7i$U_b^ukbs|mrl|uBCi?7QE|=!7 zJo7~DTznAUv?(F!>}_Z8$=Zcno(RNVHiga}NLf-WH%wAKgdJr>cF7C-NWhQ%5!m_0 zV@Vurdw_Sv)>x{OaP;HY|5x0l_BNA* z)LVChte>G;rH2r5Z_^*+gjzWVjsW-sl=aj2gj9T7Xx0^1(7XnL3#VioUANcl3`)b1 zM@kb08Q_A@LXJ@eWN28K_$uBBMJ=+5W^}ecYi-o#{x#K?&TYVT6R;M>(OLw#{|LK9 zQp91|dyFt892#bp)=+-9{&IXWrk5Y-)H$99Gc9C9yoSJw&ljJi?G=o4RZr5ZbV>c# zFg!aw&Uh<=KP&6d4gEUbEE2*kphtwO0lP*XgfG>^>SRA_xP=6(5p+$_m> zvgCI!@H7nckLn3Stz-IZ{Cgh3-`HAtoy0;AN$NZcJ&KEApZGvTxuh`c7dXO5WqXtl zfa4>b(e=?8!ESnw!R_-*YYW`9XM|-swu7z+`iNh19uz)-X(E%8Jo2H(^;V(1qTGa6 zr`&C41e|N^fE#92-dA|bu#R=Kr}UMBoD9F`z`$;d{F?o;fMuO3S0+)BMGX&Pv$0f`6S!>UU#`|c1tG<)p%{Eye zyyqtX$tdOaa+_|0%+r?A+h$IeE8X+rsEnSn<2rzosuWJ&)67jIDi=%1OX%>ywwR#8 zfrfiXuY*tfen?y@jXrYv*2i&L+U4<=4B2;k zEe^?NaaVomXp}lj63!vCY1i{TN1YnRIc*T02#zb2D_(h`otx>$m?3q3?+FOqtJJrV z&|~m{h}!ozOi|k;g#%eEA^6kowKBjIo0`kYm|B%=+wqoxE~VKsa-@2z8L5oDiN(J$ zc~0Z1kdMP9d7U|o3EabcpP(LMxqh1kcoaa1(J%<&%Lv_~NB0-Yg)dMhHfHzscDEit zA0A%8#IJ~cS6xiRn$^gz*T%v6MI$awdtsT!_$lHCS7yH~is5}{SY}c58Y; z)^d>}2yxZ+@KsKPa94_C>GO->cj-iA5^%JY%mcmxy zrHTv<2W{me?u(zFN$lL@$DkiGL0NwIenu91nh<8eo6nF|y<~kH=-sv?F)fwo+7E!G zMxrF^&GR4{r7k}$iApe$nt5{U4ucT^re(QL@hMr(idr@U?<0eBgz`Ypl**)l zE_uzo=@kPO&j z@2O3u#vOTEZrsRo`==MRfQ8;kC~(-IZD|{pRPKtW@lE$CYcTLezf2*Ik?xl2?=^ML z9LSWStcudO$G04+9E*^2+P5;{7Zr*a?s=a|O>_;*v$jDGvJxkYfw~{bY_BePT9WUA zX`U&5kEqV1GC8DF_bPY-a?lnsZ3msG9`)|Ahr8~9dj};kz5d@yBHnn+UvgF|Hb|JH!KYOSTDTacXtZ! z3-jOKovP;RXgF-w%}J^^M2EskI$blat?!aBF@sf;BJAL==h)Agegk#V%urDgF2^m+U^$XA(gDlD($}CbOpiQO7wQ17ddzx|CU7AijNDImo))L zaZ+pQO5ug0xks3|13*96!*uiXE%t2In3@mXUrFh?iA#42VsW+!7xXE3EIx^^`UQvI zF|0;_j%uDLl{4Ggn1ZY<&Nw;_W^CL4!a0c4MWIe;as4j|yrbN14hgD|7W!p)UMhSKNnn8g}?b|{BAZlWwWE@pe4*sEd% zOK5SL3Odg}?zCp4=KqpOADx9MmLpIhUv)oyZ2g7%jWNqGo7E#Sw)#G*RhsUmCiZ<< zxOvk<<1(TBv}?FfHP0T=_F5A}cyl1aN!Ye9KAT4?$X4GxAQU&U z*Z8&r8)*s2;nK#r1)X;EIaP5UCp}&jrR!~6!wdY#UjJ&l2p1WEaB|R;6NI$y!+^R# z764P7`PPBZ(lDhhe-sF_+t34+V@kwi(Ql@qFG2t*!Eu?c|m?_GSzpoe^tiWP9ul0A4qLm^KJGBo^kW*g8L1SbVvoaH-^XN~U z13-{OMHTP4d%GmW4BE=dWZv@9brOz$`5Smo=~l;!wFFI{pJXpct*=K#p3XaoGUX@7&PsKYt)xbHUY_QmU3Fm*P|A3Z zeK5R^GCpxOl(f)Ak<6vlV~7C}uZ0VoG$mXoG3p%OK*~>FFuO44m=G6k+^% zcbpW*%X+6h8&=ZmR6zv#y2s|Cm%6~-~7g1dNK9=RFf8o11^ITdPcp)Yh5QR2f8uN z$MW|%{}Y3_3$I`D65W9tS$=Jj3qOb4iX4_Vk;9LyEUJ?oT_aO)#W@rNsnPS|)3<}k z=n6eR5k$lw&Vn*mFp-Q5yNQ-qDytGxN=`AFqLl6L(-H>&0C>J&-p2o7!{ruHKDegm zMLj6{fAgL^4FH6QYd|cyyL(aqV9~33|N zftEI%mGkbCaheVhLQw|@7(!6Qlflga2s9w5eR;MP<4fDZn_4(Aem8#Q)@u7{Q=7iW z&s;ll<|d~?b64Ef6ei7s785ax z5V=wUCCRs9f)jY661`cJ4B+p}Mik}VGipnaUZhp3=`)g^2vX4fnB(5Ak|wkM6I8pl z=JeJ<#V~l%n)Z?1!T^$_0h0DygdG?ub~~4d$>>)cwgj;!uBLwH?T)ASiGsKb8LC=YA)_zn~*$@15Wa@;)BOogua4ICv|FY^ZqlqkjTNi z;tJ}Dlk44Fd7BUV=~1%5gu#AEuH*3z!#TPcm4i{9MaJ5dy1>@WA;0cxt0 zLEMA{s6-njAD`(?2+kiMvF%+1rWrZEY&%ljs}El8Y3og|9u%5&xmjCzsj2?RLH(+O z$$B@Mva|qKz)st-G1%+Qy>jgz?4iVpLcBU8ye0XbIbK#&*!lq$q|;ZG^6JlI!ZC-D zMgZRP{%ffNsA))^7`<#xt2#UgNL&~P;GHs~3cpv4dTjWkk{~h!F4AYvI}z(V9>*(o zHXg|pvCZ`Ob8{BCEz_|vU5`TCLDfR>JkTVc80a_2m;gVIG9{WnB37?o*x($4d|E>3 z9B4H7sJWbmvtBw6y-oArx{s*GN}WJj=d@!4?C~85qLxIPLiPSuW8H*tMN1cC%;!?e z%~WwIfpH@nyLS{<0+Fhz%SAtWEYYLH1m@*vLg#J zIrf6c{aq%s7W8vtfpS$=ORb4xqMoHMuoORNY!>>AHT^F76II)Jb~-XWwENLeAjr{8 zBt)q}P-{qdi7W(ERuG42YaXf~`cGL7EQy3CCIhsZpzutGB8ryIiQ|>b#FS*<{ad8r z*#zmwMY&@pd?b9RI+@}C;6S$}N5cUsP;#O4^89f80$}$wqc5QlwD&VI{s(634?2)+ zBB(47Ij9YI22Jnx+nN1(>pK4G`7@p7XAOo8bm0TUE9m79;Y6>5&#xq=$^-sc+4{ks z$pv#*$ruE{jwP^iLtDtxphWbJ4GX{><|>ch{ZN6UqPiTO8>i!(R&~UznZ-YEr|`j@ zIwzko!FG~L5&9Bv??{~a2xzX62ZiKnh<%HFOEG;&rKWHKg5S3DX|^VWg-fNyjX0nx z@`tgi&#Sy>fJ=SRcDIA_2N;fCr9;Lp!f_ACg0z%Oh2~XkdB3$yQc%><94#Tt1m8(x zXLO28f3T;+>NyT95H#+#+tW572a_EvuaE;1q320C=?6-6(Z5eOR&W?(=Jch6E$dgx zfXJq1ChCK`2ehQQik#)@eGC=Nz`J;870iUE_tvHf|N1SeZptXCI|r&3vIp?k1gFt@ z`hO0v-k%6yDlLl}ua(o}G5-q}6fT+5Sl7GqMdvXU-TK`it70#ZQ(xsd$28R#7?Wxo z6Wk}48MKp01OnEc)Tz!v!DGs=%>}KZ%*Nt2IvS-HsYwmgJ%o4p|LPLJVH-#TJK`SgD((74t6mg*&#; z>K!~OIpIiWML?Tb{tE`9}%|0p`8`4=IdO_X;G73lbAo3z=w^!BeM%8;Lt~+c=O!*5wn&U1>RT+V8HY z9E9|D=Pz^$C1Y>K}hFl0t8p)sxshSFU8r*QIcU5Mq& zu64f!4i84?SD4`@fT>Is`Rxh__9{jON7Sh-tGkA9^)8y;~m0zHk92~VAJ(K z;&rw>!JQyWSvmpRos_yPlzc_J!A`CQL7Fw+7|Ui<{DU2=gH3ZH$G=zf`j6GHyKmYO z?Lz=I6rv-$;P)dm8Ma*ULWF)7sF`c{$kcHVPGq^C9(BE6HMM8L3$P-;G0X0PwrZ5V z(Dg5_vHpLGkDWws=)=MAZ+99pmpx7Yl=KNi^3x%ay?e)#0;DH!S78LpOooH^pk-2W zKe+VIRD!ZS)}FN)yEg0l;r@&!{$mxB1d#o)G>uqe#5+W3eEuZ$Zux4Q|7 zEQFDo*e!DhMGAhvzbT;*C9D#;uj4}L-U0Ho1XTzff->VGpA}~CHor*%19AotA-|7!^XB8_HF#{oF zoEe?-P}^KF7@6S9;9@;{Y?c|~I+#Pfj}WXHV!5lmnp5Dw3KX#%vpk-G{34;px6MIa zoqG>RJ!W$rG#umc(k+_D4sBI{^M!r-->ky}xK`$y+0c}^AlEWJPmwCiaUM|#yZ5o2 z04UO_zweejrHY>``ug)DRHR}UrAQmR?tV%le2hmsm`DehhFq^C#eaU_)&6tzV~(&9 zbP)yufgb_{#aXD(?3Rd0y!lI_qUkD({|H_>tYNqJhk@KH?P*?YdA>Z3 ztlJGX9k2hSlYgiQ9Vv}mzE^5xVD+VK7-3G2c9=fT+pkcp-%a?IbKste!z(5J8#M+= zKMa$1nyti+pJ}zY@t(^BBus&$0A|v{c`Aj9rH66+`*?h8A9+;PHsvie4QXRd42B@6 zl}m^nBu|}NL5@x{gpi+Fo{)GJiw>zX!zDSoR138CH+^03McI{=5J?H<&gQ9qCfE@G zC^+UkcJvd@v*yGYGcp1_CD6|QdOrnLB6y2Pe$E-Q2F~V2xp{H>J?krB_zG`)1*<|L zd;r$ar}jX0Mn)|`N2AF{;QCssGA#(WPhOAhZ&z6t0=_G7=uX^k7{Yte7tMlhZ(P8{ zhp0?Go;Q$QqH^q~uR1L6nr*|RBhW-(Q`fnP>K6RCh~5Wm`M;ql_6;l4iY=PZR9DQ7 zDnwD~SnxE5rUDiejbR<(%)|o%arCwWFc5br+j8eWSQcdYK#L!c>Tql9>f~clrGuRP25dgE*P!7%qi$j1dn)_BIJkYkaC7tQcjO+1kn| z9Dr|y0cTU8Kav2UKBcq!kHB7aBH&hY%CUE(FO)Y0@aTkG^D4AqAIPDnbNRQRxv+4q zRT_qj-2@(x%mOv-y@y;J&abnjtdUk|Wnsbw%+9)@{LI}mvcb{YPlVizd}KTg^3k!X z+Vj_FW<_J{<=Ht=$(Uxaq^7k9)ZeHJ#6bVJ%W}y<6$k_}lb7@LlELIMeH9KJyLJSi zpju+rFfo(j3xq|M98Miyrmg)!SgeN$C&rh_pF9@6dpI(qD!^Y!I5;{BiG5p7VR)%^ z@+cU^7YBaQ5-&w=AwLsO*cqSyHY564vM>P8(?oSc zCYN_H3o$+j_V~uLQpb$X+(*jP+yTImqm#u-$U$I2gX2cK=;7z^;}&EPscbAR2msfl zg=Zm@s`ia=(#P&+9GFLDuN^kPtDT2OFO)(Soh0nZ_)z_0ol_!8dqY21oE(>GeXdqk zv0}9dPJoEak-U&}FIJ4Jf_8d-jB!u%*tL?4x7KD&1^p$|guInU1{B~LdiM5xtkP&N zqF2PDX_C!J?K^l_<#7x&Z_oxJ?SED0eeWY?$2=4bEJ$!3kVz&iKTJ;oB6GPrD*9fD z7-+QPL%-ABf_~iCiMiY(utOGsgBr8~2`q$&{8eq693uH5H8U@x`91774315&N=bT3 z4uEbjUlO!k0eDI{+!nF`ee7u34H;pC14ad9+&Aj>fPvl=;jMXix5=n$dU$RfOBUcS z&#;E4^>rc+d_$`7Sq89-O3FHo9P}^Oqm$q-G`AmrJ&*T}=Qp6Cq6!xs-rI7mLF zdPeYqA^j(8dvJJ82ekQVI@);e%h3Y4q;vZc!3w`^`t0%hFEC3qHm*%KNPEuu6+N5# z2M%;TFdT}U4#n%u>iT3M@A}%$nE8iA4D$hl3rDSYsG^IB06c3K(r(7B{UopmW%M>h zl0(m3CfH9g8!DpeQH|QnMjKmi3Obor!e0g__rt$!=#2;s?hboeQulk?AsO~4u=^-j zd}Xop+uCnXUDF|=WKe)+K+Dc=xX6nkpFM7M+fhsip7dCuWGoh9M;xI7C_1ydiw=;W zrXgR_XijNjIn?l`J>Mw&X$u;^_Q zrbm~Mylo~GO{mF93-mzFf0>Thh$OPUu~vUxw%tkvx?-W-Xk`ihHU78J)-|yvDxaz8 z1*E1Z%hjlhi;8yA13fKw(wJb!NR!&bZph~J%EXK~wH>>RZAiyF;nvUlVX36h1jA(R z+OfcJY7LUoHz{z++{XzLjUrCDLOV<^SxsUFbW#w0_eYi;1Kh*w-;XSigxmdON^o^% z=w*&cw`a;Xw@bXgpA8VJ(3`AKN(7uQuJ0UW(}suHbdG8r4^huldD(P0J!^~^42dpQ z9^)%1bL!VO5wZMShWpV)zyZ2bO?|ccxBXudNtU3Yn-)KFy~;!PtRjECcLX<@y=D2a{)~s8 zIK{0Q=#DX1OPvxQOif8M1qUWTnTy81qW5AH2#~r zYYc3Svo?bORHvM|qS_N^eIds78oHlRWY-E@Ss3DIsbK|%1BTSQOb)k7t}GQzZVLlp zZCyxoa;uKdI?nD(9xq0=F1A?e9o1zxw@>h@Vh<9|e-Cgw4+dp^T&(G`i48+rUpY7> ziM1cRfB<)BwTM*HlB@+KWPv|ne1wmEeJ0#I+M9GlH?ecl3F?22>#sel3kVeOUGlMe zQ9YXW@6NcE{;nAoSb#nGndD%n9S!LH>0cQG1^|9$@*l?Hv#DZ87mtYES6>Wr`V&u7 zlq?6`2LOQDEts|U|L9}+9;OUM=-4j+7W?ezTgMRIWoKSpGvMQUGKw7+_CoVB@CreS zIXwRECw(Drp=Mq3^Fe)ej{X!hE=E1^1x-0|tlb~*veOhsE?UCz9bE-P{GZO6tvT-i z&rfb9^NA-B6eX2<=)Z~_}RIel3nr|;4eyEaa{Frt|tK782dU6ZmaH?p+SyZ z22u7~Fl)3O`()i-vmJ}EmNpD9Zl9>6o7^gzzG7NFL7MP$@DPCZ_*k8}+h}CE;{3x}QSGxN(aa>+)?)KXTNNz*>jKCJm-; zMXtSRU{qUQf9I+J7xg!0g`*|pj={y9k4}?T?0^}~cB!HbejB}nFvGfovRcX#`yp~K z{qcizl{S&mNSP5eFXpfUamL(+Upiy!Md`K8f^k|}cU z8U5rwh-Sa?!`6Jv(>dcz*fs258Q_e}OAQ@{w<^XHKDmK`_0C%7#Rdj$U6CYikt$fl zl5jrPqE0Y`2pPvRz>TIAm2c(dhRo6&_hNAmiy8*n8j1DGHhv`2x;*uw)V4^srQ&E8y)~<06c&zJUDJXJB3N^1cg{GC> zsZCjeII6`U$C+YxTjHHr1#Sp0@yI7XP-pNH5XRl8&x48JJ?avuT``$(O zLYY7EIhqLP;^^F*DJtzMqGp1w3U2-S767OEIV1M=Noy?ZNQoI@Eey)~R3u8n;eqdV zSdCgwPRJ10P#)wA+E&i*7K@jT^MI~~u@ys!<$T&UN>4paC#7E@1Iu@9+&IheS2~D% zPL)taxpXKNE4s^WipX8aN>&*10D*5ilNc&%!*uI2zuHT~X9RAY`A9iE_}KUnqlk~Q zC=(nh#C3I{?V+0p=?nWOzEkj_NOlPzX!)dJI*Q{mlZB)7NXW}q5O0~`a5iFJ9qtIS zag-=#^*m<$&?q;k4*CZG(Xvk~mo;S$sDC)S zfGrUxGyJ$ z00ReMUqPKm*~Q6*+bDuMgtwl_ECZ$%7(6F^PqcUR1Hjl<3Rs#xUKnuWe2aEl{YE^R ze2i{tl?m|3DR{=$mwZ<Z-y&ubHNqE6NZ6k)bhw24qui z1*r=Ny3jP4ed5GTW_Pk%nO{h3(WI;Y7Ht%uBr|JY%ygBz&q6JKSISpzTEbqsnb{iC zRxynGALK872S?Vu@PGD*kWwWj3HKOlZh}&hC3S0BRJW)Z(cC?rN`NN_WR_>?*3Idh z6lh2ney6s}zd|1Oy`AzDGg#_ngkMco`4vkbM-igOJRelEE2j za+LaP8m401Wff?dp7c&Kg)H8_M&MC0Xx2GA@Qk4ztgmeb3BuG2Cd1dA_URi{B-WySr&QTNppl;I&6; zG`99XahjD&2^6YCq-3!bV14=}wV@pa-KKT!JeC{bMYH%;hmp*ZZ1GP)u^WFT$7VAn zNCdpo)8uwSl^cp;AZX6^_3d~QMd(tfqc8l-T;jcDYG}&$Kt!aP!VS~=BwY@hgC0&; z-a7r3tde`AzTay#X+GYD+w?}MH3=NT2}@_DzLpf_rhx@An8s3GBl&e(?5(Z@|bkg>!^Q?-BM@f@HA zaZ5W;yxV^=s-P(#T6*xjr`swx_pP9jFyBu>VrGx*BR#$bb19^E>?STmCl6FlYp~UZ z5r=;A2x@16d!gAiOk8cQx>8h3VZ>=s_Qz5d964)3*wiDn?;fu_vViE#y4ooSd|8#(-Q6IldgQ6-(t)P$jV{?loG4YY{pY^V8zefuZ=4cd(Tb zAjJ-8da~oapS4fXocjt1TL{hfU(Eq`FdS@@Nf|=T#*k3b_tlhO`i#Cn>2x=FA)H`c zas3bBrKXa)pmKqwK1aXsd@Te&UllnTJ5e+A&C5Bp7|$V)4B{hab18*Z zMDx?=yBAUltldK4g8S&OYk)c7N-8AAnp`wH1QZRjD$ZUTm+bKM0ropXLS`BdvU1g`` zbwY<9d{SFG#g{311*W4l>#V!7$#C{?p=0eSW<9o;Qjm#h>7w~Ji8KQ4kX=x@T}2iS zTb7GPOYGhKBL3AME9jO|VxUVq?u!hik6+5&;V;8cLf@UuwgDV+M_k*kp14Z*6EQSO zjue+CRM-%ZMlg_zTNp#pjqs) zv+ZCoct;Hl4zto6DT8$>5Gp2?hc9Av4S@?bY7SQ4q)M048Qz&{ z?By=*M$)2Fyt7z`UoVNfIc{T!PpxGV$;qfKrwL!I%)i!mqV2sz0MMKt?a^dyKoNVg zOGmbZB${;f=tcBz`XjRZrZmqG2<=~rm{a&g1 zWf_cW8AfqINfq3aD+S7oaLZp1L|Fq>Ft)B%td(+m(Dr75v+x@?T@#AO| z_}}d^(2$F5lj9SZuU{n6H!IZLtxkzWa+z*kXBP08S+tWS8Diu$@mZa~V0u+E36cP@ zLOos|1YxEqGx=Y1)A%ymuU@*2)(Yp|zeo*C6X<~->d*yOpqO{e8m2qUez}tl#-%Q4 zhijiR#7*S`s7z9`*vU79(d+MF)GXCik0&WEZtpn^*{k(FAL4;i2Mv^D2JjR$YAF`M zO=}J{1OG}hO|ht5N;=IwCYFF?&Hml$#TQTY_|N$uUbb}$-vA;D?ZJ_GWBuICVF%2#jn=L{d*{i`WJ%*{A?gyLuh>LMBP(ADIMf(P4t z=`f}gqznh#ni@)aD>Up%o__w{d|Xt-m&V-BQ`}^#r$m?c-nu7{flgNa>OJNm0T=s= zVSGbIb7!1zWX-(cm9pMU`Lt|hgH+p;;h?O_dm%&jzUa&07HVoxZQMJmVW&FA839v| zqrL1(`JUhx@vK0V_P#N0A}U_k5mI3^_FMz+BR17ukkRtU=X}F30>1n*!Z!+U+Fg_C z=cAB`Gi8gAV8!E6B0QhO{JWHRusW}V2 z!$O)&tw*9Ih@w8re|}K&u!rG@vpo6AHV6k!^Be(?chebYO#!fga4ZKX$?&DQ=%+mu z2t1t>clzy-F(UPW3j0Ia#HRV!p#ww8XKFj~gh3UR3nZj+BeE5L_xC1lF`oxxH2M4W z+>=Wwm*EL&`Tj>4odl(#GrinicL#ekr07y2Hd{Okf3)EV+__8>W`*)+^ka%IDqr-k zgbKzG5A69D4csIRM^aUuu_yz*prt1CTTS1Jk;_wY%ZZ5{p?kKYoHRH$Nr0V!;nO1w zm)G0T1!RpHcPZUW-F6AODnzRuHtN#`o7jLbZ3?R?oy^Sp(gh z%9$M_7umtuD5K4KG%}&cu+9pjLEf>mfi;9BY+=zSi)qBJF`q9p+21qSQJGW#ajvdCjGZ|vS1t>M479}@A&b> zKB3TCbF4UYlyFQLv?7^24uE3=s5X8kc0nG1iqA`SYw7%xfh2_R`rIW9MY>L}?4@-5 z!nzJqb4t9m?h>couokZf-o2}3SYpr@+0n#KQzOK^S7jkB*=U9IQm8!A)P45vD)JI0 zgemLVH0kFbO~!M8Vr-rS!Ti}5-UeMG>6|103CFj4;_49Abfp?vBFo6ZYmWy38Ztkq z@&~aU3-N&1CAsO^RI4QgDIE;o1KU)$08eaNTHSLm?5``1%GGM|TjgjJ5zR;4Q3`xg z6E~`*K1W>1;ZwtLy#gUmkTlpHTW1lD=W#cDU8}6-O5FgyFU>=&;EC$Gf;ST{{0rWt zjP{A|jBbSyT#sb{EQb;KxE>$`%-s%_v|Z==jdxDaoZ#*2?yG8fNE!-J(;eYAc%~?~ zyE#YLwdGi6E881D76f3q)#Kj?fYyd2M%Wnl7 z>N}AyMBuP5xF1MO>bOgv0aYLFj=1T9Re;{qvsyP_`XXjT%74Cw3?c2$CXh#6#8$;u z*p{0Xtmm~vFSfy@NkAStOQD{{<%*9&HLY+`Blft(_9{#e8tI-fR%)QAv7pGm?#krF zr6|d`KNfXUcVxv<^9Vv-mXt}f2;CzG@qervy5}g zw<=O7elG}rXkCLJpWGOZ{b=Hj&!JY2{vOAkCrBEY2KURdmk(pT!uid>NWEi_7Ifjh zW}3$A;^_tnsLsAz#4kJz>KLs6~7-5u`Sume&*28I$$Ne$$dpIo!aw5j;2aOcC0ip9C9ei}Q)j6NkYD$FBVSJy*EIo72~w7TdFncQG+ zs#x(cf0!Ux2P|o=3G-;>EX#&WChREZmqvXSSY?PKe4q0@z6RAAL(|#hf>+nMm-54a zbdG$fOl}fvIu1$1ZD-VWT)c~9>NVB)*nO^*A!L+kO}qYjt>kFmNKaxeV30j05jv<@ zES0jlU_4&Yhv3G8O?RLFn6ruLMO!t_2OZXf^OA@Klz>K3%jP@vW>)!US9=?UzvFE# zR5!WdBsaU;G>MsaUwdzXn5MMtya`&|213DgI~1D(T4ZJ zLg4`vpHwwu^LBf5b69Lh5pZQ3_j^{u{p)$BiY*8uoIZv8p~=!q^z~6m)pmGDU~!A8 zKFMcqu!nKc8W|+v<5m8wPXdC*q>XZerpphU`@c~nkA0in- z(+BZmqxJP@_b?W-zoyy`%eU?Uy=}%7J>;aO&p%kw6y!kh<+Wj}`ZH_p!w={nO}-7U z6MmjJwZaa!oq!NuA&p!??ULFhh*h5#wP~J zr~{SoJ@XeO;$b1Sh_15ZPpEtozgUW>A7#I=$E)PcJ=1&4#GKj!HYfJF8}=62qFFV|<_y{dq!C4!YkFB*7YAnlV2r z6c|`o8T~q_eAE6IUJltVf*9bDlsh8xDT|tT0f!d2y^jZtn;bAk(iHiTYnnmHdR^5% zebf%GM~VsegU#*W;ChQ_4CutBlLugHFNS0xjln(Nu zsMDT)s!El)Gar=^zE)M3U`y834E;Q-3mIJu?_rYC#p$2?UPAkZ-kx?? zu6;fDt8(ccrCtb7kB?$!uynGFZ=f2w9EIp0A1sjqb!MAJEu(Y%Czj*h3^#x6lW`oBJLQx%fs7!NU1NQ^nPM)>q*9JYf0 z@SM4L|A*(4y}>jjB04rSY+`=q^8ODIBDw5?BN_c5U z#!B1sy+1#Yue*FS$+`);=r|st1Iyq}e!xSm?v?wO{V_hjXV)SC3+^0gJSc+b*6%k} zr6IBbOklS=m#mv*6OKfUk5wmsM~lW$m5P`bFdxNrbq*$F>>y=4z@=r|8B+QZyo&Y; zDbx6nrv&91K07;SSY@*{_eal7RO1Ytd-%8cW2vBOW}N zPuo8tZ+&l$Kep7`q8kUogJ?bFGk}y{pbPi(Y)GV2FgG-=ik+0jS7nnAIJ_@$i~ExB zrO0f(P@LZvLBn8P?+a$z=9JRS83V?@y2FX7zDQ`TX=e`-{{<85^UHUP;>511AcA}Q zTbk7j?=F>{QGP0$x_a}KJ_oR3lpSsqAyMg1#gTsezO=J=oV0sHcZ1Q3Y=HD}+Yr5| zJr?*rZZZh_%(Z!BFwR2$8a^~A){J-JV&OKT6!_x+l{RKZJJ)?LbU|Jm2{jE}OkI}s zV4AzSCpR} z%0KHFbYIl9p2cJJ@n|T1siKI#bxMM`5cfPGRKf|LK4o@gDgpV|&5EWE`+Hns1_Ca;03%jxVUTU)0kgl(;?(&O&We>s@+t1F611uX9(N*Nj#W zR!U^<|EN&xeg6pqRwk;*_`#_}69Zd@l{$Y8kZn%r+ z-b@bKS3%o9v*U2}wOvW%IV+Gq!IQ~)kp(;Tl5fg4t8TcIde5nsgN8YQtpG44)BbU8>~Tp&JE8tUDYVd#Me^3M&*k}Y({mb zI_l8k#+2J8D@GfnjSr1r%X7d~W9k-jyR|nriD(!ehtzWmLUMyEGxYXP+Q-BE+%%y0 zR^4P5qBTV;szC6fXxl)R_fcOAIVLb1*nmD@Dk36^k_Q5`WiiLx+# zYZ1G81($zF+Yp$l^zB>buw^RP<)4|xNttHX;nw)@OV+sVpenu_*m>|8t%)B)+T>Yq zxomMj*tWa}y<~rEcxsskcde8t&V>L}J@Smplq=SYK z&$IiJ!MUy!3ebt*$4Gac;_JI@R}mA|I^GA@I5wC6GW^{F8VP|?B3naOGgHD)9VLR! zwdLHbo8-luX&)1-QZbu{5OSb4ye&sAWt3_3YZa30|1I6r@sOOzQw{>oy04fJbIL5V z)M#P+{YflxFY9w0{j4l5NFk<^OTKHBjL&m-slQAyeyC2oL3rK*QQv8mCA$EdYEpI~lDi{B zhASUi{{lIcrESzqxb?DwcbNGS+E*9?tH`>EGk7;$n?6^8)4WMm7jIgEVqmR!FP&9M zLtLNj(3>P_R;!O@s4UM73bVBaTwHC(lpXb|EP5by@#pM93^J&iawqF@JHoy!KGtZh z{xRgaKJ+8L77K^aIzrL1b&DmwuWr!F#NO<)dU~JIZ^`(6FHfrefDanHSvNT>N%<)U zBbnt@gT+I=7AV7|ZK~jEbyo&a#RXu@x*UATyt{^3Jxk9;?we zjC53u@o`!XTylHpn++~2j&-Euwt!uG(^fyE~=cA1Q>i59>ztU~7*v+l+l!#i@U z_&1i(E_`?tzT1FWArk3nJ*E5iwNX`i=hGVdbF*NUq=9e`-{>vnmsSX8$bwtnACCJa zt2qp$r9X|pM!>UKqW)iy6Xa7%RM8EJ)_cHUx$=MbAuwSTRf$IR5`A;C&YL=_8C`~_ z;$oTN<@Hg#XbWweIyZC=k$v}nB#{wdF7N-EU(J-&58N{Y_(b3*_>q1nglJx1Uh41S zlmouATy#t*Mde?7@KZC+0QQ>gk$tA}3C}p`^AxhWO<8E25$fteKfx2jw*U^=-lr;a z8JbgYT}~V$l!0U+m5|O4^QO69vqcGcB_Fg}Z17Z%*69a?EF<|~*`E(Vcq3Ge1ls`e zwV%cWY35te$?%mbZh+7uhrkUkz?%&Zerv6ypc|pmu#})ViBuX*{SnrK=zrgKD4Avr z^al@XvP+t2V9E+Ye7d|MwygD}LOk<7pvPq@7pd=&s4|D38NhgW5Dk4)k+M>RFm981 z|BI`0>=Gkse#hcjZ26S3x+vJW+EE8kG& zIMGlo%OYtm(B0FQc!}GRx7sr>n!hzwX&xQP!b8qatfb}*p@OMs@I(>6g`H}1jTv<7 zksLM(JGcIF(gS!+$q=zj|5jJz)AGO%QtE??aqsA#+OG~?2vuOyZ&~78B{9*s5g?$R zjU9c_uTQCTD8FM?OeR9a{TnHjFs~a!+68~?6eN*HY?17OK|yJgF1`DY(>c!SxSK|2 zVB@8^sTD9-&@7CBfc*~T6oxsJF8OewFoVL;a$MY3iaZ+NrAVJGJhQ4)IN?+ zf>5CM=>)Qm^?*6aLPIAR&7s3kBqwye4jI{Iokrq}X0%`GVW)ty$)6b1!|x7&>@|vo zaNemTWtG&9n+re1MR^{X>tw`TZmpAbdO+8#U4xErhuVgx`Yy=R$f}Nk0Gn3rit5CY zH8*HgnG&j88n_5WuZRm^j(BbS6lNwO2Js%J)J7bQKeHTS3SV2ZAiS>>#8jWSA_$q%mB@Y04`s z|LOPACe7K3F;K0k-a{_c{+66$pi`g~p(*=AS=FWFMp@%p!U=ymvDBgJTPGa)-9JLL zeJ{WF7k?KnrO9MrF?OU=(C_V$gg6k_v}CmBhS|Y{Jbd&`Zk4XSE$OMnCHU+f#Yr$l zjcpCtFFgFBIU~{x?%el?YR6Jbgtbx(Pe^`^{*>hpvi9?XZnO~nj`7lT)RH5H&8~49 z9Fi;Uyk5PDuf9lG{@;98GK)T0I3^ATVr?3}k1b!fMbHz2_T5ak`tqy`n3hGKWCrWt z$B8pcgOo}m0RZ5t78GuYUNz9LWlKBF>+{xwnd_YS>H%#Mnx$BSoU?h^i(KA!-x_Q!W{-4)X>0wl zyt*&>4goF9&M18bl1K;rH;>qa&n0|);-0C%2IQ1^^7GsyHa8z8^OqNo@(-IT#W&F*2t-dEGX-c0=iprz?%wBYD-6wM z?_GN8dS2eLQKYkc46k_RzGcEQ5a#)+#^o%?RdAQ50dByCAyZc#|rPl2+ zeMj5_se`~>Q8MgxvhrCM5Unh^t%wqNFG6W~6I}T0DJ*FZa5=1>Q z=R#-Wb9)?3Z{?HO>S%;EV`qzKI1o$tQ^ zQj!2HXYMc~J`^L*T~j9Q(EoelbzC~&D`7Pn8Tg)3c^8KJ!XxkZ{1Y%JhBYk-mF z4^>`bLa3%efyjg^P{%_03b4ex%~f^R~4Pu4@FjmX$9P3 z4xyXL!yqg>rCm@PjtA--auKHX3R2B=WTFA!7QRLl0oGG1dT&5L_Kx&M!Y|&}72gVI zFY|wD&gZ;5u7}1KE}>r|3N}!o^a!Le)DXtjh-P)6PBpk@K{1)v%wkZxeEZsZ*MDl~ z(q+x;U){1qU`^0#IsL)DIEYRPP%*3)v{61<^({3*ENqy&Uh45daW%$xD)s_j zsR~&K3C*0?pL>mvWWS20$$O>q%N9GSoS&F6$T$33)lpBW2KIV>Rw~8VgS1BuYX{#b z3^B}Y7C$1EZjs=`cgO;{gkvh|*Pkn$azaxXgPu3Y8kw}a%9OHZBm&u4)X|Vp??t*Q z>JTy<4hx6P_|(n9UNO^=V_(vTK%`TbF%evNRzXsIj68UQkFHe(KY8VXV@PSI`wMmv=WZru;pxc%}K_t>U7@dd^3{dANlB2~}ak z%fBu|cLd8F?pcBcL2s4=aU9CZ7Z|b^Zqa9GgE?Qw1VnUVS>dsGVVcsw>Y4NK94^Z` zJCn8C!P)dP)KBfOv8pI{S=8?u35v~--%e6$o(P=gZ@uv(k;BMeL@H(~E*J%O1o72A z7$5|I?5AY~NLlM?{I<}_j((2@*#Vc`yUC-~6DZewXqHh0t)#_&a7@Gm3Y>qdiu8l^-yT1 z{`PLlFbj4Ky{3sFTMebc0*}Pox!rd+oKXJfXB-08knSHv3vMY|P(_=t1AFHs zb;_#-+elb~2l`Z)cuD;c28iu$G*m^HRYP45f=b_PY|By&A~`48TToJB>8Wt#$&M#R z(;83pA>RrkBM$gxw}&B!QERt;RbsQ)_2TUp=#P81v!v7xuR*Gv|qMEq-CuKm_Ow)P4Ci`=IluNRXs-2j^*#3 z#t&#hb{?vdUB^h60YV-Yc__CEi2A&sq#TzcHa6L9AlLZ>4|GolLu81hBcN_`?fth^ zY|;lW8*sI>myFc4Sjq|%MoiLpXXy$ZBwYqTlD3yY8n>F?&m4v7p zTX)G`#jz;_-)3)?mlrrMjx|5xh@E!?1}RZw;;Vzt7xYGnt&EX(&e8+!Ezi&-R-d(V9#TxKl+){c%;!W%O;)S)ODsE{n}o(?)3{)Fgd%(DlOyj z`slpXy-4D+7r?};)_RD2o>iAzh5B*n=i*$4kSr=u<&?UP?SS~|FC!Aci$WI-;Zb6Im=8N?}>1g;k85Pk_$U27!M_5sNFrzO1gum$-E=f zTMEu4?zgF+<2A7Bpohy1(S_r_dGk3oWpTw#KdZ{DfQu=+q7UD0mWA{%`m-pEN;Qy<5C)S$kQmDjyxqGWO<}aS)Uf>G!GaJ(}?3M?to7>OP{>uuvr39ZJ&IPuLe>OhgR;YVV+5FbtAw^gBV1UhD|CojYD|7aLNEHa2kx+Ca@lio|9bZ%iUMP=Tl!zABnyK73caFI z!k+=TH?hqmRTQHafVbOu{Vk_s;OJjTygWYYzL6E_6L`e;vVS;;gn%KC z?v=AktjMguh$Gn__rz=k752*DPA36y&)brZiuy92RGZsi{1s6gl&!xmW z1HUj{Ig0lbTo%sx*T0SO?mb0!k_`YG_J5}{eZ*` zozKa0|HOAB{_JiFuPp_9--AYu7HjNMw6k7)J{i`bX>47|CdhN~R$9BChJw@^2uzDh zWqVj?nhcdWpmb~f>=n9T6AO1la#AvTgv`w&g3)n(n~&8vYZ22gg5?Hxd1&gzNAQ31 z!N^1gju2ae7elo7p#rEw%cvto^@a)ietR<&{q>%KNP#Pe^<>#;x|lNoRPBZbyZ7Be zI-Xv3FM9E*yz!82k~TN6bM-Fvi456xp4?=HA!%@;d(n z`nDhV*BVL`HGA=b!n&!Pu`F*F+59$ge45y>IC6sKoum$4FFxWUsL!C!EjY<-glafs zR+m<{a!2}au%U)+L)&qyV5!&;3Bk~^#1R2D*z9wy&bVVuG%_Zi)-i4ruA?_d6K_p! zl^`R+;56}|q9F+Qyqln_H0d>VqnBk;?JsL_<@O&lJ8ImYx0>s&pHzTn#!(XgzR?}I zl90`U(jhyOOUN~#&Ef)t*GKSDX7$lyDT`Fh4CFdF2MOrKzw#;^0oV9{GVClLG424K zdxY<82rO)a=whDfqy)@0wjKBvZh%?Cyk0$xS0iXMacJp0D?n4ww`^jEw;Ig)^L`=; zLV3xwZMywM+oTG)1My1AX~YC7dWF*5g=^v$8JNJAac6rJ-dpF$y^8i!{7a_-LxwPm45Hx-aF`}O^&0v3y*L4KS z-O_z^6V~zWg9{u=Mj-Et4S+tXPE>forRyzvoep{@$c5^i>%$}^C-*kq7*6roU`r8L z7S6IEqp$298GAb#3jCF~>c27icPbUp`Lj?HEujlO@Q)N^>$aEjI&m+aRhy@n~WXJ-IxDcYaFvLCo1=G_zQKFXY5VXY}`*A$Yuh!GficSSm^<-+-C? zKRFTXjQ~xduLqO#g5Ux#oWLI!2aI-gp)@SdRD$;tw z+m;#sj14~D-OJ9ZkyB&zfazm?GJM`N82JdcB1+wL2&c`VMFY2N1Lw&kx<1Y!nXm-I zSRnFn2m&U#?it~3^>1^Rn*!Zr0lA@e`Ws3i^2grtf>)}TE51>4W4leBnm&opYn>^4 zSo{^rV`*7mml=+vu=^7x3it$odgXT@YL3*+Rj@d#u8oo^x;#06cLV`=B;y=TgUwlY zq28PE1qRMka6A2}23S`q&3pj|MHk}7!K7FYWMbnn+|MKYiy4)}73`K>a}+fH(OF@o zhLd+5Uo4hM*z9q?D!sSo}3kL#7}HJHdcV zlomAT)KKsP+B!PKkp{})2O3=r7Sw}}W@0D&e(@E6xkmr@7tRN}Jd+Q!BG~C!3F#t@ zPcP9BG{SDe=pq(YqGIK6bht0F@;R7Bj!`r;#FOfkAq@7t?SBGtiHr*pTLbb{uB`^z z?**R#1(!)OjJLeRkKP%53OSLIt9%PxDS1S^G$`zc86s--hVqE5BtP<|Z*2h+z*Fn* z5}hj0$pr3<6v7z9k?hbf)jQu&&%_XaieLk?Qll8!SLsNt2ya(U_Lbupo=X!bp|Cj0 zOVBl&#pu!sp*owzx|-Xw=KbbCwMcpwJe;)8WgjYl%Q2lrtdim6hXo{CYe^e?1 z7nvD)C|^{D^jg(0Y@O%8y$5Qyf@6Oc&ZF8g#D+B>ua&-=FE76%_>SkAA znbk2|C(c#z^2yf;dLjyk#V1f9Xa{MgM4Fu9pEj#4* zbZwMuV()1QyOF>h*0xjhy^;O(yEzY#uGF(XY&$V&00-7kGPp&{rt?!0(s-I$^4>Lh;BRQI4$-@Ojl`OheszxBfE!{oLYKU0^a~eR z)ZDKoqs|f4(aoqM71Hxt|_=sO%EcR!%flUXv{-fdK%304w9>!uF=3>axCP;9 zun%Nlc=lgoT**-Cn_UryVRP>^@5cxIvRr})xmD!cEqNTQi=R`>aicVx?aTb56%w)z zuaKdh%LsHtqt&Bv++xqE z*w{{DhJF72`M$1fBu1(eExK%j^A`Jv8a;4+r54!rkr**?_9JG}_h^^J8U4HNuh|kH zKjSSMGp~)TUd{u?C%TGCevT-0YX+rq1%NXk+wjIN8hxbEWWEOean-QQmPMCPnHT3G zT13fP=`o*gFWm_Nf_|CVsPW&}@+{RA<;COC@*)O$gl(qvh>|wLJ-5-5o1U%Pay=(DK4(84R<1mgG*2OhCxrg#dsWW9J90Z2iD&Ue^;UYEHgZvr=hGASO#MsB z3}oXQlgscBScTFPc`3)j3wq2_Da0aIq)6ayZXU3)`>vb&uf$tNQ4P>GcZts#XY*q6f-@Oip|%o|ChBPU`#dQZ=Z73u5ef z3o^4@cCo^=4J&^VDOZwgkR(tbo(m^jVg%mvrl=Xr>Sbqlf$m-AavRHlWXdJ7B=8w& zOI|@(L6yZN5w}&U(?lRaB*V6jkOp7@wDZ>o6W$7liBE#7plDrUH%vy=ty_Q7JWjBW zpZ=Sy#%lLyrDZ5apIHdU(pO0KjlLI4Ld$3$f^=}|?b3wicu)EZf6oP~)uACeWJb^0 zhASu!xYYD@1p0p6{wBA#YVZTM%NNDpQD*SjwI~!6?fHA0~y6E zSgzn@o>8x*?@9#IctM=ikKutOF%gLd`-N~1(lB?a!WhlRd}%GtMf513(tH)Pwkw!H z;3k_fWUBy-8GahAJ7~o5#D9G#;0L z?U0?K&@;Ip6p`X;m-#GV@iShVxXm;K{ZISUvln-91Wu08=wutVj&TQm*q`gGvv;d-FeVM*tbBkp!VZtvwd4G;h29yx z730M`!Iv?h%c16;O1GD$HYjgCgij~Ctr;3Yz2WaeL~6f)Vpb;0DCYIHfVJU`y=QWH z>D6BJYj+txJ_|`c`3F~ZMQ5?rSh{AQhAUaF~7M{EbLG03=KxC_9yR$)bBFUH$qZ zJRI<@%4uir41xptD4XO}9m()Gy)+FRd4%y&U z8=%&DOl?7|wYSW|_7mNzPu3tlB8aoicS$~*8ai%dDVRrZ;Cnxl@B%t$v;7jX8Bg@q zY%qbQm(ADGdf4rA&Z36S?Df0RB8V(&MN0G|2WFYC%Dpz21%cyv_1Uv} z0CmhFQd23YOaO?iVc)Hg7*RT=5<~d)>KWu`a=jPF29+N643HG6V=QS?bLxb&RwmlL znel8UMk<0a5jYl%&z8iZ(@_?#mp|-F~Rv`c8hfsp%l{86ei%whRDj6bpN2_DPfK?@i`3Do!to zs^WWjYSt6QH}AW7#&g+%TaU8LZHUf)8{<+Ao#3h5GbiC zH`bwunufJe)6c03;Kk-xBsVn1ov5W{nrW-`T9Ao*0`&NrA3~MVPl*E1ZmEPo9dVG2 z+IKLc)O}UKb*5{fsfkJt?Kob2&O&wHQ^9m%&%GwMAX1c(OugD;TQ|MF6Q3B2_ z(A=#+Jn`;O+~~Egg`t^KW$ZOlI}LRK7J{`?152^+mil*1m_%3sWzzw#N4uX9^8(K& zqETmRx~pC;6i0IYA0Uo8;#9`$jy^IjR{K>=_A!I2D2#jinaCvw(;#Kc7w?bj}kjWBkiK);dM`2@i=^a)x)}i`Jm!BSO~l zuL7UBZ)S>(kEy?Z6jwBx545u(HBWllBT`@uJk+0!@^`o8Xdy<5X}kuLDivqzF?9Kq zJsjbo)4PW{f-(ww#tE$}2)RHNC->DS!_E&9Fw0hZ*#$v9?SnFO2{!pIDfjU?sgd*r z1A-AmPmotOimKsbEy<67`29?_t`-LV>_1$U`URZw`?wVmXno(c; z(C#abD3TG__`9su-o7z69&YnX9bRt1HoVPwFI0sDZ?n0s+}-aVbG!R~>f&asD@jV7 z?1U9J=5`Q6|9mhQ&WvcGyRQ|L()rcY_#lIWfRZ4|RKUK+i#{P7^{!Ei>Sg-&3|t$y z801;~fu+OlGYHvstroAnwc1fw zK}9vTY(|&r+xS%X;qY>2dDa0NW&o(Im|)x&Mf@aOUqH(bj*_^L+$L{`i~lN0eHf8S zeHk{Hhc%O0LTid!_YM9#QFzZ7dkC9cRWQi^2Du+WcsvxiHmFH&Up(N|BzS?$tjb^t zVR|aH51+D3RsOkkGkT+koSq7}?-)18?i?BsN!;T;%ZHD2%c{RoCXq|EpxTJ0OQlo6lJoPe1?7=TL})nygPHxS2EIU1mTUjpy( zx=oLGFP$ber}$=S>;swgn8VI(bwsH5(h zD&R}K#xLfV`~%!Gc|h$kc7Cjg(qs5W+&X-Xq6RyOz+(tZC}-%VL6_1~)2!BkIx3T6 zKi%?Nd*P)#Ge!4W?B@#XL4GY!&hH{RKbkiy@=3zI>0ltmGs8n41(cB#4pjJd{c!vj zrLy<_536_7HY2-(I%4sn`GM_zINQUx&_B>!@1BR$5(a5ih(7d3xywrY#|3m4v>>G$Z`9?B@ntTPRP{uq~c@_fKt zYm?Hy?6j3iq+F)3o}}}Z8X#o^4Y$yQyW{AJ*tIu0q{<0^J7EuBe1i>#R_{r87NLk$ z75vZ$I}{d8ZE`l214pojs5a95WAGc@VkER>-2I3!v3wKn^NRpT6g>1+Lcwa-^Yf?NxT)77A649`NnOx8#`;&CI15Kt$?Z& zrFE6;4xDl9eFK86Ao!^v1?8HEFs4)L_y*vA<57zq1N;4C5S>%}OZvW0&T4r$9z;+hgcR$MA9IjK*h7H=e1l#a4Bw%6 zPZoCAOSH`npPt$#8+^sOkjfhKnvY_2yET zI3otvJgsP6{&2Wq{>mICftw({9X$C%H}ZAUH;f-&&76s5wVHX5UHbg~JT|omR4v0z zMgbMzXiH*A)pi!v?eWKH>P(o3lXkA)y+H&ep~)-I2`T-2Z$xVXR;}Ze${&dRtr7^C zDGyIZdSbI=-yk9~ES@|!2pqEpBV;;E@*Z0Rz*uuiV@4zkDH}ILoKAqS*)sE&F=>Rt zH9K%sgmu0I8}uj)l>4DBNIBYX3WkDWl8nF1cWsA?ia9bE@Vvxd>uvMS;yT>1*RI~I zhHb~p^+X`QR1lzKD`Z&n_tyK|L7@{7-aqp8(7F!Vp+TQZs=1tpg5^E2gyq075S3ko z)E)}NVVg4(d~rIeqiUM$_oPqe^eEoG`n~x6Z>IkL+tzAR^U4Vj;@#Bw3B+GQsJu10 zfTZ1--Zp9@qnJOq8)l=RoeEb)LbtYtP+~qw*Y>6P=3jY}j{N3DUhTA;Vi402_CZv& zxpSwnp!_BQWPMi@H7?R+^(*%4(Zj;akR&Jk=wj|&f?C&Eah;KN!SdpUAyjtDSsoav zERkhbw@gv^?OhB72k zqYil%QmClU3EL*+nN#&AcDryBR+_EkDl-6t7&23Wr9{RWZ-8&Ip)2XQo2!h4(C5Z9 zS*3(yW1SkH(=jQbG|%D|ipm!IdHmi2!9AKUhzmBC?w-0L0FaaE$~AGi!YcVI6>_D= zR`CFMeFi%H9`ag3aP`4fv0hqzb~kp82!Cr*H*ZU`OnnPBV60}CQTsLi$@e_;wrT_x z&;p67fBO{GT)QB`=J5wqDaJe6&{lnX8EtCLB(UYB>9kROC^{AChrU18QXSH9OkpO_v@BQ zo{@f9)mFmt@H%*+R@kO-$RTjUVO}reAjLPGb`CpxFK0PQ z?>A^5Nr-n6cB*P!o^Mbbm;OO73c`}Of-i=VoQmi+jv8K zgQM_Qfyr;fHpq?3g^3cbPRtSW+8p5gWTGT^$AfXO2?4y^b*torE}e5VmFoWE=|F>( z%CgC=U|EPpH9ZZ1v{`>Th`oZW8v(7%nh&;Qap?xt7qQ(mvtw;6zxd_cV!kq|s*{|% z%ptz=l_X%-3?8RO$W-YFuR@>FUI_;li2C{lcW%8+5g)Un=;0$xnEC*Mj<0_t5^qYO zV2vQ;HRU^xSJI`}{*e*g40!>wZ6z`2vNnr1V1L#$ zY+Kz>5jWojs=rjdyAdY=A#TbHMQpKXw3d|(TS8Sk&QD48Z{8#&Jn{T+#UX-0U4OGNIx-fIf#DOb`SeW6x7 z{W3SF)|m5ATmei{g5|Hv+iu%;ZQnI&h8b6|ms|;Q;PQ_XjL;l*56xGXRjoxzeF2nxFXd)8)xF8F*m0l@WZ$UYz86WH<0vhX@1! zgng7!Y2_4NuvzitVqR6>0cCjC>4Xs}Lrx-y3S`TVitf1^emD}JK($n=ns;eG z7k0k-)qwZH@+_!Q{YhQaEoR=KKJhWf$aK+gn}uNLIYXYW zNQbY*K=>c!*A81vSDN}hR~FC;No{eJ8@qVz+v zLme2X`c(PF#~|hk`&!!+1RFc2m$w1wdaw_ma1gWNhHGm}Mpv^;G8A9>;f<%!8+%w! zT#{_t;=j5#CMe=;W*bN=*JyD!ujj0e;A+u9pZN>&zcplM-Ka1P19TJ6nDj#`izSJu z*g_T9z=~9{G!O)D5=NFuQX{n#3CC#qp8tuw0t+lbb(8#+3fE3V$pJ0OOJO@TcA7zn z;xM{=u6!5S_w^JmP>YcKr7SQ2bBq6vvM{)Mz@LIW+r*O*$%`rMDXC3D83;7m05VIf z#4`n}56km*bzop;9Y4Lh!34pdq5X={%Ilk_54aut?VV_%`^YGd1IT{}AA(DI%FDQ{Yz#yb8li zi1sAfl?{BQgIPsher4caRp0AL=^r7h~LgRCWvZ=jLcR7g2PY)Sh%ZEmz=E#?t^BO#s(@+10F?UsZ8ZK^We`txY$p~ZQ7f;a zK`iPyLM;WZ8x;kIZ$S&-9=bjS_4eQ{MFwRu=$g+&$`{A%Q6+L5uUow%m=p~xfqDD`V1XwR|9(M%p;0qjSB*_*QjEO$S2GxvXO2&Zj>gk))VG5y22590B@ZL&tKe-y>5Ms`oMyr|REn7k9Di0q3=6bG4P3ML$@1 zo3MsbDV>nI;mkS{&B-S{>v*r+F8}~gchObI>2np1zns+lm@Sb_g;|*OuJ*Xb#e}tt zrKG7Jcn>oLpddS!MWhYq_)0j6R2|9#G8L3Qs4+h_Z`lisPCd}?7C4}D?E?c`nR@cS z!zY4gN&uHjdutbx^(8)37jh++FvA946hlN$tIhTH&6yJ{w#bPJkiE4l_OI;&yu^%a z%Cw@K1;fpeedfomNQIoen0o;VX6sL(7^SK~YKbAHE`AA(oCer1jO{A-4pE8V@&>N3 zA{*|Fj2wGjt+1Z5il{HB`Q0g-XAh;_+{vo;SbD0bFqW|(0ec&W>#$=ri?DZ+#4m%w zi&yc|Ib+q_d9luG4=2bH%)ZnE5$WdwERplwmMJbfFo#ydwmfT2tg$Nb6VdVl9%1RH zq*u0lhUg~fkc0{xlwTVPAXFbpRtQ}cnI;uXwts=UxCR3P#+n2Wv-BG9Z9I%XLz1j% zJ9Z>uIgJtsjFv)98+p5@F#en3tV*9&Mt}DaHJTg_hlO75ea7?IsHp(I_-JWi)G<@M zw6D>KR(-(*dqoFr1w4T%!cfNdtSp^k;%mo>6WDV>|eF#7`J zgnWw47`A#(EMCGlPD5zGSrIZ=G^>9+D;%A;F<{uC79ZvySA_&tT#Y2iR$P%^h2wzd z0%+|Nc!SOi%RN{0q6CdT&f9W7;$A~cs+w%62BI?&POE@1FxVdWNLY^NN2jM}mU?*I zvC6B0E6d?aIK)ARdA`f?{xhExt2;fItn#=8j&r>g@Z_s~qxgv}J`bp- z58SQU>~4tH1!JyQWY2mQ-GKSS)g-K2Fche4(`bm?qT$6<{4R(y@mb+!Pvg@Lje#)4 zY8Nm0OVl80R_)$65#BlDh0JI{q7y|2CpvVL{S51za%CBg_DvRVy&fkRbwEJ)Idt5~h10H>Y7ljtZT~svyM$Jz#VQPQH^st$eV$)eh@xmT=)$EQ~4rGkD!W3_c2I=D` zXBFN#vQw`Eo9dn>vM6VDg)C!XR^X75S@e4M#=1GpJuq7AfbKL%doy=Ahgjnp1Im z?Phn`N?RhiJ)YNv2Pw83&d+&3JG0p^CkwX+#?mtX=g18VXwLmFaC6L}R~UNi?8n|3 zd>-c*-60#SW%M+^{`YP80n9D^f2j;EF_;L3Yt7N`3H;Cm`$u$b$EMELOuFjfP*9U1 zoH0i>A_xGu(Wcc(XCMKaTt&=4K5GX-5?i3E_A4pn*Ubc!91>BKe=RnS^89A??(3E9YI99`+KuFWRAjnYM4w&bj=m|aI zf)Pfk?Tdn9uK2mq^;HD~Qo@%vQ#jrj3Yc@qlFs~qSh%JoXmQ0*w4J&96ew7p&Q#@l6119!NjGS3 zpTJ~+)m{kv}*Z6A-(5lB&Pp=fA z?`XjC43a-JNvV!<`)#?l%rA`Djn)gw=4U)j#6jbPCzW5!|NNNmX0gU|q+e;!z_!2{ zLHuzkjzomBz`iZF(=&?(ddf>p*7+If^+1h2Z(F#mTCEaUlsVWa+C2wN(T&jgI=?M; z*I2_qh`p;?&v4Ko+J|VEd5t$A)l959xjA_%jU$@Ri7MwRjZz3hMp;k3p?>2BA;rS) zKY5ca3oApB?@%9|bwyM_{e-6^Qt3-ExV|b6!Sdz0`;p$7aUpG3_p(MYw*)>w2R%aW zCyWsJ^=g-vagy&_9z>Q2qgBMXF?%Foq>d$F7L6271H)tZC~X^Q>LxrC7cpYH@`M`< z1oStP`Su=lr`VCc=JWlbnk&u%%h8%!o zZHDqRP305e(SPZJu5s$PrS-iN(WS587*-{lig4^nOeF~Y*Yq7Q7SLa${rjuDrEwnxO; zGgBB5M$};WzHS-pSMYsydu)wQ`9h6*@o9MjMyY&fHkjw|4%HR5-Sry5dFtWvOouy` zOfc9PRZ6~qnRw&k$%}%e)NYX&;3~|z4`I}uCoGag7)=VyzHN$ccQkwSJfF3pvX%rx ze&Xx~dC;P;EZ(QUs{3F8?Eayg%sU!N&nU_F5)$4T-neCeZd~!!!J_X%;4<~%4(YKQ zOhcG_lo}0j$DvNnA3o(D&l&s13W$FWy|{DQC%zXKs;#38D(Y^&TZSX3?5g$u@ohxY z<3#kn#Y5TG4E@It_|J2%N5g`(G@rd%#Kruk?pw!%2U~2X5X>%FGm{KHiDvn*s-R2G2q&15>vVE0fP0e`nShSeh9k@6np8SmJT0#s7C zy4Ar2BV8NS`((u5Hw*)?(5{6t4MzXsp5r4S&yBs%q~f16?BG!N1CVEhd?hvyJ@=Y2 z00gw`(LLYOSfo>!+@6@OjpEnGt#ufpq^UMY_vsSeqs19eo}lB(VgW_g-gt;F+R8oJ zadsDjTq`eG!P)!;WTm6MKExp!T+zwr zb&UbNYvK0I!1?=&^I&`kW>)@J){E<`%3w4J zfL&mf(9iV|+spY(;?gGE%-eaqR|yvli`~ui8G(U#M;UX|kLRI=CiQn&Oqi|3cA>sj zcs5o%nDvsX^L!I!QUYjUI(_%K1X0&Pv-$L-A|RYxr?FWuL$9ut@;x;|V~AYSKJkKY zN-3o054o}NXpwh%9q%$p$7wI!E6rlmP6wR2LXaR(ntHv9kJ9DjmOm9LIOSsL_4I5n zpxo3CNlzF}fpf?r&Pfl%Dc7GGphF$_`h8!cFPlwNb)s#oK2~<;TH5;q3Sk`WCP>%F zLq|Re^)iECvmK#i#ANx%R!~3hpLgZG=v)aZP$NcwH(RzNWX}QM0m+7%2gaE^A?2>V zSO5ZRi_MjFh~}QySKJ6W+KW`{BM(7ljj*4&xko!l$X6*uL!l5JFJeke?U}!A&P5rV z*(Q+U(ENf` z#)MV{FW~-BBVtt2+}3SrUD_kMpWWB4NO0%-oFuIeyY?P}gD#sG;r68OE-whh%W=ly zmNAytLf+snG)RmLb7PkJQEbD#Gn5M~CJn-M!0XluOHDTE1SZ@nra)=${^cR*+XlM` zUi1g6Gi7Jpo)NW^qb)gS$C2c7BBJEf93&td6WF{cp(@Oja8yrjkphyY+q!qp#cf4t zEM^O8&7zq+4-i7aB>i^Z6HF%!F)m`cw)ViH`L-#?g{}gQTZlbb=&=3XtzsV=T)%Lu z@AwL{Z^no;t2u9=Ghwo@U%h~MmfXy0+?(F*=Mx&mS4e&7=yfpcIv5e)*@bU3mL8|1 zH`%vJ;?5!K@=yu=KxE}zZPHnS_OkIFCKbXgw=no%`qcsn3#9CvVHwmY|=$cLs->G~aTqLNB1@&7>3 zr@kLaUlyZ657smel7bjwStk6qmIan4&LS`ixdgYk;eAb1PrKFeChmq&ZX{)cP3WKH zRJe~RnnL6)K-KW|SE%TG;-t7XqA(-#aySCzo(ZP?)e%#C-uvw_2Mr*p92l2bGqT4l z)8wzET4~V-a0|}FAO?yLsGOgnJIzv1qj2!@hmc*8_6x<@%U+xX5qF#(H20bIBAnR1 z>*>7{ev+wN#I)#I5@7!r_(ApGREt-Zi%E}$zF96#G%Ya!zZoH%%jQWR&sdKAyCMNC zuW99MQ%rpHz1m&+aX&u55Zvw^Hhswe+a-hTgcmTVV1==u@R zpH`N6TJbi=8vWra{-3I|i3lY5M9E9Cwdo?!JcE~#J;7Cu8m=0!g6aw;T2tc{6cwmE ziU{#g@!`DuNH6$WG*OKmM3S=_n}>10BIgkj`bY&z9|P;=e&(&0&C5y+*G6yOcQ8Q+ zv@lg;Xq?*9Ok}*B0??GfSAm&Q5DSuB2TlY7X(^Z`K<`U9Pybj3%IH89c znXVFFb*J8NCUrI?wUD~`bXKe{b&I;0meCk9tW1|CHLY5GdGGru7y#O_W5n{+k3n%z zL|;uvU`a?NP|<*OQyX70tT7dqrif5-E?7vUKXS?N70OPgg&cLgM$_J8o0sDO=kv)f zH}e6e(nKaqK;X8nA-bvlgYg%x0fTbVVu_rz&br4i+>1ddYgy@D{JXIANnTGNLpFa? z7dADIPBW^Y5jJaHA(VI0j;esd)1U0}iRbwb0!+p04h&GBYhI&6O!|BQ!%IyWU@g}( zhb~22EymA){3uv3X^G+KKk|RbcfN6~-v#&-b>^M07j7Hk=(`?Z{XwgK?1^;dn#l;r zclX4|Jn$O{{}#nXN85*&|Cj;&%*SBfLMG5Yz>#P{mUa-J2M_d4YY2AF$pG1wFJ>!n zogvA;L>|qEn_iQhC9l2Qt#70157u?8Gp!^SPtn)UY*n;H4h|6491_Rgf1<^GpYz=N zp!Nt*$L<%y17@!Lm~Evn4FvRa*6zBozP@!+Pqv))NCQ_&uK6A&j#;C|CgFo>47Bln zl1s|_)Inm*Kcrg%%)qYejc$uLc(3P!^AL55g(J9WJ!eyTr7`e5Agv4o#9~Nqg_2$G zPvxD*a8~*;+D7_&Z-N-|QVZ{Bj_u|s1To}~ZGpT-N$B8Db}o?3NrIWt!6Bf1e)1*s z59)z-o;p5L7X@4ap4(PfSh7d!uzORd5_XeP@m^iUH0pf3PB&)&6l0(8)~^l^K-9O*#@h`=U@f#rjg9M(hZeWTS3zQH`?(KjE5Q8E^RSe3eXH<>2RSH3s}ei z#fIcgWeJ1+kzgzW_3DWb5e6&)?FylsFbWhzrW@*sh|WQmPoqxIF+kJzWRRiOq==O%QR16dcez zGI^VFg(}@U4!+cX*I+reiD>tFI7!T@^YcGtE>sG+G_&!$q@7dMRa(p;-X{G6uYYj# zG`DQOBZ=oq$PD>oM}@Ukz!8^)F6pKy@at2s#5Q{cXO0q4uk8vCh$avKvSS>Ty!XuL zfOV5<9g6#UMvvfmjr8cZ!Oc@n0F~<4$e%L*=tgYkc~Z07$AK{gGQfQ4&Lce=*JfX8 z=lp+tv*I0DB;8j)lt`v%Q=$k1;p9CF^0;%7KDF(OnZe9w`DK z;B<9Q>(p7-4tgD=xp+t&x14S4wGvV}V^zL0y9bHp2TU?4s0D-;oIyp!=S;dEuX5?t z7|4ZE%!Cg+gRXTsFXC!Ock~++$^nCWtPw3@k#3*M&sbNn@0HBVDGbB_2%o=a<0a{s zUf5tkKfasXM;zieJmdV+8*Z453Z=E1Sit&@Z@zqfQ4(Ahn?}`r+fN^f9Z!_lmp>Ga zbiTa?)(4i&=caqJ7ITb}eob3!fSjC`)?zfqiQOdxdK85&^ko}7H67t3$HSu^-Hq7% z9jrs)O5{X@10E!xAB%x$v4rC+<-KR+a%0`fSJUeVW(3)2?dNZn$0LwFnddF{gl38o zI5>M}Pq=Ile?cXm8bmdBx^!2Mo5kE7^y`3>3``Ufldpsef^aLWzbbp3l$MP8WDj$P z?D4MT7GV-M70v0#bf7tHZwsBRQTh=(vM)!|ni=sPT-Sp%q&xs;>aCLtYBo15kzC4y z*UWn6U0HaR?fr8H^q==52OcXM{s7HAT!dRwH%Bu6UV|AL#tV+g(m(l4Hnt1{&|F^! z({o#wE(~{HjOFeY0{!^YNlL{#=9pPUsKZWdzF4=hpW0ppo?T(;7H+X=Ij}SiREM5Q z0sg4l(u8on5U)JwA$6SvR6+o`umR-HLyoQ~jN{C?_h^(`4(u@}zd6@lFdo!lN+LC59(F^yxbw zE7K*FJrOC#PFvCBviufr~cq$mQ93A=~efW%n%7(3SRqNPjSvd<5;{!AW z?t9Zg0xjr>aA<3`YiN!pvd!3-rw&V84^n`OSTW|Dt^$GpyDW<%*`sijaas3x3_#AYg#xGd}O5i3x4h2yb-oOk^8wI-YKBjI8u2?L-^*=!wD-+bKiDrOg}K z9*b^vxQ@=y4=y#xVO`qvxZ(b^Y}a6AI-jnlv!WRLKHk zOeFeH6R6JAO{IUCRY2P$}h6HxN_3Ab@BSQAJK`Eb@8#adz z1HTbTZAuxFs#ua`?q;gc5k*9gOcbbqIyCtCPIwVAM)};vN}%#|ggeMC{()v=d?&<% z^-fV=Z8_0d&@HCocJ}gIPVGUG|G$zd{Ri}&f+u>vG6e=1$C=cgJZi#kBC|AE&ZE^_tJ7 z2A&YB^hce6jNfh<$K*eNID$VD-`uSzHhVaU(G7gkG!en*{PD+4EXvbB0m{V&fh$3P zRtUnw62(`ZXp&CW3nzs~VCOgcgPSqw!{^q97h|P*E208xCA)XN+*mL5jlaUmlGX4m zx7qT&`!JYqO?EP=oP`>!Zo6{1n51%Do(z4H&t?adBv9vmA3W!zKp9IwsD0zy>p%I%#3Q(WUvqW$ zAWn%LSCV1sD!a|6Jf%8TWDA~nN|AmaGQqy#5zP<}B4_LnvDVbh}v1A0I+{JDe zZLp*B70%{Hsb5Fk^`HBKqpA2e71$?iLTtbxW)V?$Wpr;T;yS_Ho$0ss(^O2QrlE|> zb)cEG&d}y>#0f=f;819&gpx78n}+;F?@Ww!8$%xNXNcI$L%WZ~u4tg>~2O7-(C$GDrg|_ zK;uu+sG#WyqXWac%`-_6-U@k_KvM}?IE*7@Zay#>fXRiF#orLQ^r&RRNL0Dxj}0Wc z*uj8iMWKY^HB@u0g-Q<@cE_!NgNSWO_el?iDG;;;o+O=WPOB`MY2YyIQzKDrLys<= z9#uRkfgaS^&RZe8p=X-OYIPs)owp{iP~jTNk&jNNV>~|NIf++-cw=Hk9UH3fUs;z| zD1xLAx9Ux=wqAcV-j2?q&1MoJNl5pdLw4|!Ss+{-^n|;rr^dFV*wKjjfge<962W#I z^wB2Lob30;jIk^c0%g0(f36r#LG=zMHkMV95Dg z1H+3MTQ8ldoEGrx){Q)7UVy)Q2astRCRW9M@m>FeercUAny0>)CWBSo(btMCR_OL} zSj9O|4#X*lnDp~H2S`KGj9>*gjX(B~IaB_Q>kLm=wCwjq?_Bal?I3(cxlsTVhS3V1h^Y9x6y{-#H8tBOfLoY(uED0E{9Czc|DS{7m$vPT z`q;pS(G$X@=K=p;^#BTtOV2T9O8p|)kN6cvy*o=p9eoQ57jA0B9r%WCanZN&ksrC5 z@0b5O5s7Si&6d(}>ITr~&WyQnl%RBSG;aK-MlX2~C&D#or}I-%WB;r%(t3qE%#}H{ ztc!gMX`wa#SOm2HNU`<;6At@eSp{SWqy8Dy)-1GY6KI`a2Yk&Q!WzmmgA{`kS-9ekOZC?ZYLYnh-6a6YKl9|_=voy2cU;1TISQ~6dm=QodKls+-cyPW5im*Ml`*=m}-CGpz(M^TpxPo41nH1~sq?{uTG18>WhVJNC zC#3;LVaGdt2 z{22Gix=jIQ1qPRpD$TcjbsS=iKibpkCD0NJpzwT&+gqCiDBK5>>CzMpZdoFFe5Vtj z736yQx|!XIHtZVG)$?DpQGJdIbyoDNEo_9=Qq0h0!@Ww2Y zQz`;zmj0-#H#nmjcE-GzO0IO+(Uz%t?l7wdP?<7%m122QL_U9?3F*u+G?EU>xzCsc zM+>pohO~9M^FBt`R?ZCU`X~DQY9mD z1@^^Y0u(O_up47nD)L?K$pNO~lF9Bs|7X)sW&q*#e(l;_#St)WLQLYcI}dYRQ${=d#>huZxx{O3)K z?-FO-jZo&BF5(QW!mO?iZ{<3cRC6U1ff?8y_(j9$U|`Y?+^K$&j7r|=v6?lJATOV} zNJ+Xl^4oq}9`n1_F81(1%gT;-8t7`TJ17xf(=!;8}p_b0WP<%LES7Wi}A;<=Yq5V|%=-%+D zo?Ef?&5SoV)x-DrAMuSU%s#Js}UO!~S0o6|(T)=RAddgN#%WHM{mIj9_=8?eDYy zM06fWqOKVrHUIzR*|6gh@q7VTl_H+T&aLN}nCQlh9l{QKdfrp4QNb@?wESZ?kO$OF z?4*i?a5#Y!EU)We$xKjysxLGCl9k*&lYg(!&VH}98!FQCuX%R{8%mg)IYyRW^mvyl z*lFoEoDwzh=33o&x(9eS`o<()eP_}<;(>+DJOQXiZhP$gLv6q1E@On}#==ip=qD6A zc9)V|?4zbB05LFQs6~Aq*nzOr!a^K^6ZhviiAdR)+Ciov#lyf)Fl*d5UEaohLu^LocN z?G@RUU0(vE3|@MO(3T5gQeFFQCXd<&@?wqu8nB(jq$ZLHRp`Af4GoSEI8$N#jdfhq zg12l1u4P4g^`!cE1A>u&E4A1Wm>WRoCo*~~Xh@Ia+z<230FiDun)W_uDT2ugeS^`G z-7B>wzCdc!puhj3s)B1?Do5PfPM@#Qdu9kB|EyUv!+W<|97|fMvDJFoq#G-JpN7;E zrR$F_qC$SE3fM;gX;;p!WSk21gomhAe3bwGm!vlkE97d;$GHmbIJzVh*n~Qs-+c|9 zQC$zf4F|n+6(TT8YY24GRD>wiHl2i1_hFR-hR2=~gK?#Q4D91ztk9T#K^-!{MPyh< zOdr)1rkDg(vd%B~pl35nZcqoA$N$6j0OCi(io2b&=nz@3)xFV&Q`+7(;`rFQX^@WW z+GYi9SRt7%md5)xzfik4#Re<%11;;%Z)ul6vA0)0t@96lug_fPj>r#Ye30q? zMitXGuqbBiUaq&x43ffTg3r(J2U)xkfApx;WhCQ-R;A)XB70mBd>=cw!~_IKVvy2t zf|FS^%lw#D0fX6XN__3V?N|#A7JXH%682L$hS8c&>!KRim^Ml?yUtfpBc9W=wC?{# z6PCcM(S(r*oKg}8>^McTM~K^ujA`7(L<@RCl$10ucFp1dR=ef!|20Zfp%r}M1;wv{ zlyFH5wDP>|zf3H{Uq~gfOn8ROuxP=9jdVirT4+hQd&~Sh+7aH?+boKNcIj z2ai4cu5 z@y9y$1t1`ig5{?+#E@H2?@EjG3=w@W)2f4+P3?Jx5}q|oLRDFKDIF)z-mU-y#%r|G zm}2Wn^e3w?>i`2Va4bf~sP49e5tujGdZ`j}LsP=tphQKCTeElI9!1;9s2Wd{BaJ$* zAru#`_xy{A7Pqpdxx_EIc_Z+-G)ZS36IB*SS@q!+kBa_agu{jt!E?RN5S~q;l3EWY z1xVmmTZ5?6!P7mq{A0rPjoB{=@?Rb-U&4G6gAF=G4|D7R$DsfSZ{XLWkwa1!H4F zeqvY^&BmV^3M{7DjghuZA1A0r-FuXMwFpNqcnCTq$=QdS#^oVq29E%-TQGS}_H5?l zW2I@g`<-1F1|6n9E@xNT#zwU@x*)vEEhkO~8}gSoN{hmqq!WRnjp1FEcsdq?v>EfUlX$c! z6)DgjQ}K@g1eA`tyJIs8HlMR3;7MLvwo=!y!inD z*2?-5>b~=|_anFILNBxL{>_v7F1nhj{h{*vfOZOAejK3&5(gTHhTtx_+p%=I0B_Ev zV`6!?6!MNn+(zaM=@$hop~d3&6@yx%K0}eauKwYc(10+(Jzw8h1OK&#?oq_Sq{p%D zl9!WwcNs=(wSef+wNqW`y63#**YE+l%b^(|EGz!B>eGTyn5cCkmG#@-(oOVe!0|G$ zt%vVV_5JU5KnXz|@3ANq>j;QT`<1-RkiH8;k$^TtU9?Dnd-HYXdHrI;%1JH?B~b;Q zk#b!LzE3kLflYVG#c>9J&Q{#+P^te};IYO}osxGyq^w8yl#ec375K^d2sq)7fXmaH zF>$}M+JWBP*&%zRbU1Gw%ADuK(hrKnM&uQ7)d@MR3TNDLI%{O<*$7S4V#&@?VIi28dR(qZ7#l>*+1KHVxR+s7KZ{coJObeTk#xx*nflNZ~PpeNR?r;C$?TI7viS`}}MGS2O@mKj9MX51_ zCdpfXo<-|w(cd3PvaT;|7We1=Uo{f9`oebu!Z%$A)kzX%j)2+D40BC)@0Fx*@0N^L z@7NK!2^!7CrhzR5HF+=(0CxBI%av96!D#}gly~4{ zzeuNSV81Jf=S^U2ZekG2Kq+sgoPi0lfm2xP9x>0M)F)#s8;#WK(X$?SGXR0TL_g8V zQC8edL9J}Dv6)K8gm?e|0|83~6A9!R4He%2KtZLO<$KBFBc12GvWGZ07vFVqrA#Zc zdSqYT-{KzuGXMYwkO7|PX%L?P08ft{$ppXw2bdu#OPiKhnPY1w!g+d)XkvMiXh@0Q z00Q}!f{TaX&{<3_#(vYT(2?LRW6^X80+!|AySXChAQ5VXfffz`5{dL$0gIpzRby1t zB<^4~g&IBC8Z~f+1H|h&W>MttJpvJP$@@~mCBD!+T2v;$QAEgse;?I0SFiJjIg!qR zySx%7G-b}sn*gasVvV>R1)EWoV5cz^pY%V zbBdon%jaxpI3xVNNEMOyanp0Rabn*bWA*)it;6dmPPE{C{z^D@oIW+o#Mj>ssD6_o z0^2J91--2gWQh|j^6e`M%`)m)(vB^a3-Z2LK?UaRG!tK7-`1L{S2_6>9V9qsnN^?} zQVPMdTH=Bj&MoJ8UeaP3UFH%vg|VU#kslpKU;+j-FDnuKg!rx!^o*XH0iFr%i~fz$ zT*qK~V!9;p#ZQ)MeKQrrB+8;q!0B8_P3p$B`54I@5!KJlfdJ<0$=+ZHOVU!dpCsh; zcI1LCs1+wLzE|KbAKP`0>sIu#b*>ccuo(HaGQQ!OX8Osim&qd5nhWqf?x>A|- zj*Ks5bbJ%OE5CrBT32!&Fe$X+{8{zsH#?=yc+8w38Yr8Wa*s z%C?qv`>sSZlwnRB``?SnRSXwU`Jok^H|?tW!UD&SbLl^Z&!D}_?8cryc8iB7AL6vZ zD+4;Psvm9bJctUJvKK-EGd3&sR*JQxv0~mc4f9fUHEQ>6tJh70aPlJZR>WoXZL5F@ zOOP;&S`LFgl@p1%=G!rl!L4#yF4a4#h*G&>eCbPdCM#8Gv?9sZ;3{Jwa3=O=4V<;S zQ2C~|sqlryoiYw_I<=i{SW5LlK>7i-&sjXE)v5wALn3!^pQcgzJF{F}=$&mn@_d^2 z(E>_vy~YNIW^Q%YIgf8)@*03NnG2}sg%GP0Ru17MGb+=W5|{ zmJvR_?G*VIDx@wKJF>MD;A13#uduV!ncq2J?)is1;vQ~yy042YFhSb(TY%M!Uit2I3GN(OGc?7qb&qL$mGFlq-)Km9GMvoq_EXr zEGua2be_)IdCuQ{9ws9{N0G%b>n>DlmS{p4+xL$tXfU8#3OtJqW1IJRImc$7OG#Zu z{nas#c16*mhTeCnlgOwGkS}?qo%aY$ymGM!ma6cJli-B zQ7VyHS6;}+M4}2+87cM-P`8uo%c;q7h1pWOT#8tg16PnrYGQ5EN`>(kGlKpRM?S`- zw+6Cz327|2=J3KyB`5AR>2233mPIk{AyYI<63gXK4@s0awh=72%JmNqoG$ePSV zs0uokB5y@S2Jy@D$qDsd&E%p}CXMh%q6_n74b30F7l_4~$6H*$Dk1A*Tm(((!bUNo zH%ubg*RbXJlCUw=;&N>q#9q5Q7q17!dH#r`sl5#4elCkG`lJuo6yA6_b1@#Jk9kI`CS4&;zm6`?A zp92Of)67CzSxuX;L+iPS#LMsl2uhOWA$D^Zc0y8822Dk!k`A>+ob1dbRjU2fcwz=T zDG8v?_0|b~fBn=}uEWYkzOsmTBsxYa|d+`MF(jEl~)p_mP&_RrvFy&6J5HTmk*nb=-f;aK#|7G65-nY^=gY7*U$JGMuwi6 zWfqO%1}~xqXiKNYep(4?d4-2CQ7()1#N*MQ!~=NKu)T8ba&xU@%|oVXJ$lV~GePL! zc`54e?D*%F9uUBgSGF4m{tHi2_aZYnF;PDPYiGQ7QbBTGqmVaUt$>u}j*bmV+`;6iI&iO5MaQG`X0=u>U8AY7Q;&4{ds3oj2fsZzdKO#lD|M1BAZ zW)Kvh#|MSdH>R*De=$&ulT@VC4q^%v@c;k@R{@^tZbE+m08gMgMhdYq4>nS4PRfI7 zw^*`{Q6tX!Yra!A4X_>^U0Vfyehh9|wYRaT8R|Yk-vF=z2@ZLRN77R<(uOPIbRc&o ztCbW52~$@|?&eu7z*tKZfo8x}kl~Kz00tnaBILs}6Y3N&{3FdAL>Iwq$93ywCn3_l z#2YahN7sA4Kd?jKFYkMUHJeHRzzMM2m=t0xB-(YQ&;#>kXq=P zo3`rPa%kc~ulnp0GI*JHD*m8VUa>?5zjMy;nyR@dw?tYXPj;2)!*8)kt=Z&jF<4tz zJB;$Es*JgQq2;Vw=!t9~tpd^a_ush8wu1`P4LgpNrR2|89%<$^`%zdb1{{wqa`F;y zje-^~+H=l2tGCF`vMC1?4tYiVn`GtaimNzyr2G7>Rc@ zLJ^&p{{2z34Rf@9C0I(j1ugpE=lv|WXr?qrA-ew(I&D$kHliq$B+Ozo7zORNoc%>C zJ$RPT#mF5hFrCTIMQDmgU0-CO%=rLAG}3W!b1cx! z%*=8s0|sV1Uc$z9IUXHY8zT7P`?&l_%I8Ja#;1p=2*uv_={Q=YdpMCt*J>_N-^3>8 z8MBIta|4W^2CNU4K;C!$Uq+B8P-@7q1}3Gby*uN`p1sY5x0~8>3j~46XC_Lafk9s_6NAy#N>jkZjv)NQMH*JLppNi?F~+)Ko7@c*Cq&nft``;B5E- z93>GtFsm)VqR&}t|lLr3WG4K@{MNZpv|QH7ft0Js%4F_s%&59vdKQ`buUgz zt`;?4ftO=9wkN9pal!1w8u_g2mtju$YSwuRE{K!I!ALr^5ID4;!DcPBcht_^>z~<( z&!4)xhPV%ewxbg^-~2$)H(pC#@aAXxq$kpl=@dFobm+DcquJpHL1SU^J+msChzG9i zmz=`s9e@2}z+}jkaz;?B=zcqng#S)>R0W=Uya*_Ctfyc?6A^1y}Z7iJOd>OSNHzrZroBTV&oD*oF8wC}P(%T_To;RC4CIOCjZQ z0X0G&E-TtHIwRAj17!0?k(D3($TEU`OQ;*c-g(IM(g3H|R; zi&QLEibp;y^RL0A>i9n){n2S}WC>EdjWhmAjM@z=;ze!<>b38PltF@DwB6vb#ed?$ zkFFTOUS6qIUlf=g=d-)wlid1-gyIpXMUZjm28N=*A?1V z4c|=BRxl|!HG>N!&69(1rb?L)Ri<R!rZFF*m_$JajTJLs&Ma2KHukm!qGUr?s$`+-9m|)fCJds5OUmdJ;{FQz}#M@ zAFLMB#1`!J!vy2S8eXJRVy@M;L_)wAOXcW)PL7MM12ra2H zm;^Wf{;E{~01i0H2KxQjzfFxbBK~}R=AEg+i*wr=W@+8Q&P>4#Qf`sMQX=Me zCb6InG4FDmMC?F<)cJC7bd=dQ<~kF@sL(Qlq*bH4_@_%>nXAFq74BmF?fQ`rSwGOv zh7QG4ovwo4DW(D&wh_B^`fyP zZR9Mm1O;%vy^n0Z`7z@IdyWM8YRHSDHs2P!EXv0I7~Dm-@Fc8(@|I_}kSUdmgQzYl zhWs0u&Bx8){h`3K)x?n2X~F?B!q^B4C$otYjz1f`uo7#R8yOtN3fmA?@LOL{72*3e zVbVh*V>6aXE@dzn7J!SLl>;n8IEY}2?Qb>ZnuvhSIMd#+KeDN7LAz}+VgBn*Yuln6 zsfkTD`6nP@HqE&fc;+R9S=b9Qyi^Zu8=YHck+x)t_+D(%VJ@_41Vm$HzgeI-ktVGD zI+K^r*;!-w+l~Ws!3Rx?e~X6GJZRG_-sWn}?BCHuv!sRaKJ~nYK$A)0ein&y>|AEv z6i5nc6Gok?UEcZCuHW)9DJw=AE`u8Ol9&u`N!)89eb_7P2(B_d3(Hmupokw>{G@lLFz0&&811&G_L|nRV`w z`tkKJ)K3wdhIyN5_7_*NMzGrj3Lsh^`Uy^n97P^TL|IdX@0e8_7LxhOR8--G!V{|? z?3+;5?v7`SMP`28jnyb3cn{kr*i7&640o;OCINOFJqeKBnJ60zu8IirY=jHNigUM2 zyOIu8`5hUlWX^lxJnW7fbXPFM52OX9TGK@r3cr88UaefM?N^7%rxL++(UhvsfbW9M zd)razay}%tVUrI}tG8~?>XE1tcK&S#gyUsxK`0b;pP%dOGOb7{WO% zN94gjNc4p9dZ2w2Xv_k;bCAa5yL-V^B(Jf@%I}AVxgi9+}`3OV;s=hmI52g_QNbzZ;1^TYQt8_0=<53zFI^SG;G}?z2wDv{?AWK4R zL}}{yRO%&)lS5!Gd5ENA2-@KU7SvpwtQOsc<(Co_u{-&tIo6ndy-TGLlvyQi(dRu5 zD#O@YGXF#+yo$9OPI+qZ=g3=yajN+om4${z4$hpjEujt1-sKBB)SXX@%3S@+=QyIdJp8eko-17ITt?K;#XC5yz3`Tzy$)QFV&$ zgAyT%*szYEVXKScXp$LS6Z*Z?qGAg9pBYk$H#60iAza6nqcigJ)%C=!w}Se={Q_|? z)BI#j_XX~g(_8w(&~`ypqA-^}{vLrCRj-R;Eetcds6Jvg0R{-vFD0T3rklw_JIOcg zPuRcviCSN<$iAhtVrsnBYev*X5NHU9%hNL4C{!;gWKG={W8?j&(EQ7%W4a!+>!^O% zlOq+i9K+g{Qhm>5*$3+i2=RYA<@>rD#gI4bvFeUl;{4UjnC|!=4OdU3lshN_D@2jM z^CD_HsxTl7Xsd|;HLkB6*ZQBtqPRHUz~+nTk4>sk2n|j1Mj%rv6jUjtV2o-TfuFF> zda_h$Nip9@>d7h7G=h*0>uNCV;O6o^0!aCYkjFCJi_xk@Efe`g!Td7m{2$)L;8 z?*DoTi{XF1H{sSg{V7Az|m zoS?mjuqH;wiNoG}h}XCJb7>eiOY>DL1-N3w`ht;%Miw#g;9}WQ3#%9GVXF@~Tzy1_ zI=V9q3gWWPHbkL+&o*+8q1mEY5s7Y|Bukx=4JuZtrxkSp>DS!NpwQ8;moCmGS92Jh z=B4Ni-5P>ddU4D=`fsaF)`sN6??bX$0IGq=o_i@Cdh9ReZn4?#nG_dfhvCVr&Qp=}wLv0Px$eltx7v*+~sz>wG;7s8oE97qPU(ESqQ5Wi;!*u#- z6WIZx#LM(NI^7+u1xe9Lhfb0F7{_jummVrYEDL>i)9d9vr>e|!UAB~YgUg?Sh13oso41PMA z!giseA5f@0o4S641zp(bM(%kuVzBcApQ}4CIQuHY7J!Hn%k32G`dGiDofQ(Ts+cn- zMAdOVvz=+6Uo_Wfv7klY$fU=AFPcZH-44RKf6UQe#~JYEP572tW`bzsKRtiR{Q)1l zlVwey72k*nGYA9leNDF7EMOvys{70|>?%Tw$j+Sp;s5sdnd(-&OS@F6VJnwOuJnkL zYQ;A4=7~W`b-5w4E%P|QKN#v)^8Tzn=;dP+!HvY&sAa5JU;m1O4J6a|c*M;UlS~Vz zgc-MJl#|+a!tTH1uPo$>SW5UW#Z7YF_clNN>ZzUvt+Ro$0-_cs%`$2u|sqaEM9eQhHtwgBbDeJSu+ zI(2U?*=O=<49Me0mQ@?>wa6Wn2W94;lhOn10vdSF>FHLqL^@mncOw%aBEMOBoAW>P zem#@qiCO>iQ@(R*4-&Ewa?JZG4?#P^d-kI$-e5{1fewa5-xeJ)3C`KiIA-0n`3 zM~4Mv&#V9`{u{Ydn^MKz+L!TdJmcJJ+54`cF@(A^w>qP6IK+AP-89`NsV)ILLaFn= zft9cKtmG#D_d;bNAOlnb!3fY<9~(%RO{+OU&JzJq3jfoK@qxh=q8@qKn| zpOS}eRH-doq{PqCNy*s=jP2yf~9;?O>*Z30+aQ6Ob zmImAqh{&rv&whkx9DFoBhN%PmrocX<2V27}e?A0NK8w$$zl@BoT>7@wRvE8 zp8^yqkPJQMz)jJd-k}Y9&G~P@E!ELNLo^<^ld*9?R!3yWf3?$1tWVx)RAiP=q2&7& zNDSR_W;~#kS7SP{PLC%H&iUhADiHX=HAZAsOgCyyb;Si!V1}IOQtB~<2)io&4L|+) zO6jk32CWNcva^`(1y!FZJ}i$|R1hz`8|PhO(KRDbY^%C0$0O(nfDCaCEZM?G#}kPt zq0+YImdM{6EEN~QVG4z7{o6#uy8}vOqf}$-jVmc!43*`83jX{r6+>u>O0uy?)4P!Mec$4zC zZlSEQ*{L-SN_XD;WIEvX25WP)gs(o52bX5JN6*duE|;qxRCzb)?QbYfO+fm#tAn_B zR@r_iW62)q@|ZdO$5s!o)z6`e9VJ?SQaBdmhL$%Ew~$Ew^7e*B@cwn&*$r|82)*`CqnF;|zfpi(MWYrx_@2Xf!tq_kOz|MJ&$I(2%B zlQ#T2E_(q$k~hsVZgHO{dmOmgqz*>^b2PSTu+)KQWa%Uh!oJ6lY@GokLy3WQ6t-qV z3zhmzAwM9U2&#L-sT)2yymbe~-NVWyho6VcS8lTf2LqnSWQ1ZDDs35E;mKz5=e&ob za(HbNLiGi;A}C+-`z~n?K^7J^;0>lUCNO*2P)ncSJN!e+^};?#Wvl|5wl8Afi4E^Y zewj(&j?^I?@VCizr<(w`v>4wTJAJaOAjY`b7fAFzMs_~PT^j)@bYL9S<+!?@ z&GcIY+=d%3@6!`<#NsLLd=&^8oYP1k-TlKxRQ^}AtM$eJ&ISf+yzD%ICy#cjFO*S zPG7(`h028A1GK`dZvybW;8c*)M}=OjC8#fro=dIUxqI z`>twJ5c#y+k6ZgAh+D4}b|I6fQWA8O`*?h(bb}@0#qX*x^7v_UZ8XOgj0U=|jp+@_G$`)*Vf~POxhDLci(}*sV276XH>{P$gSk^LdP;FMMaU$?|EEbc+ z%|qSPm8_bZ0A;g|F*U=r7g=w4!^a&owy~XG?hVa_m>#C*(hkN7zeb+1^}D8*!$ojD z;7sMJhF>;s5EdEhn&^oq4a!0o_TV;k3zrmKND+QC)TSO^2^(d?jhRmwJ6d`tTY?p$ z0hsjWtm}hE)4$Jt&5@jkv+R~)-ji6Qb3LF1;5;x z@^AQaMHF&2K4!j|{PHHZFKg2^cwg1$Wx*viiZwMi4>0o5X#LfUykKvy9te*0(QBn5 zFf1XDcCnjTBGClXs1&ef^aSS(s4q7h&4Lext_#myvwMgE|JSOtby0kA2=qkNt*ehl zJTeyKSS@nO%J40N6hP_k6@v0jtr+{7i2B>yGwwpZr}nUGkuk1W;)YPJ*@}_+*6cTq z;PuqY9rZHF;dJWovFStf%O6dhyV(!;rjB$b3|40a&1wvOJAar!={~frNl*HQsj|__ z$tM9>bv--kjUNZsW%iEikQKt7APwH&sFyoHOXn9|RZp!pT+veoTODv<{|xCGHk=kg zBO()cM>sSynEg2e&??lrM1zlHs_#^qDy?Cvy78PLfI1eP z-5cT5URvRQZwwu|FLql|HVpFr8P*WOd>xDq2KHb2Ty~4b;6Z+B8}6XE+b+WAJZg&} zoOdoviuS{-0(98Ut7LcQj4so3zaB;NN{{Ws&o>e5`SwRa%bcTc#B4`G%pdNatz&n| zzm42Cc>Woq{v%@XW~KcqV%D z*GjKdF-Xq{N-n8eMxe|cz-37XRg=Vw=bZQeK8Z#?H)EUN>e#~(2ObpHaYoZn_o@JU zK!m^ijtUe_qS6qF%c+=-=-eumYQ)xHdC)@cIBF*&X1lT zVSsS!E(h{MyX+a=u;wT%i~7{*hBBONE~2Kr&+Pw`JhJ+hP?*+Qjm8J|*h3M2vUB|N z^i;gNIuMKxq_ktiGYDRG74 zg|Q+)+L)NA^E*a^)v}xf1Zvt#fPMkw-MchnF|y-6Q{!&X!&NEuY?v-7sS!QK0CM3- z3G9at zvNOw)YW`;{9z=*!2X5X!&RFo3bA)_mdXQxAG4&P4<7c7LD3-%|FJ|Kqb{G)Sh^^LgZ_ZAv*Hu?8Dyyff3exzqoLQ+wRr$|8auuov8feP*2;0dTkxNn6*2;g#L6N*=yjp zb+$NTR8YHNaI-*X)cvaestoq=9)7i8 z|A1)TxX!Z7k!Dt-6(ZvP6S3r5X!V9~+Ccbc(hC1!dhBx2c-9W=O+3fj_o>LW*k8kHM!ZVxjC?kCaI$h#NbeQp27PWz3>?f3sUN-n%!Z4m+|3~sd>6}3Kl;hk9K5+_5H>%6exgPH`3-Xj4 z^}Lm|#Z=6_fKMXK!(ud@)|- z{@{kMk{z4rXUp_wp#F+k3mwiCu1H(zqd7WFhw3zTYOn$|EaS2U`tq6#*7mO7u9Q$g zH1FmOs&5EvzrG3HI`Qt;Ec_+tm*ariS$P7Xx*!HT9mm0*dxl}f2ZB8g{k+>x2zDg% z^ha;jt!Jt$*-v!b3{bo00fS$cyFG4ZEVy>xA_fb_C|)QBf7{Fk^~iLe!}d*;7-@xF zB#fvnRX9~VrB9=TKX|P{?!+_}kC3>6Adq=ev+Ut!zzz`H_L18$2!jGYEeNW4qRMl$ zufW7z0P$ZK{8b_OW~te4qNE=Z4^#o)Hk2u@CiN>GLGcCKxwe@=wyqYqKg$8ZBABsu zQ6nEKDweI-3{a!^E29;qa<_d3OrEVwPkSE8(s-gW-Cw&In}KO)e#uLlN|W?s4>=t7 zFwM{kv$mj-aG~BTt&su+!DnhjUx1q;TGu65>-->P*eUJR&hvTa8pR@2+@G70JxS!# zv)LH)48D*5xBvF{9SOx9oX?Xs$-g^^8MDxd+shMiOicdqpDy|=%2d^5F}elbxDr5# zIRPAFKL*F0UVFl@4;v@cCiQpwLu_V7TqZu2P>aw-=B%P7HIGD_PuF8xgj>1pDNAboY%9$^)*pdoJl2 zpQ6U!L;+q?&{zj>{ZbZ3w*HHTnnKdrr^5zRJHq@vIK;|usW(8ACvXF< zwd&UN5EHfz$3e=n#RA^x#qG3Ea8s{Jc8zTzhRV$J(`>T&px_2WNZek@P__w96y{~g}ru+{;(6bi`Bw@AWr;lBeJNz9A};4>}v?cdeF$UFuPZ?rYVS%TgL zdO-8s<6*Yw*NrLyBo{fUjB%>1vFToW(k@~@^0mL~cKQCx*#HUaM--@dmCzvzt3mHC z33OuUIdlMu)c}!D`qA99()gc{a(sZAAtKd!!ZoUY#MuhNH+LhI1>g*t$<8n+c#xQN zAcSA8Ym}AuWdE*wJCUM0y&s!vz!Iuq(d6`x>r>qf(2+00Tboql{mrx}a)b#FJEh!J?C!qdYN?~jJkU&Xrk(Myg&rO?BQ~<|F51pAGsr=nCo?I$T|C5DTtKVY1R%COV z;Hbt3W&74cpa}vpG1sNqc;9cBjNKoF<>lxb{HX(m&k<|^Uk`Ki#xGaO^~`^RDVTub zOH43@w#FYLX%g=q8s@HP;>@d z!5LX(RVKIXl8x_oR85T8i%9a_wqhBTti>Psris`?XOjoRs9Z{Fm_>S^-%?;cYbdKZ zw;v+HDRRwAN$QdJl}=Q-!Lo-SfZp4;P?&=$>$dAP#D~;cZev{CZ)D)iXXN(oLv(Ew zw|ck@B-+z|9jWWsG!?>XN}@>&DGW3P?KCBcPq+MKEHu)>Jgr$6 zZ;4ctP(L)m3>v#)Bbmr+*{rLNfvm0|S<~vbsuqXqPC_$YBsqYK0M|h77Jw9v54dwU zZZe*3E;bL-!7iZE=N_=1_9jb2lea1tN9Rso%){x<>VdD{X1VD7 zqf1Duqc^3xHbf}CK32&2CT9!vijP;sMOSE&o8VSUG$^z0GmYRR&$ld3HZK5ll~P^6 z9O0jX{Bp_tUb|e(XOE)S!X>{tc0=?2Q)5|(MSjVUORaT@Z|Rd+g96gHBIdAC$GJJW zs-Cei?7+!R-jZ#3{DBZoeglAK1-Vh7;Ud)%>w6@MkSYheA>pMa(l%+DQ-QdZH{+vw{S~NySVHJ!Z zQ|q=*ifcXs4ScmrjOQfAR$Zu6R2fd+pv1Vz62XiiWummQDK+gb^$+mBnIa|>dWJI$ zF!`t;V+`AtvPy|DL_HuYL~E+GfB$3d$lx)KHDF$B<+g#k!$51jQJW;X=2Y|KtTZz{ zD#89#e!LTaB6Yk6b2;0C9TLgPxL52DlBl5FfS3_0zCADBDF?Zvs6oyqzhFVl3ezYx zvsmL$knv}lo>kVH(K?RclDyDIHr8{Y^KpD+l<^T$;K(LodZZpPi{z_0Vdc?iwK_~V zpB<+u8%hmZZIllJIl|T+Pf+S+aiLaWqpM)aM+obX@L!cbIt`}Digrxq8K#zF5vBav z!ogEs{Zq6;!rf8+<+(%+G*Vbw1i)%5@Mz!nW-#bmt>3XkGtYvnB`(1AX$UIvMfhV? zT^t;>R|$_B_wZb++c7;2dyMA5V2jE_mK zHt&*7frjp5yH(*k4)XDu%ujX^5`QSD-sbRhmQs7~DW96AEO&wb3b>oH{z45IY|sCH zgYdGE`ZbdJ*Bc6f1Q@2%5QMr~wn7c)Z`lsdvcHe{DEDr=K3vuE~$^S+jado=+$j{vM8<-0U=$YIi$=nfV zqRHNn|5n$YYIX~^^!&Y1Bq_e#X@2lJL2rF-VXO*Vz0ON=&PX!)Wi=ls7kX%AZ>;I? z@`pz$VFWM~FXmw(VQw>7a&qPk+)Avhh z4srDFoWIWPdm1p%T6-E^7vhy48o3lPZnij$GEB6q+l@dAp>Zfpc@Lq2S6M&8)Pi0@ z6e0`Nt%Uwz!)A-@U?BIj0pe$2ps{RENKv* z002*q9mxh+s-q(gA)-?G?0|<8s1K(4<3vvb0Ng)ECcIWc&$B^{T5B>+6tQ0OMe+*qUk|UQ0w7zQIP`4I#Li@rC-#s5cNA9(^dUH7 z>HM$`^CbFHVSlvEPac1CtuZN$KY-VXdnHiU^YXIL5p8VVWwy<& zz18LQwTnuJml@ZqXFE28$0#_^2?Lu=C}+>(&ryM;?KPV5XDC~9ls*oaQq((2*j(Q* z<$c#E)sTVqvDW65=pIf1<8z8|%}C<~mwW~m8};qE9jc3Ymq)zHY2HVJwM7(c_~%g~ z`3e_d6|1VMlIF9_M~{f#^fq5<-vw&L7;3mlBYPZRrdjO&k|%@tuJ)X%9fWW_GJdt0 z+#ac+0AV|Iz>BMd1LX>)s_Aa@C-V>tks*?!Hb@W#~A@-kd=)jO*puw)8nf z(P$@jP^D`ulLP4GhvLP>U^#sQZZiQ@eYa*^KAX&Gc($h05DIp4Gh!5bU^vi{HwU7^ zb%LQ1rPZId+vONMVyF6Tq#i}tPQay;LIo_{gAO%#I4_qq@ti%O1audvFgiuDZYypM zNphtKsJAZENffeJq@T?RgZKZhUZc(*7-qW);L{IXVphw8%5x$GnY2NZ3C5fcD%C0E z#E3+(or(|ZUy0Q<}a9SIg>@A&EI8R<*xb-tC?e=>(lmWo5M=q6h2e^kWSPw zyfNhSmDi`x&mkNCA09v4TwTR47m6j}qEMs+qf!s>CcHo3nN9Kt%$&wa@ zXx7DQ#K~@hORVBW-^+vv+6%t5s2hE`><25r>>KLlth9(k(S$?zyzDJj@Duo>G`h{5 z79W8NTsVB2b|Fiv*I>ilv*udpoH`mlA@n7jNl_ykuC8qjt;0{t>5RrXY$In4?7vHm zH0ml!`pgRLZ6>t)FJMUz_oVCs@p>hbA&d={4AZ>vV$Mu920{USq0{)B)fOdE5J%Xs zSUA|tUk^`R?Odlo7nOj6dQX6en5--$K)YVAv@?(1gAnd^QwO#Zt>hJgv(n+@8e@hnNZ<(lZ?X-1gDW z<~I6u5hr&lI#`st3h{=-%hWz5{O?gkA zaRi#H&gLKR|V$@{_zMOx%ISe-w1;&L`{JaB3 zl7Ps-bb{dF- z^g|xnlXUA@vq`GISM(#eQ4QCFx33AjH_grY)YF$;7zp2MeB00-4|X$pGG`ILXF&Ig zOM$qR4T20A=H*o$h_xHinD4p#G`(cY-m_my2Di$7a*b*7tv%4InTj1r?Gpl@pm$VM zkL>SaTeD`*p=m>sy)$Y6aqG10<8kDy2`Ikqfld5H+z#`rYRl4V*PyM&-GHrTaurl? zk2{bKQa7AALK>kvGSxA)p!oh?+vKdb!)r~|RRewF(S#9{mcfd`E z3^26IO|@S}@7;`0Hbcs6KL&qH(nsjZ<`6iKVH>nO+r7h)TsO7ZM7wKsHD%>GD2X!$ zl(Zu!e}cH)9+xGv`c)a2#u7&3@^#Nb{i9D8a-iqQBHTOIq9ls6#KMm$)SPGIXhB)j zY1Q>jq;SlkDBbrbd!w_QXd^|aQW`!>*XGG=;f$!-767+s~ETPr(G` zYqYll0C)!!*!XUwV$|VzqU;v8sjktVwLdH_P>!4oXT8ZIB3y@2)-O^J>$qQsPa{E{ zuuvaFgRFjR3d(E@mZu(jWiTRV&s5cIkuYxuQ{U1|^FaEoUE6{%zcRf6(8U9}v1KIZ zIdeIO81FW@GW6@l?b#ob74x*5H=a0Zp8bj00<1mAG@SXsr5tTl*=DAEAI~{dGhuC$ zO>SLasAmp`fCm8=>~F$yHfh_}?LvmHZ>jQ|!7|R>ubXU6F6JIY*$a{nS=2~EM+I+g zDWp<^QKyhK@xHEqu>_c+|xw5k%9@T^RM8WH^`2fa7i}eGvL{}Fi?7s zb{!>A7~WsiZ^kvayi|hR^nowa5~sp#F>ce-pU!udwWv!qY({;qg@rJBZB6}Ky+-ae zMwx_^IB-c5K0?N|_MFCT@;!l5OB;D}cgt88Ozbv1 z22E6S+jkQz3k@w(p$*K|l~V2XLoTm+Wz>7*d6xdkyp+J7iAY+YfG{DuwL|1TmP2~l zm0R*n|B%Tk!L|{>GJN>Mo)=wX%yGlU0*8_Ip!d#t4>wh#2t&zcvh>+k-jBv_11qvS7YoA`Gh+jx5d6jjK*N*Tr8s#OGU9OQ|(Jmc5%HPez4Pu<44AqXSY)GoS zZYQV6z%2ud`|?kgy?!#&F-o>ZjrV7;BVRtLak@{G)w#G>R=Ypt6S^F!3o7~&SOriW zvA;n0viEW|D6=zXY!l5QT8#f*he;2}55*^vo56<&%If*JBo0@-VH@-45j0OW5?^hB z?KkOodAwq9DW@BA&EDHCi5zTS@~8x#l86&Oh00jMi5b?uwg-SK*(yh_GtO3=m;4SSY4el8eC8Nv@ZfTo6gRk`%cZzpUe2!ux$NN$H^^n5P@C{zn1IcZ6qUApFr{H6cXjS2kDI~wc<*dPrSb8msRiyjC z=!ao!B!Pd>=yenQlL8AFvVX{OB7gnhfQD;XmP&c2Ka}6KPjldcxJ9F%MRUWn-Y+K| z5FiC9`)Tp+TQ`!WM0L^Gjl=&>eN2fGqB3=-`}NbbK>jd+!Vfvsbl3i3c)wZ&ke!%l zbvbnhmsT3m*Dq%z*y29Z`Nke_6C+tas2wCVJb%+eB9IKU8UdLgRRC2AH#L{WTEhWz zs#^oYS{nB#dUly@0S3tS`HQQ5qk3F*vnc=&*UBB}80`MHM4`$55r^Pds)OJg{2Zh(jD)?xax!0Wfoa}9&#O26J}d%dQ1s%g78E^ z#K=b4KCTEdX^ZD9@{0gPN&xT30RE99ocHhVp;}77hvUwk8C^k1d8sp84qVL;GV~_; zO>mWuahVo>LvYH&=AE@fF!XY^sJzAtS8o;eU91+s=L?C8UZ@dP(NS1V7Mb&)zMEE@ z0gW)8>syFwEq+g~P{35s1z_`vws?2P&^F8txkg;d!jKP_PMxdxwF}i_nR2ZNUV`WV z!rD_<;_91#<{QinWE|kKSV|gt$qLyUchP6?-cKu5P0ym0U(2DP#M2iaGUoK&fpwI? z$#k`zn>z@7*BFb3C5}3-AMq;X)dBR=diY6BaB3eg7+qS(S(CGj&J|~66tlo1)PUp*#;CmZ(&}IAW9;Isq+$7LW^n$;n*?T;Q#;} zeLUWLnnP&EOKWhCtl+Iad_#iGiRNYLNZ0K9K7GJ^P=|ZLUf&yB9qod(N8ph zXkZobk&y+Ad=8J5iDc8&-{P{_I6;?q-A$u&2Sm5LJnmXNGj+h!a~&0QW57jY*&x0n z<_(7^2@Y0s|KmcAX9s|e6+U9sGYZwGx&m3iN@GWI$}75oL8CWm`ukeg>S~t{DQ{#+ z#VvFFVZi?HUOmFE4G99Jf|lMpx`DwFT?nZd)fEZ_OPavb<5&KhTs|*QI_6`(Pz6!B znhf$e10Dcd@v`MJt{|B*$b;Rz9)1=-aSn5|gEyXA?S8OTyDaAJcbF0b($K zQs&3iv*rr85m>lHiwwCJJNqb1z{6gH$`N*`M25j3ZL$%g~ss<%LhPHl^Idcy7H!jx2pMdKtGGA?ePhLX4ZFR zRriDgoqX4c5w8!=3ZNYAzjk1RQ+5N3wm(VnB$u0C62hc(kwj8yEI&E}!1$a8@1{*G z0&dPG#4>lVxNzWVT#jp&FyWy=w7pZUG$RE|!AAUBoBtdYkg^;=2P|<47CMS_*Z5%5 zj2+hI;YgMC|Cj(q7WU&5X8=>$et!To`Tdk za1J*vdYR86sq|1JrrvWgq&Dm%-f5yBaq3>m6tQPN4Q>U6p&R`pzlspZldva9LM({g zY98giT;#&r*MA#2h|Dcm(iP6Osm9EVkJ3RVlhRd7=Uy;jGl%clcjU6j-_Ooyy)I@o zg~uc@OBWUV&4cQl6<2&FrQ8RwRah4NAHiS$rRAv@=h=KuXhCK>`36+blIHQ z07pFnsj0%S58D<^7T3jeOx8(+R^VA~oA$Ze`^eOd>US0Qu|^K$+~M~i;< zBc^3X`VUw2WUnG+4^}ZizeqLCd*K*30;f^i=XwDbc)!y`X=zfFZ&8kG0agI;(;AtW zyh@D5?#aV0`TKM96r4hi8e9%B9A>BPs5peN`{wt=wUnJUsD(^H&C-e$f1~P))mU!W+j(BOCeiFWFhDC%(YFEihca}MFF|h z%{wGSu+PLVGaKg4x7y`|S;1+G(-ii}&2X;l7`LI#0=Dl6poiOYaMRIELo{Vy@Nz;%N6+<~=DnX=t$R50Y*4jo_*YZbf)qo5#D5Cy2v-Vsx zHD@1>xn!un-Qrl|FZ$Nn%n_S{JyjbO{mxbo|8%-9MD3cXEp3~w!pr&ZY{4Ch9^!Tw z-i;a{X`-tHCGA~8-vl3m?o(_-LD|;BFkw%X6JSezwG+qnG$Y`AtxP77 z-`R`MCsDBTj>2-Nh2s8#+_6jL#)N)Ofi^}Vq3A#r4{P|)9{>=1plNaN8|pY42Nv3N zI9%$W7p+u<`FMf#!_&!7h2;pmF#3P*s(-A0u3+m=1{OrJr1On$R->T52tnck|EtRx z{HRm{0WzXXR3RA;jK}16J~6CyusXezL4@8&@Tq9vWcQKbTKLit!Y&)hm>i zVSa$-fLTTwd1Io91bu{ zCgfTXKUuXv2c%_6b3)t3s!^QlFsj-HYdNt7>OJ2cwtJ z$MYzdWRV}!F0UEnp9lM6(l@78rTD0z$QoN$L0J=9tLfwG*FYmHQj8GQA!5srBE-KF z@L&5VVR--WuSf!T00VK>iFEW3IiN9W^%Pr8F-0$Him^|RthQc;J1%CDa3FWW^r{Iy zFzc|2j&C|!i%5D@^lxtdizo5lT20^dmGqS+orLXYEAP$b$mwdLOhi{4xqfkVrbBN| z^F5*G4kGPz=E~<-iC%qq_{4EYui+ZASuAAA0S`?@3E;r%^kNljuiqrxTYoaJpQy#K zNC&Dx-e6q2v35gQ{q$pqS52jp^!qnH6}bS5!=pB`U@#=_6|p#B`krM0R3DU5zR5Om z0{ebqKgd}D<6XxYBI~StV;2D4-nwHSCDRGs^}9vT2U6|`Csq;zb))XT7J8F74Xrq>H$;j3b6ju@;Fk$k z+a)9$ku2OQh>mG8gppUxeg6}j6|R)TeVG4wGg5lno8Xq$5!zm(5ES?#(0~N&9S2ql^i1O zI793w_0n`ClWiOIii5d-euhOYSw+Oa=jw|LCM#0~RH&LHDuHR`nn{#u~16?wrBS>YJL`GtDDHw6bKR`529<$yfHm`TQejwR0;Yr6j|LYCyh+`+;HfeZ1{bsHW@Fd&TFB&4Dbg>jTtD zF+loH&e-s>a;rd=4t3Bbs@0 z$hu*u40&21ahp2C=9T-|TggTSTO=^ncr^Vy_YOIVJE) zgL!*KE|@nmb#vHEAv;=ov1$`&l2~e5ypZ$~i*T{UBEDfwp}dbM`|j1ZlE__uhdeHOQ4op^+Z9XX0{Ui=L7p1>v$$yEL2zF{PYe|KmPDb9xPAt0-G^EDGkIc z>yrUXe=1Ric{+`=&%)wy3ux(Dcbce0+DGq3M4J|1-rti-)J5mOp}tT-9C&WB$Z@{~ zhrgA&tqP1yj`xadWDM&5qDy;oxtWq`o|gluxU@J^c_GE+nI`q)Q0dPJ$Y%eziTCaV zkjXL(*dG;!2Rr!=X6E|4n*oj=0PJ%d4w=+1LR$`+gl^;R4Q6H%KvFT+IDp&Cj>>7! zDBi8FRMR>5p&(oV_eNEIM<}{1P<#WHDtXPZ$r5H&NxHH1zWBytp)@w^JB)l z3Ac=MlhEO%CQ}W>zd*i_5!GSBuLH;S-lVo)doI0{yTDlssx8YEvyUb_YpgqVS86zG zzvwf`2~DuG;p@b$jC&|g_Gxh;d}v7^`(4S@9m9ytFB2oF9!*70TB$2gp>mLB%yS^b3QaT>92;*~;{XN-SCVO+G^p9?1TY%3o&lnP|>*S}}_WgT>w71IcTY*gT_37@|6=)PCK zHz_#{6e55d{pR3(qU%51*?u=eMU35iD(DU@qo|2U0j`gun987@S!R7!@CmsAhl{Tb zZ^*rwH!YLfN!3Q^WNZ#oVXQ|b$IdYq=^JX2S4R*EW~qWCf*(AQm=xl;zsFn$waXL9 zB&~ffbzExiEEh4HFznN59p3B?{2yWDwCQ6P1V~%%(u@T(w%c5o6q9Y9EGYB##d9}7 zdX!EQaa=MnLC4`|tnTt7;c)9~0{Y@BQY|KvWcIl-N>4(TK(VRsow1pHfkG?>Q`_cJ z_*PD_Qmj*Pb7@U5<&*8sDEL4pH(z1l=OD6oCmflGH>7}yYTOE+OR>3nDv>atbs9+R z<}+<9R`6{3+LU{%!c>MK>!|P|3uNlw-T&T_JK^Pnr&422UA+sAiUFWXva4BT)psY( zsrT6kFIPvcGO1gW(RD>|9(+8zLCMc1mMqNn@A%!yXd$ncb zx=yH2!8VC`rV~bv^o%)9QlEV=+jHto4F36<`Yb9`wLfM1pD8PKE4rtXWDo*`b8M1- z(93nhIjzW>gZ;n(X+ZR+jFVAHqh>vvS6mO`btsZr5abWh{?L=Kq>q88upkBWw+%!! z8tH;OmMx^C%=uQjSYHVPr9@eE15PBgewnbjZ>KywUfL?SDUofCQoNNh$n28RUsI!t zSGsscEb;DEba@8b+b*hcO$+Im^|+Zz6n`&npR)T&3;8z6%OPH6u#BZZX(_b(A-hpftt}+~6cS8*7f;#{ z-_!M<3ZzOf1()0%ItQ|z(q&smkIV_%W|(R4Ll;4c%_18 z9KUuN_5k)Xf$a;pJ;*(r+vhiB4@?x|IM&B0I5kcm!ViUl2Vy+2n+VVIPkJ_;pjEPc zX|C^3lypxL#t~i_R*@Pzs(%XAKm29cCt7d=W<{&Mjjq7bj%rm?=ZJOkGM2$p!}0eW z;c;Zp8@xlx!rUz_REkw^5QcL6vOqTRw-&U%JLJ+YsTyw9-O!@X0fBOM3VCHu&rbPA z&+D_DrJUdCrcG6hRL@floA)r(TQ06g>OaCBsP?Xw=b709Y;LoJTqShp-3$AM(2WPJ z8=IWi>L8=saA}LI1IoZ87#p+aX=3KCB|vS;q}-B$S`6<^zCqh|f1=KoHeNHG-^($T z3`HQei<5uh?5-iO6<)oat377S5P7e1Yx`tzAI?i~^J2PeT^5|O4T%u6Oy}4(%1lm( zDixBh9i?7=<}dxwwx_Qfo6r#!3+6f4f$ASy*>nSa#U`~#qJJHjrA~*YvJB-66KAA* z(QIE%UbnBVPl&lHeju(rttk(9VYD#Nd#@3=%4KU^RfkW{3m;P?mZ!1CC_ocH5NDgB zEO^nBPUWx4&`=}idDcq^NutrpC2UlWp0YLUOjJ<=L5=+9$z?#zv;fq5=O?amz_s=W zShn=5x^eERSE)^IO-WAVvlJqu9Y&0{WIU~Vm4y{@YYmxFS8Z>{*FLa96sF zhNo?U3EZ*>$Rg6;}fHr7~T)Df$Tu!%cwtpRQnewtiwiqGE5;898vqt;xJq2wv z`6)AG^uZb;M?n?gK#4GiGTyyZUvd0wcpD#m zR+p^e3>0|=&RCBVIwj%k!dC1ncKE1M(F8d-r^joD#T-}CcqCuBPb7@Jm1NmwvOFp} z=W6}jn8>ZvwvW5!$o$?og#AGV8+j7w{&ilIv^R+F+h@!aPdg*dB8^jmzW?Fd=vPvk zj1Est4<7TUAcW=`{xBE+_>Y>z-b2Q14l)j7hJqm2*io%`*ZIv6 zt!|2OiZUpRI*tqA4>W4Cn4v(-LZh2<-UG}gfnc}F%3e(S-k(u6s_6Kc<;`ft;^})H z?nnLTc9D_L*|^kaNhRElw6MX16;0NRK@G9{QBTJ|6L7Cq;naCsj@}giahu`4*Q^-7 z+pH)%vtW0VX23*HL;44H#WMK!UdCUml~|S7g=f=L9`o)X?GeAYB*&J#?lHU3KLG#1 zn++Asc^8swDH!lrZkI~{uzxQL@A$#u7kJ(vfcN1Gx0%+wZ@lqpZ`@)qpi0!LB3n?x z=9dz74K^X?`D9wLs1a|CjZ}CCXzsGD_{R|PF19x<4OtWO`QkU#jI}2~gK}z#&q~s> zgWCU4(gkdNOJu_C)kiXYK2H>XzwO1DUQQ3_)s;pLK)-S;zgqJ z4SfvJnIkr$tmGDSrIsIKL~EAt-x^dy7gn1G>sq6;OR%2jk}EKZ8Wym?4GkpH2Xr+~MdqS*9HqW=O1mk8i0j8lS)t6DV6ZpqsNSP0N-YDEky? zCQOYj3hMa5xLxqgk(9maF(TJ%Lun2+3PF&Jp2A#(@*6q&a~m15`$jj9FD!+5tAbyJI4JO)RbOO95rk% zjmC+DMnnLQ-Fa!Sh7i9PnCWKYL%XlW8Wdi6mb;eM8`q+{vMAHBu|Pse-#sSAbHf8o z+*i4Ua|LVu>*n+84z39GAVNooz3vvlo(X<__9<^{G{~YAV2vVZv;h05?0N3#>_v=} zB|}{z9qPTbj)36sk*vN%*#0<+m&<}Vly=!C4@YH8HD5Y$BB#-z3_7&pNLm46B{^1? z5NKnF=d#R%`G7X0no-1h%pwXdQ&1#VO@)`*LH0d)c<5fJEWl~Ddu@$;cK0IM9f`*Z zDW3_h`z`*y7;9z`oB{bYPKWU3K2~*tUT@{OoSzjm#xo!yJ9kBkXZ1!fVFe%`hoJ-B zYGHK_6-T+58daD=efLB6{I1?kYYjCPGs2_6d*OvM2ggM%I^mHu{f}~fZ~9S!>zZeg zE~@Ywwg26jAxI*+954gFc49-q_lvr#TJDSCYj(%!ZwA&pgRrqOw6q#xqn#z>eeSub z&kD*$gGGE!wf_S-NRqbk`MHaa>(q%RT+N!EOaygG zB1k-QML>}I*2+X0TUn!K4my=X+@wG;5kOtN3Ra>$+#;!^kviH&qfhaIi!hUx2G(K; zYt8D14F^7a%X6JdEmJy2V0F9&I=u`Db3!)J^G%>`wm%5yss?&A(b<=pnw1X3HCvsQDl@vTr2+o06&UWSOa(pXw9p;aodjot`6iimtVMu z070*-2^uQNEA(;u3`11(-~sJRGwx}|PSUM3`AyyCUoWn{^i5^0%sUNC2=dVjxXDsr z!^h~cTDYB%`c}M1h-T9Y##z-plR&NZup*Bus#Rd_%jGVsN*fC)1-FDhvG=|+r^g@h zqwRkU<3kQy_2syVsSrjE?;Mj{DUbSOYBUwXvCsHA*d{QIWLSR&JW~1_XCgj47;GR* zp8v98(gzw&C(s&W7B((i21=IBnuPqirAQ-+-zd!t*`K-B90(;p9c5wx77<3(+LZO0 z0SGWVo0$c~nTOt`s%(Kke1v`-;%1p z`chYqHJM#R-s{uQ*v)?frWY@4E2 zubo3Y3}7*^JHSfzs=qR*O?KbnV-hGn^emvSsgCuL*Fa}WuJTXNO#SmG=Tpgxs6q$ zTB%%<2qP}mM&}ZzZq>GCFi1UK5lw(1JSDqZ_~)tH5Eo|R`U-7V$8aJ~-;c0V`Nqf^ zc0$!?yl}FF=Utc>#q1_kFwb-^oi7EiAKvch9*dveoRJ#AbGiIqYo;Au$Q@J+~2&V9lwP|E71 z&4j4cID=y(B?MKSO95i-wX9A>SdUAH#aMDfxIp3?0TnNFwOAN!*tBmqzoFRTQ&;zN zxjAA9sU0e^=o=qGa4bHxBAT>#vDnq0yN4GiWt=yJkBkA;E4o_o zLS=r$ma{ibaR=!YIzg8J(0}j%*h{x#3GV70DAj<062VBDB#ASymVdujIQ<(p#JHs| z-|`RWV!5^-XDnSQwcY@I&^uhyIvh@9vSO9K2PAw{i3j|uO=c`#Da0k9>#-!#xA8o9 z!lcz{aQ~cZ%ABLF{7SZQka?JaM>Rc&gj68kQ{=M<(!fs?QQTo^Ms{I7ib=)07&hHf zKRPHrgP(f2H(ML4Z6>3pe%&1?d@9q(QRmJp=2rFocAr`XHqd!^wa5p`*gIB%+{wSI zAB7srv7u_!$0cw;-MD{5ej+|?KDOO%m><<>0)y0cqq<>sE=rspmln7Uud$}s4{&5* zdl3aVtVtD_bMQwb_zNE|*`Qrzj=35wFe_>YzRP5~ETHl|K&FRuW!pCgBMX83Y^>`oHA^N{BBuoDWyYt#ye0 z*)GU#PvVV-D1d6^&jRLOFJyAPOSv-ZC`v?ukpYhH9U%g@^a{I{4m<2H1N(sP=lwj= zzlLb`4a<_Jpb5Rn@(9Et55tINeWm{m2V>Q~{_1tFhtC`XpxuUS0?m6qi1L;tMb52o7X zfH;{3jSJr(ZhS%tqf%5upNggn#T;VI+dndi#*4VVt$4sq0J5JLW~p`m2K26Oh`LyTFdLYfqXGaVQ)2hkhGpoUhwx9 z!>N6|Ge6`1-&w27lUNw`#4VOzPbV5FqhDpvVE#rnPZ{SvIX+82Q#R+Zqg5@CErx#N zr3fPNj0rQ6@UqZZl@bNzDif>-_nMG3Y+EztBCh}$?wD$jvH77y^w!W6FsLP0hHFnq z+0s*}88fZ$dCgMPGLn>%`IkoTizV?nRu+4V1(OxicdZy|t`u8jy36~QNoICK5|k>k zrzA$4L-x~*2zbrzol8~%ImX0vd7Jxt;9Yx;LGib>pwXn>&9il{n=bsK3E%)oxjaGr zP$nU68_b_H)P?IP=6m*k^J^=l>;zDKgJNziht3M!{irlinYD*ad=COh+?ub?BCqv= z-E36zLQD}rY$Ow(Gt3gpI~aDbVJ6MJO%WfP09#eF#^x?n?ykz;NTj~65KRTD*wvWt zo!d6+kc+}kkeIbJ8G59fF+o^s91iRMZ7`4@QaODzCQrn{a(=%G#ddwlDy#`B|Hm?+ zDyv>M$|YA6rHjgmd%+ihOVkialwLH+)~B=pwwUf$CdVLtR~p$JNRD!XeLpDO6*O}B zFecg*j7spWo`uH_W0V-KFtpSEdRY#ma3(N^IkOu?zyAGZnmc3;g@LvfA7OFnUe>L|wfNbwp;_Qq^3(Re<@O?j6B(0QLvH zB9(QQ?~(r`O(^z%KF7px1l?HWv=g|yV__14_WvC-2y~LU4^^yr(hSz1-qN)vNR@gg zN(hnl8#gS@pFyVYj}Qt$Hoo3#=w@cR8Y<{l4NGAqIbuu*r)w?6h7rSkaDU}VDO~ES zy(r0*+_Hs=DOgANY{iHp|7FRd6E$~6TQ9@K2d;l|-~0e*eTv%}m0!3GV31By59A!1 z_84GI{MvP<1=*-37#~TlF&tNDnRdd5v956k=IH!)K$_y6J1V(O2fzxJ=P9pyHa5K6 z(mVLW<$+GV5)gQ&1#DXYPNJ$CV$q}f|L zml>o$ZsY(m!Ulyx5o~*LclOl4*`EO7000tg76DBm$1UyDxfv{=0F?PQjF}v=cd=4Q z*g~GTd1QTe&rQzTc(wKHGD|1!45-Y;ga7~rg8`p#X%L?P08ft|xwA~kvrrTn2EwsE ztN{RRm?MGiTTknPU?=qzHJRsWHesRR%xj|ji~xUt;3mKd48{v`hiU!mK^_27*7m1#rwS9{+1oj@IH2G)%$hQ;;-eW`azENFN8DFz zXqZ3&&5-GPu}KFC#1hdAtHx7~#_%RMNRZ0sGI*uxo0yP-&C4qNPvPwNVWg8%FkNn(cEH;h)NOPrV*)6I`VG+f}UK1f^Ec`72n><*WvP6 zn{B*at;vi1t-h!QfFlc`E)kA^0|yqUInen7e3La22a#6mKic|bQZWQ3V`cwh(92n7^Ps!j3RnzCisA<7GGv>K6?v&lx%;ZfNeeV8r7d|22xt}UxqR3z%5n;xA9fhzyR^6ZV z^2Fb*Mx{J5m%yz)7O&St^Ng7oN2!~KUZI9*Y3+Zx^3hDT2)+WL(0?;d(^EH=<^1jaSw1cXI$6DceXq9 zcSm|>I9sLiZ{cqO)AE^1z&QUn8-bmP8Pt{kl=xg_IzYbHV+%8;PeEL_;dZl@4&iIZ zY(^vVV4Pkil|xwaTK35HS-?PuM(U6izj?rz|D!dg_E!W2PA&$ z`AfgB9irKw!yx3SPC@0eRd!auPFoHKq#{$jcc*s3;M^SS`gk}A8{1d6T~}$<2x?|= z6!AiT;AKSqv}Zy1Ka2nf%1kGk{Lq{N*@-2%tJNvRVZdvHzCVN3@25DGhutm%+v*6| z@>Q+&ygmpX!$0B%*mc}^|Bna%5T$$q8&Snm#y-vu+kh15!BX|%hg5}<<#^nN(o6(E z>2*hLHK7c+elv3bk}fj}C-4p0|JZK&a$HnW&j1ap95znzI6+JP7wN5rruHh^-h*!e zE|$TC!DO!7W-+wJ@MY(}c}3@#199@W4G0M0ef2$@wNRRwbmsoTyS-=89*shcQzkWQ z0jB3CD1HKXcdsd;%z^|-SP-qI)`+f>yq64PV5n!=2}HKWP7)cFNj1`d zz%bjf&o6Y6>=yN-$3&_id#mD`#|KnBsThJEg&ahT;P=R2fl*vCTfQ`uw97&kekFha z15NVa3*mS1)y!LMKOE#>g#{L3la>yXG$PU3 zv2?FfFd&b$OxHjUSIRMglQEWAnut%(Y5V8g`J(J2dRWTR);gw72KQ_9WTnxT%!Vz% zVAi6Me*nAl#ZqEfX=hPYLLULbM5P3TDHzRR`+0) z82$RX{cmC03_9s99S~UB^k_1ImSpUe&}OiV8PCNmXo<5lEOE^QZ2b3pLYmUnmiBDU zvf#-7MrPg@#|r6_SEGWNJ-y1sJ#wv7+P#)PisXxS&_s>L(}+jL^U2Yw_lILO`6`?= zt&;Iz>XJHYV6a7b`++VM1ao{>KmMEBe zf?Wr@xX}+1tz6i+PJiV7xW`S`B;QlRe-E)^ME``hFhlfs$^Jh6dQl}Ae0r|j zd_*E@XM#js_YY0&U<&DQ1hZRQ;==t3ElF#N%Pq`P-*gT_!s__S4JZ>MY8-Tg*m?3V zfVfnh8}S?Z3#5vXd~+%3k+tGR^P{?LT6lp%Tq$u0@e@%Yuqi39CkMki@4i)x#}C4E z5xF4up-!HNzO9xcak_v+cyyJPRziMU-wfb7IS+=c(K(22N(Xnro?76LYsQS(lG8yQ z#w}uyM(5tbT#bLtOC`3bU{F$cyxv{KKbKnQisF6*P)|xcfL8ZMUS;g5UUYf4GSzkv z=a-I5mAn<7(Hil4eh%U9{Z`-6bEDzbt^n29YFMb~wm}Q&FWps_jmzmF*dkUkS(9UT zsb8?zKp9iU(Vk!TTq&*&e ziI3|~Iy_L0!8|(Rt7-kTl2EDSt2xwA5Hxl*mFT92wS!P7r(gN|50$^O*W`Wv(lO;^ zqW}~=N?3XbKo_C1S%qzyF(_pu1rxye%|voin^H=*-=jZ2g#XU~>LVQhRC*WB3-|dS z&;O`YDQ=ROUZj_hnauNGR-c@E9)zzqo9%Nbj`b@AOl-T28M+R`tYn|RP|eO15RI89 zLh47Y80^L;?;@Pw>HAO+}*No1XN(f(U;z#?r80{g8fnKmH=n|-j?E)Gm zM8SK15``z(Y{i16j;nc4RHCR_#i|{K*ntEVwfmBe z`>O@OfwW;pMLmt@yi4eMjMwN=iPnVQbS0_~2oE1T&BQpT>UorN&}?=oAsy`YeGDs8 zb8zX!x94bm!VApzkBFQnjU475|F{S-Y8MX61!02z$1)q5H^>Y_)E% z!t~a7sr8fXpx>FzVrHY<)6I&C((wf$U(4!*;|k@6&2IJ&jbK^FWu?y20C^}>920(B zC#e;Ccwz5jZSpJne`rKemuTMM6QEd8S>4eWebCsCzl|P`Pn@}5_#rVz87~l7R%-xf z(4vQOsg#gXog@gV{sJW%m!EKn*9pEW6o-34Dy_IFta{hNoY0pN3Q+C1S7ISlsrLy4 zYNS+;&D&PUBaKJcPUjG{OxP`9=amqTL!vkL?JSfT5~NUOZ@x{LHs_y#(c!bRX zLh$A=4b4takjKx;Lmw>SDt(8BVn0mB9&$%hoBz3;)XH?`m+!1JIa8?3F4^QEd30*Dl?qZl0Oz7Cm^PDu4VSJP`J4`sPe#33n>kDKeo&hLWKi2RFGLRa2{nt1F z$Z#vZo~7=h-n@N(E7(xgE3b79_rU}a@K1*QgU@ST zV#4|Z476zOP87Fca#64W*c;)4O=?c6$(=dc2oFh9o~@Xj)7M3ZB}&<|exW0r6%;1Y z0xu|;Pg5i`HJKp586vhJU%ZeN@@myzNSoI6n}-)y`smiIn~i=%wS=p`K!&~3z0z*9 zNbjAK6>=JoE#?7Nkb4XP+5u+p735^kS|p&!{PqcOWQz5ztmjk63<#ibXiAGRMTZf( zUUwT}PTBFsK+T7hY#cBhP5J&8A0kk0??j6uo}DZq@?olc*Qvi8$Xlvic^Mrm^fZnQ z5VUJpHEhHa|9LC6ixu}TpFOTO1n!j{p$lP>j$C|V1Sg5x_gH2gJY1C6*gV-DxZ8CG z(AIT3-=)p$2bXlXw-9xQ2orc`WiUNBDr5ZRV}`PuV<&_6Vbz&zO&{|78xgXJMS{vb3RZ#;*Z_FmXgg7@piH?{|q zKZ^f@DAQQj>y7OQU+?a2grZT@)Z?2{m;eBTyniddE(%Qo+NnElp`paej(ukj2i=vt zZJWqwb4rSm%{M=#ibQ6BfdBfWi^uK=RC7tIDBrfXWvxgMg79NiXl+)O2S3TmRv;V8 z3HXiFy94DeMkjaE+mJxwz|MSfI&Pi#G>87vlymcf}%@itXj2I^f8ah)82&{p!fjzGTwat4hJ_6QdR)w#wXot8R^4uS}G z_pHD*MV~PGOK=t@yJQ%F8}LhDvz1vKn8PvVJxM422_hRX(rXWh`z%QQL0rwjehwi&WU$3~Uda?u>V z4R-|Pu)NwM-pI0IoI;sMDdWsU0G>k;TD$u7d*Xl*r7exSMZ1A8l2HYS5mTQW!&<(Q zzWuCYkq7orDkWYLoHQb7lv58=8$wDuM4$@idRU^Js6VlAB?OL3RE)A;?{!N zf{&lrQej~(z6BUlRcW2IL1=1;js5a*METYtyYY(;)SBaHtOvSJlKrP7R~dsM+hZhg zD%9tgRhi^mAp%tQS7iB~9)tW4s*53?|X z7nlfWL6w7H?6pQNGgUAxq^W!z_{p(Yy{LwQglpK#Rw>SlDh~`>WU4*JR0SwHt2g`7 z_a4H;(}mJcX(3!Hz2+YyO;wCeSVR{Sjcu&g@K8R^5T;!{o^_;~>bAuq+&geh>$S5a zSleP_cG7$wJbrFuwRso+EZvDzA=-*X@0V?X5A`we|13gpbCQ_1^Al5dd_7J!|0$3I zba};u)U1G2{f&Ik)7IlD_I~tnfbq1xZ>YL}Jsq1NrUyAm_sPY@&;pA`Ezk;;*3Et6 z9zPuR-&WTY&7zCwV)=O<95N+UFQk~eAkwv?1bFHA51mFZqmb%?_6~g&$+ArX7V7)9 zx|x$@>X$2nr_7K+P(1`7x5Xu;JE&J7zwcg$eKIFbK^(9R1^LgIPyxQnw{8-qCl#l&y%4%}UEaTz5-;y6h^ z)4(jA;W_ru+W3@Z@W}+ObHC!)j)cn9D}Aw?ij~Q76O*34dp-IDc`Y4Tfk%y@aN^u& z2s4z)5r7V*A-pZqd3FY#A=NF~Q(ArQ;IjU&>> zrvl(2(wM%|tIUp?>o8L5W+&iziY4Md=8@j5iq-}qjuXyR+-sSC{vy?Xmvhfpaa3Wo zF1siNTx?n1|aFf2?CF1U99!c0Vb~D8V+@ww9N(2DOG>!}p`wr?y%J zab>HwUP?05LYOlHTohQ%E3>yz&JMYVZjeOiLnBMyb9IM%GL`;-TZU)h#|^P!e^O@3 zFW45zGOJjCz58+n3*r&_ADt|)0!=;ov0UY3p`vPNC0a)t!{WT$9nCst?CFo%MWiZ} z4QM3phh6PY>dpu31kDEl*D2$6$Iej1{E4hK*yQk8%VgVq8r^HIXX*17hnr(_fsjd5 z=6iv!`ZhDor8Q;#DUOT+mrIw<$};4Gw)}IAZ}ecW>| z=ep}ygLa1?2zaytk0J6(JzCkQ^iteTimf{Hs2|6wUlJtw zzc?Ts>*AS!-&lc_r6~^fBlCA|`U@DGcKPt8&N}^aV>s!Nya5rblFlsJNxv+l!0F71@r!2MS(il{jMdO-~Hb4f)@e5xS zi;!a<;*F33n2f&X|KV7iANArySb|2IewUK5YqrE32yp-vIcN;WDM6yax8Ix>ggjK_ zJIF6M0Vj-HcLdg`FIrga@z@w1Tx`kb`rYmE_0+-x$ir=MRO%xVwqbMlN=6cO~nJ&(loDqQq%L2_fT3;emim6Ic&!KUF+4^j-{lGpN3E5 zL--8Rwv1%yTkS2&cW+iRQr4;;Ui~!J1yXS%I=>GYPefUW5ZeBo<;*f1}4!6oZBJ!eAKr zt1w6kGF{w+X$Lvs3@Jv*%h9=Ry(YPEXaACwe+&`}|PXPK)P& zeiK67eRV6#gT?Yui6T^L0QGUv8X|dDJuw*?p2B@@NtuV<-kiR}wG{p&1*+;1&}aNl zJB4OuuJYtjhYwslF6)eLbqd0hS)2;v%j)bo0M{rh9$)9oxb|Ufx+JVqX+D;p@%Wm%mSn|S@Q^A zL`Eaa`yb09rxQV&2xlboZD|wl=Jcym&px>!Q60{2`!^?MntONq6s0OBvu{OI$GaVt zmKS!`Lo{6r@xTBH)UU782lMS9+Gh7IXcJMzjFmxMf^OycCT8?!7A8JJ{Cbf^GXZxk zHVjMH1>i=n1UfTAgUbxZ_(_BpE=6jX0TE?abGXq^l_e)I9o^}IJR!qwO!<@6s*Ki1 zwIMEVv-svZH@HXkwXSC~=%OfF%H_-wf?03K`N(TNQ&Gev+tY#zt{{Uzd%|&DUwFVn zcBHdVR!?k6aiF#&V*%FVg1?yWpcWu&JJCaR|73iwZoB8H6+E%8^$^G|F{5EZ4gw zO{jYXWp5}%dp0V2=w!1E%S+6%QeigmrqKQg+uR;D0$Eg8@gbkg^jWQX75HapqWqLiwUenI{#leQ*b~$`j zDnb68pO3LnmivM*lHC}RAv2hvi@dQ-GETJ}=^~kAR2Z93*hh80LmKy9K@}bRon7jM zcV~^1;)t%xZ%MGE*8m8=pfumFMucGgqaRbCZ;Me+&+ielYIqCJJXnX7P9c)5QL!FLQE3fM>vDw9GLUZIE$ufybt91D|thXoLC# z>^xZ|T8#kJeKdJJ^Nq#N8d?A1-gc_Q>-J2(zskn5r1h+Ku(8alx{nXt@D?7;KM&Re z{20o+#E56&kgoiIbeqTy=8dK=6%Kd~)OWZZ1OfQAg=?j*u!8t2Kk4lQ0f_PxC3neY zxtz!XJZRJJI-CTZjzm)d#g@b{4^~o-HW(skvX3jD#D9|2+1-a6anPCDdaPh;mLXY< zjTYBiqcgf{=zALmc)y}9_0{Tr^yQ1sQrg71Cj9&;1W2^YrQtOZpuJUwM;jQGcqw4a zr>=;P9C=!g57D|ce*o`AN|a=nq8e(XEW*vXKX>rPWSxdn9kZxRsq)x`dM6?Qm{CvR zE0&DNlw|UN*@i3U-UpXGnB0dxmZIlO)blC2IkT4{KEq`YapF}y!Qc(cpw0fE z-F90P-rpD7*__@){ubG!7%u!|@|~ly8VD$Czj>}JZO{j-MNG+LMMQO!QtVdu;&Cqq z!iftnet2|@g%#Q@xnJoXh+8CmTkrAgBmKDEG)r{G>gkqD1ZLV*1e;&Vck<$P^?Agr zvHKW-vH1;gXUhMEFNMl*lsbD3=#YUq^u1uf62vGmDHH^w+Qwo1<#MV;K6dRqQ`A5I zY(>242{r8-F%~?{_}TGs28sH-{YenW{9Uu^Ff$W0cB|04|6RWcMbW#t9&Uz47@VD6 zD@Nflo3V-5=n53qf9zMDb~eEf6`Yu@g{0xDsPB-pk-yqpIMif5WK1_qHubg9_6jN( zvBlSpd%np?3(0L~pYNc@2kFxV?H}1*I5={T5!WWa7QbkW#zKo- zoQDSl;+XScs+u zX&i>s0hhVQ0Ms13Z$pPd3$LK-_;Pj}UEoLFT)2O?lAgTrbRFu0bbdl$|4kp@csdOm!=mUX@N z0zJ%qLX&^ZKbo{>@$Eh;rtM1arxsT#B+sU=A8(2@vN_JaOaOc>CIjZ-wlrm5miT`4 zlzS6_NITCuAgiL_ek67P7>eW(kS+6VD7m(k%#0%)em^r0On_$y`0bhoYjst<-@d~G zL&TC4;%x}>m5thyHSip>Q)Qw&)8jWBx;+4W;qHnJNW|>P*M|+|@hU7GlRckQYPtBl z{jR8uIf#=*6Km3;0}Bx-=p5i{6oV`EvXPhSW~I_kTZIIC0=q}Q>=Q4{{&;yxVmd~f z3@qs55_orA?b8@?&-lvxMFeUFFI-vF6mw(ycEdz8k#rKgSz2hu4G;ZJ@4w(LN0Kso zzsTe`w`6SyD}NRCU04|iB>Fe!S9L?uhd{Cn-g0NPp3*r%Kgg+%q8~VkWY8yUSKo2b z)SWHl!zSUl)jMCTIl@V*j#A_g&7bD33_NQg)4o7D;C1fMa9@M{P)S4Q@a__KpVRl) zE>2lkuq3HU)YO7g(c|A?i^74ND_(~e6k+%P27{5PB-JEt)tnSvL?+KrmhL=x z$;)k7mrqm38G7#O^@>YE8^*lKN){LgjFyX?abKouVE7M*4+R4T4_+MHey= zEU}?2A$w=rMbdtkUFh4veD9@%YX6^U(Zk;`zLnZnymaA&^w|4_on z`bS?22!T13=k1pIZ5#Y=%4{!B+*!1vlgRGSIIqqT-!!`(qZDv@81 zSWzx@#cO4Or}5OhvVzR?jp>j7-z+xIuC=fX5qFFMaDMKn`hJS7+`ujf7B z;=WNhd@lKduEvL}-uJM`fjXYg9?KujD>4*q>lBG%}eALlTeLmP1Z|7`Z=) z1kM(Y=UC8JSmunP7x+W@n~cO;v_p|+(HY)1PMghs%4DF|n!=($F5n2SeZ&H~{4dWx?( zr#$P>1FJ^VlhvF;FY8hH-glEw_^;qA0{8qSAZ)#NwPGZ?u*1TyPu@|LbgaI3mK~ai zXnpg8H&7TUX5iu%U~=WD;~LZ)Q2`dbrZ?gT-ijj(O%R(pioE(>@Pulfm_TxDhf@CR zU}ER*Oi1DEpu1WZhKya$zF!vZ@{!;m@KyzEEzbh7jILzkhVs zL6r|iYv|qvPR?r1g*8a@q=16iwj=o0w4@$k6Y(AWYlPb>22wNsI>@-POcnQCpd-Zm ztQ^)>E9x)qlm5BWJ~OSX#qba!k9Vi=LJ$&ppky2Jl7!nZ39p$`W7Y(8RCTF$VMqOV zCiT%hX%XOsP+SAzTxTi;zuG4|WstnI#baB#+zFun%0N-1H7u3(qk9N1laqN7IS5Y?!>+<@Uh;h?YY)W zI$nFuSz#?l`t)1p(sK{eox=J??({h~J`HqunLirSpKOxkYaP&+%wya+JwoQi(3%Q$ zA?G>}v&O`eqxDj^jze+%w-~h}V%9@yk=bcn4=l|Rima?ve_!d3#V8%%)dgc7T?T*~ z*V1jFzs53l1(G3|M1HdKw`|&y8b2+*$u+rBr~EqPevY6PN{_uhe~V#;YJ64^ zb;sDki%69$k=n;|*$D1hHYB|IZw5a53m5L?P6*YJ0clhs8s?Paw=nDX!O<}_* zQ>uo2|J?b&V*apxV+Nd0i~=!Sin0|wQ|mNcdsyOMcHB;YgH!(hTtI=~f-7ncKX9)k0ztMVR;#Cl&z`RG9f8j#!qaoK4xX zKYI+>fHLs9GD-y4NUu;kI0>vE&fU{-qJlN(*pY+46g(c6`6#aDzzb3&k@XkbOS>T3 zB;tI%prd;r)@>4aB4>z6j7CdZ;*zr7v>A8SsS+mf6 zTy;XtBOr)tGL8Zux!*o(&7LDnCCKz8WIoY7CmRBNKY%w@n-CpC|GKCR;B_ZIrDK5# zIQke6W*x{&s~3T}9O{Y3^tWc|#)AA;=+xTM9bLF$EX%l%gYo3otBeR2>Hqq7ZnXW! zy7+@7|FPoqP^q{!jYU1^=i0Uy-r(Fu&35^wtcIw7b1Pgs6Vv!3##(A&BmH7x!9GcDxWD0^oiz1x!)hj&NQ$0bT?K9JZV(9D;GU|vFaYhGdy|n zk$ZhdQISBIWr(lQ=)n;i>Q#B z`y5a-b_K)k(vBnVY-dn+8s7OA@d%y8F*=GMIG1U;?Xl(+h$vNPt{RzNQnzEl2F{4js+9QM`fy;=U zGSI-}GEY;660;41MEVKvV(mOdW(g2jIS z=B8Y!AoSq71Xsx>FYF?^dsZ{7l3%c>uVRlg$>&rE1Dn^K^>k!~>-T0&M zT3XfTd=S}BxJo$+?li_9c{=aOihZE!bC!kcWV=f-^;ZPNsGPKs(ja}bD)b(d9R4-m<%LzaDEaGb#nqnP`e}x>C;8n%6dGp z2?}gBg|%z?4guOAx}{LjMNS2BdJ5mvJphPYr%zj#j-!Fbc%E# zjJuER1SLg&%J@_$(03S`Jo8h{=tQn~u`n=Af?YZR&bh9D000;rW-~I-knAp(hyfR7 zQ|rEbw3i9TJD{=p4cb~HQCPLqjd<{TX*D{6o#9<0u& zJ^74@YV^|p0es8|h?gcmzGPs_RKmN@pWLfHPVFDU^m@=<4j%&8I9ya1y+|_8GHzEg zy)qm<#;*mAXf!K6Fh!gr=nlTtMK0hG>6#9-&qA0msRTdj(AsGmIRdoGGFHfxF%+&p z95N{E`#Q^aO1ZH!$!N&nJRt1c1;a;*Aid|g5*$SNJW)gAKOIAL>~L|6wrto^#MU># zG=2+7iGBW&4|lcU_8?g?x98vc4Ud=3oJ4aIda25T>#t-52#CS&_cizr-V~R+YmWFk z#WNX&ivGzB!AR9O;ZUdE%A0bHDN+q&Si&ivKMwo`&3(SiWy&;o_CMwPREGmyMENg# zjApGGlb@g%*ldCNFLYAra7q-4?I!7DfECN5vA`m261+ig-kIE3`KK}GHlow+7UGSt z_ns(H#uQBEO2P%jMoq#(RrQ-3M9Z36EMoYV<;^FK)djtq5Wign#`Pp^H{Y&$b+$sFQS`%t-j%A8%|HvD&^Vr5GOnjkl*X@M%a-vVC@m5aK| zNCKBe-HG`x#z1GUALmPwZ?(6XL8*zg?4`44rBK)B_&r?8Wt5PXTd5*~>C_=Y$PKi| zUsbvKA}O3jRxXbLi`)=WR0=SzFqL`U)`MMmL#~85ZfPStdiIh?2J%egt9-d-8KPE! zWRv1@6l0%7P@OxpFy3_@L!`lqIfHuSbRYu8y+WYq|j|6kt!?mi*pXNko5NO{&&NRRRc+Z7S%* zc^&vCyU4|_!kI9YorUW^3^L>@KxjR+QSjX3H8A^~u>8Q0w}_JaMAG%-ocXJAAvdtn zw2M{$ytf%b=AUD?q<+h!0xmU+rF%j@tBLnUhVU!!NF{|9@FTv+6EJLcu&Hp&AWs7_ zwpTPe6oO!r0o^4@1GfvY2mn1SmU^*ML(vw6+=Mhzk`e_at)&UzFS-$poNVNrqnG7FZw} zdDt?Ij%r~S=iP=MB1Lg|WCWSrvxh2)vNXp9X3Mt)Jl;-Kg2XB3r@Gp7eMZ+3&3WEJ z4f9trf9T?O22~8J$6Xzd`-uu6F)wKa3J12+)|%mZ}y52Y|~gBcqx^yM8$wgK!CPCM~m0t~`)R zB@IbJT<;pKQe7p+ji+37=6;>z+^|^miEqr^NXbB?dg>Q+%hf_XHWCa=-BIG|JUZfU z`8lXWFXjzX@OZSyd*ALxSP?zU5XL!cBp?xHZ;wn^oG^^IS%JCD_p;XB2+&JULPk<= z%$&@E&Sv9O5|E6&O>Ilsdc8#H4K;z!iW$OJ8&t*UZd_h3A8UnP3*2n5`@DDw?wEM( zEpK_{-K$kFDu3VOFz^5X41>7`cY-B2E{a5eJ9Ip?VuDht>KS2TOzoS2T?&K+000eK zL7TZX2ra2Hm5(ka9v}4#*MJUjL%xMs^;*^_OuHNrnRP;R z-?QPPHW4MST7c~WIk3YlPFFCcbRwHrDCouD8{>~@hj!d#*kQPv^B@Hyj@#$6^04|( zyZ||d2~?zJKE#x#;+~ja+T~!Rq`1`B#l6JursXyXa{qSfDrPc&>D+liJ$17yn-CWo zLv#6z91#B76rN8th0;lGJukp>;*>2&;^>>f%dwAU>iN%_ZD?iH!hT^!Ezg~q9i5^= zLhv-TNJQ}_YIVr#gNeP>kDC^qT@nR}?C*_L4uL#`$#y_a30{(HXjqEg?ST$*nkhFO zA7AXh1r$`tT|{_QpmmW+ZPndLmk0fI6kYabM*uwi9|&5&G%9-a8^YwK*o)#z2;MIe zH)>!U{F%iBy7Y$TiON$-wa7cmBkm*h(>)c|pz-|8;*)D1~yAm4LsBZr&>c2KPQ_%MPRYiKZU9RWnBuXzKqPH%9#fX>UFbM{) zH1~Ox4{AbQeU^)!cxXxHRw-O#87-DNoBV3 zzLAI=L<#s7cyGS9;wsuz2A^LN7Ra4$#epLiTzkLTie39Lf6w=sg)hWd=9vpnwi^I+ zK#RYhxTi$5@iFxl)GO4q%r34U`*nDRCjm{YhEm&#pVpc7DF`w5`!>^{KruiP8iy#b z9BST+r?kX*7i-d3LomMx8WWBIB7flhzBdKlwD7;$Lbo2ZKl%1W>4EHFhVeqA8aeP$$2P>H*a=qWo<2H1Rim-}=B;7*#oo52xpY zGsq8)i&$7api6ykax7ejEmeJ+YPTpve;9+=wLxDg?K{iLk%fC z0jK-0wnRcrV&(u|90;ByhgBX5JZ7Ou*ENrYXk#}ZfIq1F{u^9I=T)i=I`XLv4i1$f zP?>};Lb;ZVDasiSh;a%h$E-z4G2+#Kdz;Lzp*|3u_u!12XZuJ&X7FeQ&#A;+RHRA=T)7M5Id3G(G8 zm*DNW`J>bXJMv(thEPt+t9e++;KO7|e_8MSrO38QUw$z36N9C;U z{Tm@}U9L4L6MTLoqU!Rb^GnKs`UWEX6n8O~AyKQd%~;5x(HzAJTS@b03dYV{xIBmm1qt z#b!tH3q&+C{EKCOE}i;K6rw2!cTPH&*PkNI`GgZ<crym#DU{`VVcs`BMf5X%3*nNUT|r*C(KLGIok4Og z0b^&jvrME~SoRbm_Eo!#eL7J@JD*<`+i3n%4B3(`JWkAEQ{c{x;2z2QcwC~x`%BPh zl5_;*=@L;n_RstCwFVFs{PnJcY7$wjCl0azs+Uh1-f?S@2KQ{1zU)Vov-4VH-cgI1 zk43ME++c(^SXD!h+zW#2-w&acqD3o9i;8sM;P}`4WD25~?HwWAocx7gYXbnL@sR4k z{>FbSu1Lc~vK_?FPEf91Q{EpM!T&s1`q_xH0QOts?;%rr!5d29^_^E)54;3EGJXp1 zoYeQBA>nZepdu~fXR#v}7sVFyje#AsuEoRyAzGp7zf!$DzQ8Qn)05nke&?8u@DZ|U zv=6{@fro(t$J+MN*3@+bwr2NdM znk{~#tWVh4LXA$m)03|(#Q0MrO!)wzh=Ai5-bc0aAgM=iVRq1I&_`TGIRCC7@gVEoUjgj#7iz$!Fm_~DFZu*kQ*Y(8Jyv5ed84{;J`F1W%${#1!UfWgaNyJbYe@A zRARjEIe2AHo@s8A3S)&2L2x`F4EA99vP*IsboyC~Q}&>Z+0xJufrnFJI;Du$*MrCO zb|cjJgm}}h12+SL9y~8ku~<<2TD`qA(a|daBL)80m1}9IOWkRRFOdM^8GfZ}kyIUDtJzT6_a|xe1p0 zk>qn%fvXY!86{xaSKlP02hKP0hOsgqoFt%8e@^ zvY^k;q*df`W4J-p&+vV~f@u%%K;`~COZ?ak{H#y)J7ebWOpKmK|HPgG9JTokDUBME zGZk>}d*jyHL!P13NIhY)l@}(#O9yO&0iZb1(Ufx(DM!6^#6~E#qrcPevGEO7HmKeM zjgVc!f_wT`;6E&DGD9Xuw8Q7**AYk6{x{=4#*cK4g^QfPwtJ3VKQ_>r1IP3BN~MEjv&)H9SLqA^ZE+b{|^7f z7Dr;m(=#?k)PC}~E7y|sA|;r>7CO%fH)4Q`zS**w-lD{Z!#f)+y+*ncU4B|W@nhpHz}7Y^lHKyjQw>BeR=hNC%rBzO z6WxD6%QDe1^JD71By9a8z4sbB33@-x-x0~~XOuaICBh@o0(tof+h2Le5yMT2=frkqo|!}=lVRhqL+gQb^Qb{OK@0l`Td2hnlrqJ zAY}e`n86K)`7@ShP41lp+~O4(>@+tBwmoatIuIr*gP%HM>E_6ze#t8l0RPX8%Oh}c zZ!L_26{e~9j`r`X61Drz@6#{=q03Thmkqdpql#v!au?g&S+-`4s~CcYqOukR6vQjF zWO9Ouha6>AK%#h3nP(+D7rse9iSe>z?Ep_*;fZRy!hY7=_*qPpFU{C;NC|oAbiM{Q zjcE_;ySi}&9NuDPybI7%a1o_^yXP!zT}n|LsKX^V!VzI0x+4qQlRScp42|4P3M?yv z8s&Iv4QW%`W3%T~Nf`3JifwQI+R%8_7HD`4)XJqz_BA$8!D``)vRpd^+EW!*#(Grk zy^47Sxw4*w&dB-PyAAKL z#L69u&iHDTp(wxOTyk1&wug@>e{$7cY*@}o5oXayq2gA8Q}`;y)DT1i54_G;O)l9LH=p%u;w`fzb=ps|)E)mLutZA zo%v=s(-(2eIE9I=#_TwHeAF7Rn$J(oDS}8O7AZ;@s)uja%qZaJ+hJIe8>L;Cz3JsK zv)f2B?7Ph$*4%-=rBr=|8RAS45y(%iS zt!bNbJ)cx~;e5EoFsNo_#yWeo-6Fb`Hi zOVuX->;(1fe7)--x2e?Zb$ywjcV20PT^@#TTdPU?n`#h|#@>iu9>1f8qz4aqpa#0J zeV&=H3vz8aMFuQ9FlM#=FusfJ?}ilWMDVMU2dh@=+m=KLTC@tW`+N4sK3w8jz8va} zGQaZB-LG8wq22-iOwS^y z_g#!u#d(x+!SchnRBGYNxoiGQ!s2iC$k{U{YQzgzI@TgjV&*w|OxFv*b+zKYZ+nbf zHLCRKzM7;H)lMi3Yr4nBn7B3Q3_$o3Z2Z6-VW@-460W0QPRAGP@H)|(zfj^ld`BIE zLuUXK)LYgUS4IF>iL@+V$+a(GYfL7}qFbrypOz5I_Thdy4k^Dd%icB1)0bEyOd{d} z;9OeB%IPJk$`?=FXagZay1hKAkF(w%076rTx;sp&zySU14x7cZf!2&%tCHgy{KC}7 z4TNoBSfG7r_)36P6HH6vk5=zZ;KHug4ajawc0m8&5Vvt{+eFO`w{k|qI=&fdjeAab z3w8;wmIHDqA6cU}uoUVR4n};$u?#sL;X0WxNmzL{d{}9(A-3abYp>9@%FuB$|7Hxu zK8bJWI@X|OO|G6nqhLMz!tsKlJg~!A3-=i)L*gI3m^uw8c%nHmq+WV40_<*q`$11XMuMW(?zQJSQ9GjXQPOBy_e!Th0&j8^m1S%vCAx!rilDYNd9Qq@ z$2K&l2Aang2yjVWPA8((PH#Z(7<5@mMtLv^8D*&KdA;UkPwhGW5IN|dWqpjkT)bSw z26o6gDW%i){WN??-#@T)`=Fs$4}T=(_V*B-Mq%vo?%r$ob|q{ZO11V61By9cCK;)4 z3b4GR*MQ1 zX{MHQX^M{G?RccK7N$iQXT=828DnG_8$s-sz-wnaCzG8}e^AyFOrkM6M@67&QJNGn zUz-16iR*PW@45zlciE@2ET-YX(mThjVppXn;nlSUVcxSa3Vd5u0QkEm0EBI6R>la0%H;#SQvEmw;ZA4;46kU)$kb)g+nhV7{fd=}oi| zsM>Xbi<(Ln>S|}yW%+G^k#>is<+zV<2GRWe&C!v&F8E6*g0VX?nInRsTG4f@ID8#P zcfrsGml9b3rXT=hrgjjP=y&~kyMhNLGTNaCkoz@n1A9=GN1D{Wa#(Daja~sntuWB&Wyjv zI9HOuSciJc3YXP*Nx*B0WjSw^1}dvEQRbkJ1k#=vIqWD$G~yZ#B{-l2FiWg+5G?b2 zJEX7dpKA6p9`#Ni6CkhUtv|pOnJsrj=k!_E;-JkLC;T};7uKdr8KN+icI3Tfo85cX zBREO94-Yp2qHdOaQ7LCR7GgLl{=6SWblQml&mTArr{r??Ioh!X)95ggAJIm|j?6#j zXKcaT8BH1mxJj?FZEmaDaW)H9>aZRmhNwSoSX*dd_#qF5M6hN+l>4KKnq{YMh7C3j zxNYbGsN&aZ-$%PsU>kTK{T z2G$d6kExapo=nT!So~P42^6U;CWsF@u#oO2I{il+XVEv?mYOuY3&LJKz2%5>Z0Q%~tSqrN#S>14Zlqg*)>{TK^G(@P(~=8Dk9iPT3!No$++B@>BE(cn z76=b6nY-fXWor^cpoWQagd&vo$c|G*L^VNMqnrSH-_2|x<=(9WT1qDGDm4Yj95yN; z#&fX$Wpxmm+>mzfh9CZ=u0-{w7%3=0lF5wm?|7GZ{@Jo!Up7Ijd;HBXWmnCznuj6h5@_k6@tD+=VaZr3`+(FfmmrZr7kjbkX z48I!(Z{iKImhbB9g9qd1v{QS}%+N5Xyl3S=s>q`X1h;(bE0-YJMhL|3W8 zkb(BJr(x&_{*G|%{Zv^y>l~-X4&2Xy4DrA74ErqKL}j2_D-Iy>skJkAq8@&DrW}^Y zVowDl8Miil-H*ww7n2lQMsC*AVkz#{_>H^7lq7j?Ov<|i*COgE>ne3HM2jZ)eFLn*%5G5wbFt%g)c+2l3Ggwp=anuwyT?uM@U0|GnKG*5_&Lyq zN@9!`+I(Mu<3n~;yegNxw+$JhubVA5amDB{7aMHaVt~2H0CxL2CFk7(1B94B@|W!6 zv+iF47!=UcF`o9);)a6n+9_O_SQ|8FZ!+hYNUCK0d+1FC$Yw5hkJ9gl(fU|}#1kOf z`d^amlE+T6FYWU9}7&YjaI-6$nHr7bal|VEWJo_)a%UZ;z?pv+V`84@J-IccQR~ zg_RFgBIZ%W2~DSp<|`C6L-^wQt;Wco5yrsd6vtKevA9`^A^oEGhT zVg<_z2N#(oI;t@y(*-wyJE%Wbcto5Cr|^Knx4`qb?}Ax4{T%REA;2NFtJ4tnGPmqkb9E4%%%3s#MmD6s!8@(a zExdRRuR#feXA38UpJ{Z9et;m~?GVDnR=jHg!RYxcHzh#yDX3bz2J&l5)eXX~H{mS` z$}A09;L$UNA!5zhdM>nlYySP`6RU$pr+?6a|D5h^m)-8EQt3kl3 zTSl{o8FCxm_7SY{4g9Rdq-=TAuEHRYR~JR9jyNZ2RZ8ck+JiP!N09A zvw`VQZJ3SxUYB31<{BOy(1n5=q_qT(U9?aIgLA?USud<9gLQ7RinO%7(Uw$F0IZ)wnL}bUxz=k{<$u zaX7)mlj7A{8?{RB1OI#81gJv`fT(&xIqLXR8bCT+o0Y}o1dt+1@9}X}Hbc-QqN9tq z+gLXE0ST@kqM%B!L3jA{7Tny(9s4{nF4zd*!s;B2a=$hUUx0hyIY2__`^5(lp-Y%% zO&2F`XRpgp8>xBeS81k1VRmgE&G17W&K3UXjOL~_|Ip3ql>W|F4&CqREBE*cD&;bj z?s5i{)0F5v%9UcZDIRWL4aaOB3q)8Qs~v)0uqb&@{aSC=VVDlry2y$?4Ev<&bilL6 z1he64R=RfB$gJtN{ud0#sm059K%-35n(A-vx2THn=? zn%(yId9`X{P+e2HfRM9i8jaBgV}R<~_98JK)8Cd+v{mq$MkOit^<5TZt4plbES-~z z`Wfh0=`tVQx+RgcVe173E@M(o%8t~mX{v+_V6l?RQ9-oV$HZUGmtYnXo}=(bd2$qv z6Yt1N{R7Pb`n^Pl{vP;M(-@-+ErS(bdOLKP03IzgVt9ciOT5cw)G`3u1?w2*Sx@B3 zs!a-Qh+hUzC^ZQ9LvD9W8l!_p7x+wcy|>&&Acy(&mrg17^V{&~VIVk`wBBz96wvP7 zCS)GH@g>;fRPqh*0-_iCrdTSB$_Jy(&};_FKFLqLpr$Lx@v)kmt+oVD2 zh3;$=(*qA70l?34@L^HcctPP*Un^CM{zu7~C-l#u{-+TL^gnWy>5TmoIzU`Na`WQv zX9({-6|+b(K7Y3qP4P=+L5y@HGHJES9;d&Z1MH4ic83tu)4Kk$6m4AHU8=Qf0dIHB zVH=UiW|Rf{5$jKTU(-y^0ZU7%b3|XJH6g*e;*|!cdGSJp~>g+)UEJ|{nlS)4~!1*n0B0Qk2)l>#>IQF zSyFFO#Bl^_A&ZCe7zSdU1v^-c&I$&KOpWB5D3AO~R^$IE|< zMaI}H`1O&A6S7b~#bCFGiG{7^Z< zYT>OJm*MiPH??@!SSIuYr>qP}R)xH4Yd;@7dlVY7dsiv42qIKNVhSn7w9g$_UI|?x z-IF~YUf@W*TZ_;8c5P?Z zI+b;D;uS@xaTpy<-pLO;M0ZObIs44R)_k=mhiC4uKID!!8yabSL$msak#}O_gy+0X zsyzkwG=Yi$S{yPP2 zZ;hI8Q03uD3MFJ#ZpB(Kdz5428rE-Z?MNF#!KSv3j^XtNvev&Y5&Oi=!)KCH5-@_s zm*R-p&Z^YV;{KbEvH$`8()`|=w5F1I&`hoZXm=?wv+1d<(oP!fuwwmgYn_~7QcD<1 zl_&AE8BC`$o?=_sx&~bVwZUolf4s99Mewy7`@BwX_B6|uRG?6lTuDfzZpHiHHLN|s zSV@YOT6vsCdZyi--~=hxKsSYUkB7DQPHyY&r*k2HhDb;uj}$wRC@MtJ|SGdH6aruIfd%$MVzK#E@j=Y>LuOn zQ$wxbYOey{*pSzv%~a^n7{1a$F-(bw$CFr#7eO{~SGc!Rk8%=APbZ4F|9UgagGTpy z3uoB?f<$(^CBUQ#9bv+$fOIb^<{u+?3~399LrTayLuECf>QJ#|8S7#Q&TB)hg}oao zxC4bv2A>Hk^91%}R=U9rE~1_(h5N|e%pW2{AmF?20Zb{cg9DQz&9k=a4EE*MN%6fE zC@S!FkMO}cB>lc}r3oV(mddbq0bhVv4r)+ud`{pi#=2b)V()d=xB6{smSipgfk@e~ zmx27az0BuE)w(8)O(u-?PG!@Dwt>jOV#`Gf&_?_5wv-tpSWpwp1gqK{22kbIG4JWA zwR6a~vP4#SrOT6HmxbCH}adR%A8KHV+)f)5PH@#Yw!v22wiY`9Ksjr3dmY zIX`k7D29QpPk9RCnFExBK-1%P)&O8ofiuZx>;J#^HUt}d=WK?n-h_W?g6XNd*wg06 zu_q44)zrVGVSl7nZlf6Qa`#=%>k9oXakG2^?ERUeo*C*2S-%30lyu%I|M>Nmwghsa0=cXU%!Fo&=!{Pq&SH= z*IV`)mb%DLzEvKaJ0yM~zEU`@Ez#D|Xe~9A5`XACZnsVtBQL^{2B-pfkXuXNBNQkQ z6~QV3Q9?b}S&Q^f3?|BWqq0Z<0LB0W`TEpytODKzr$8bu1oeUrI>iv90iNDN3`kN1 zEN@H2uA!yVn?7J6a+mr_iU_RLZR1shbtgsc1G<0N3J#&xk3dL$e_DtRF`w?1w6@hj z8@+&h0okamxHBDcV$Rh?N1fV>evpZl?a%K zr0Y4z#5eNhHY4bb!ckX9#sXx4lh^FX!B^*9-sJxBKFJmo*5wr_nVV_`05$BYjucq@ zH~=$#w^KInW}@J3`b1WBz5!d=Ou0@&>?t9vEPi8WxJc^R?F?X88-($rSK8yCAk)xZ zTvIq$r$HInaT}X5=vMb+!mlNkP-Mw1_@<4gUZ>$pB2`L1j@K#Pq#(+RNPR6UvRoeL z+0E}yiS8Md=748_ah+u0k#q7#j~ILlIq7; zR@V7HPUEN-B{;t)t2-F(?SY;7dES-NSy~pd4=ORZX7WZ((oo6v&&t+!$(RLx4U!kmmoeKj)J;YE@vlDp{xvXb|N5dL zJt_|#n|!3kzX^sK5a0%w(x1B4f=9~&S~0N8w*rXfci*oD%0p;C1KAECvb1y{L_ghJ;&9-n7|Q4!(abPpV{cM_{HH^khD14aJY z?2@O6C07(Lj@d#8{e#&7C`}_GRYNIq$zvr&wXHcl549fdTFUIj3S6EY<+_Hwiw4AI z$VmwW#09SjZg*5^ObMlh&O_6risYdaBdOlNCK5X?AHkM*D1pTai-T$VNu_9rcfz%h z77kH(;ZZkHZSNY4>Ym7(sG2mH915?cKK!ydOW0F1X6>KDrU4YBxrD@7h#y~xhOhS_ z@MFY&z1I~yg^ncNi2NORaH;07)5V`8T}u_a@Q$PZGK_45n}F4LdU|Mo#kD*m8?1B` z%{PcPA%<b8TIbjf`fW#vsOhJlP_J$2DHcp{LIQ2W(CsG#}zK@ivCo0 zK?PEmjC;0*d2q!vl18X>;+O`v2A@^C1_;4E4GKiDiV1RBaKASfsvbQ0Co?sF6aV|I zGVedjN3tN)z9ByLJ^LOpwR(CwPfmd2x$Svp2R(ZB#w>YP=5*+HT)@T^TeSat6Sga7 zd@X7-n8l?X3seEoY}Q!$_s{$Mr4qV31@L*3-$&ox#mLo)-wJYHTU46R!-(I?ufS5+ zqijFB{VFV?O74qK=@yBSB}RtC4gEuZ%PV#U+0lqWmtp2q2Vkdj%bWG=`o|pKC27wN z?xz;YatS&IsmhlnHWD?q3U9!-C6=*{jy6~9QiVKoI`@2K-rov#a(GBb9qyLh8ysSg*r$ zDj}RKosVuE+K=wf3{aP@aWY32FLAACF>;2jsrG)3Tw%OgN?4ZPQIcXv^bp?Z5}|mJ zzTaX9>q_iLtp*GPjXZo{U|BSAutOqF^=-a5BfKM!K$WUKU&a-5l%FR#`bdxUOQ#2& zl)DH_Crp`1eG0xgdW=;0o{P&I^&GC(MHs=EFz50bC%)oq ziPuo?W9{sfrUZetBwmZg+xjhKk?lDpc`nB_J6`2fT0 zHt125kC+#9l?UD1uf4D0&pdPQtFN4XrMJ}294fou@B6Uc)|Un1fJCkZlc(m`dd#Wq zi7PHh{P?==R?x!4)u&UWM1wHh8ypTJtlYMk3crjRB&y_pdRgZPVUz}(x57f<{C4nL102pu^Mh5wt7&GCSE})pYIFo?5`I93gvMt5BZ@r1g;-8QVMD3X(w_yNFP%#?eFxENaz|xqs#( zT@nz{3{NuxI4nL6_Wq?P30CqVF1IFquK;)kuLxZfW+p1*Qziz)YZc=OHy=8+nl7{E z)Liyj!vudb($5g4phhBA+r$|TiB)Iw4DD2o|M%h5PD`Cym!i1;tZeF|k&b#&ChJRL z7C`=|9bcsY00RI30|G|mNdWGIqw}&j#j<@!c|Ns2E{X)w3jdvAQ1<%k;_VH<6*U^!6 zGLY;_OmZx+T9_msdX?~A2**A_$!Q4?@(3Ux)3h0{V;#nvAKb20umW=zcD0es zw&QKn871A0m|UW&BD%&tcECZu@KwA{gPbT}*k!fA(QHnZlXIk9S&CygJ9FCSh5e6* zCfc6E%-y6Ky?`?gMB9Yjz4mt~J4z9_MqXLTw-y1ge{(pJ&~s&v3O%bX7)Azb(UoZU zP#7AxEeFp)(65l4tnn!TxVg9I+z!l=$S|`E*F@!HY@BQD@}^UACq&64sloG?g5DIW z)9Qs~EPf%bbp6&)bZfqA#BoLYxt#?$&ZMc{k)5Agp3hVJPsJ0!G%)$; zdkb-%I?2ot+rD{mMHGmLpm&DE?-o-S|LswYG^JQ0N45^R3?9Wwl4FC*^OLLJc|C73 zU&<<`yQFD-Zevu?ApYTcI8@vRI|dz^xME|TV3b5BD4~~`++NxLk%hZ*A&%|t9U5|8 zbvD-8T#}KfMcOF8kXC*bxLw@sb8g(2L;H!qOS+_f=yxl_W5?JNThiN)f#|2D{m38< z?6^Ozo2CBwe&$18X$x>O!l_irC7)LW4v}#eQ_|{q&ULOrC}&ngl0*o<`d(|SrLK!} zRsnh!!L!Njs%>Z9A|fJh1auuy!N4@ zSCLm4E*Q@MhTcBs&Q!(}SBpnP!4#l)Evq(Q8$Z^T{^JIqF`s}w#w{1j6|2{(@ob#QUk33MvfnoK}}GJUC? zzFj396{Z>lw6<694R=~t?;dJyE#V-W7zf23MA16CLj=`}rS*2KpmoiHj0a%9J*fue zAuqt`DR*&c`Yv`<{grOLMbjb9t~ryvk7R|^kBneQ>b1)tpobHP7q%`9|r zxFHL|cABMgIMhEIEo-GoPOgYOnzNS~#`iy3Rd%Ik4Mb-|U(QKMdFYMvp0AKrT_4k~ zCx<-Al8}(5M|aYPNtJ443&=}%E<0L)eIC>i*N*@&=@Ijl3OSUN#G>}CAW^&L(m%^1 z!6Hsxc{dgqAao->i*{(TmbN8)@Cy@%Gpg_VGi~G39X|5f-eJhs$||+;Eua;zxA{Hw zObt0@4WFI*D(5syG=_KFVXj)g=`CXy7!;kH3%@d6rRW>(vLq46wd1_R#4NvhFlp## zz$Ga_HlUDir|2|e8>vFJphbsN^Z8tvsMFpaTSw_y+%p&`;~{T*lHnu%V+FN12}t;R zCD3nVRjR!uAzLET@b{v{h-@1py-Q4B0>9D5imuP=rR=#JjQ3=dIcgbqQiA0*%r8z< z**eB%U&m3_fp97jqod)j6vf>=AbMXpr*!vN$PcXeJa-W8RRSR0E2gu2mT-d zB&y2>-S_8cXD1!Gbz2z<-^od2WnIXtp13D>uU5b0u2wsQx>o=d7QlY9dCZk4qS?1c zO^3%Eo zq|VeJWM0%NC;wkpx97C5+PiQY7&654Q;*8jgEt2=*4CjxVqyV8!4UA0ZC zgG++R2Ys+<%;T-6R>$4*;vk1R#v}o)oI5Yv>tJ!LPmJIIP*4nnm0=uHh6<ev;n1ylpNR5Dg46uuOxw^DoX#^YXFIlG++Gzer=iCiDHX?Le^n>)fmSO=UKFxl zS@urA#}eBow^NnU0ZDKqB>}dEg{Q5u$hbN@2W?5a9Yea9(ZCg9bL-CHP(U%{@6Ok% zf9bKFgFQhk8!Mo!G<=1(e?4LyC>Z;*$L%ZVs_ly+IRi6YU0UI^OYDX)g4UGlaoA}V zej|+pL+1}u6(!z#A}8XQ7VO+e;V(I6C_2(oC@|{UWrQRnFg)On3Ec|f z0_rV9c6!^{d)T}8^Ou(}A{>KnXZ+0Wr6!byF4WOiR^w%p77QS5X3U*|d#)lQoaXarP;FE_sh`E;xWfhZ|Nd%xM-Tnm(;wW|PPe?x>_eUabJEbiU()w~L-76(b< zZfNvdH~1D*3}{+mlH4TgwUJ2w!|(DcOUmwzTm`k>dzxmb;NNV+U&2XnDIjh04q#=L{QdiJIcEZ}OF-YzYe;xLm zV@|IVL^W2_qn_USR=Tb=d>*xn=LQ4h zCleY-k7n3u?f97|bE8@=#Ajdzq|crqaX#~-TL&vi%Lcv%oQLb$2z0-qDptcxD9Q z-*n7BSGWC2=@I$h&PdBnNy!J4e8QC&!6j$B`*V?^p1qc1!iUT&c}|DZE-KJp1MM?j=TyU#E6Cj02w*gH8=*3Jgm+e)7#U8xhK;-lHlIT87#0{ zvjFkV21KSUDi;Ah%aH3l77MBTP9Y)RHG1Pcghzt+2fp(oUPJls>{>-rvX(-YsTmF$ z$-IYL71z~1rwAB^nYG{_P=;~*#KMRzi~03kL-*=O^t%P`*JrBehA+to|3E?AMoAtic`&f@Fvp$U9$EGD_0IcT$3|-&$s@&(coRF7P6p)!lO@_uWX3w@un_R4!$D zJAf}QcGLyX$QfHSpIk0xe~`fWNzP9^y@RgTvTjL81og&-9; zeoz>^tlxW8(f>LHWV&0nboj^LGH2#*c{k%b%Cn6ld_nfRI}!F=6=~Y$E@dpvb@XaHOvbS@k4RUn1gqhJ6#oYx zXc-Bp6+t&P{(v2ZN|PBvtZ#oAfv{RRUj)?-K9t9EcT`L?fljnm_OQvRHO;xBTAbK| zYt1cC!0K0>nRAUUP25BVUttj2As>Goj4*~Uw_;f?#3DY1|y086=e?O7T=MoYHNyNE z{qMar_{KIpx$HHkpMGjdfGW+bY?$eJNkv?VuJi@*R`Ps+PaMd5JBkN8qWX;%m(g&q zhB}IAeM&pCxZK&QC(lPn3=0lEm|En+a}@ zFNUeoW_n>&0Ct{dJtn&U_%#Kif@H~lXiJfmSIgyo10?F|zMtn2P|fDXz+B)>8c4Q% zRsU3vIi_Ac&VXj4UZ+RN1q(l$U2SnQrhHH$nU!@WRB8)a2(>J1$B>RvXU(8Ojmh07 zA-?>&g&9xr^#L|>T0N~Xl(zf=&mAs~@Pdw}$1W}`=@#a^=$h{l@c+^~_c?AQhrR&t zCSacmaT>ZmIf72CV&_VgYgtn)h*&rT3yCuL>Y#eQU>UmD_(2Eo?KDwA%MxfEs0(R~ z<|NTiuBcKX6pOU|nc$N#Mv5iuu&83#>R=w)tfsOV{(>p6cOs{jyjKA5lfqpHELA-Z zsQ+hIu-_!OHtQbYmGZ>J)X`Z2*@vZNYw3(fMdgwXe??;rx(ee01V7e68Ef|{`cJ4* z@aXqP4qbwK%xt-0s=voAWcoIGLPE`@MD9@_r%MD?3adUDwiiaFX%y^9Aj2R$3=Kce zW84>)IjB`YL5-$|LSxTHRPAC$_F_fAAiH%{ z-gZ?+cDt}^8TSwmDo@PvlT_JZQJx**bS>P`HbPo|Q82OCB0V-@To!4RdA_A#Y(4wr zORmuzT)6lqZdst^41bm8{Cet}Va@kWobC{!3JMf%`3I*I4&ls! z-JfujXeT}mIDUgfP&{_`Bp+dz;|uf<4IY#XH(Rg;1H0LfA#<|+?B>MibN~PY0B!)c zAklZ?IU8}}M(je*LDQJgF`~bq+^g|_jK=TN?567^PHPFI8;x#Dy}u-m|CPK!G!SjG zH$uOf{5I&yCW{_5|GbRVX5sK{r*Bry7{qyG97c8?LI}7lsf<1oydZGUXbw0m=+dnS zmLLcc#R|39beIt>Rts(eyV&8}8p+W(L&UzZ=Q%KTb=VtZ{{M61``59(l$5Blo)w@( zrR?cD1L-XcevSgjLQPO&iK;=AMP_5jWr5Q5eQ9{QB7V)GN0|c8FK?lqyNkK(WL}+G zWzB`;5B}wN;G4(_jym~Xr}d}z1~TakGL{RK)8XEf!VVo+eL3tc;$KgcHLLXdBmsw( z*y`>*xyE98u9hWC#G#}fp!4EP-GS2DtaXM;0zjet_Zh0vPS076c!x1wWF?MhiK0r|Oo8_}8%sly@C}7ul$oJ>7#C+uu>*zZt^1n-4k=_+d4{ zw0FNX`a{pkx5y3$wRp+twEt!;{akYjpNVeG z!{`jF*1c2|${l=2`ei-ogdnKoQZwN8u?+Jr?ltGJgpbScMjG~%^7zgvv6gJ07Fv_u zl~@TrOUTt2&laLO!f&&HKHC2PGeFG0PuCL0tf0a9m{h(jNnJuS4jS}6&~$4sEUnq3 zqR?`Ri*eix!6zL;)jw6TdaBOxe*$06KnWP~j~L^rIJdpM;(A zwP$p4YVh=`IuJGJz{~C3F7Nim||jA z9ud@DhQ0A_g_SsSySoBQyJoJxwp408D3l>5RCG(OjF#+z*ug|A>fczyad^0S;PZ{2Y{opVv17ue zVD?6$)+ZnG)iQhd1{p|-#rRBr`qNgGDRhZy$f$J&6MRy%RQXODR~!cd7G`;*(kfH? zVUSrhqcPwFcn@zXPH(*4RirclbU4B&dudx7>#(rd&Eby5(Y9OZq7qWQrm-&NwXgDW zI&A3+rf(*B)OI+UHo_EpEO(<9*B`AxwGmrr-b6fnS~oXfhf^RBHp%WM%^yAI(FX-; zBXIEEdUbh&qEY)xY&eGfd4ZgT>EdHA=E$8h{R@dy_0O?w`yCU1SDrji8j82zU-r(9 zygVinI)A;sFZG)T42kn>CI=3Em;wGOf5NcgnU3Gl`iRNlyn2=6Mr*6t*w~^hfR9|m zN^YO#w9r9xU_q-_wwEHg(IJn6Ou(iXJr|9yQM!*+{^+tpsB$PU+^Iw`d}%raRK{bf zfSaA}6%XsXw2Y6OaW2{8F{bD~sm~nW1mg~liEEsAtF$LemsY>4PtEPRt`a@klp5xr z&RdTKmr!t8R!dCIzD*!L80aJO!M6wF{zikgb7f#Z@)Fy54LKNx=OkN`m_I>l^PI<0 z@gaJMijJyvDCanxncp5q<%B%uT=#=V;_e9`s-UTeG*|mtskW8P(w25Fn}k#SQBi-- zVix2qIt4hBLkCh6TkJdjoCyE$@L|4^m$cAMgku|8Lh#At04!UX%>e#_C@yHi-3n!p zb(Z|et^WACh|*r?S#K48=hOy9Ujm}l6#K{z)*n4A1CENBqA)T!=QsGx1J4{q`HXHjmNS@F1s&u>HJ8w zKWnan(@o}83;2B?09z)h1t2Yd_33}a59e^IiIjOoo=0f811X+`pXY(RIW=b?-{Ueh z$h#?fb%rtK)p|a+8vXdUqH~y=|WbZ)v9Xk1L#dAKD zNnA@4wiGPU`j95u!6Lf;b9zDLUU+0p^xL!q`O}kGH&N*fensNzHR(>;E2aQsz9c6BeIKX3sf2W=4 zy%T3F78wL+&Ujs_-|};vjzUZ4_M*l&NTIoA$G^1>ihlC<-;j*Tl{Ne{fJ_L^FVVjh zVAP5l?)|~^r}yIHL&)PV;C4nCZv6jM7c5h~f?|MOl6bbfJ1uR$-W1IctJbWoU(FIX z`3E9|iVAR?6GmAC80*Q{dj0Lk%+#fKwLzW>`g{>V3l? zFsZvxnkS?P)4C?y+~jj49ia{3Y1Mv1xU6is#9s4L!sC4Rjm0=M9l&IdSCPf=HUynU zV&py8*5qp#G?3qu5aJ)+tFkN*;+{R@yx!uDrUUemJ|DLb`#cD-Ts1JDJ2H z0;#w(abzeV0f2U_(0{pV8*rlHdn_~rAsX!^=w5qazX(K+73(yZpsFx{;JuI!tN;K5 z0hzG{KxFuf*gf_%=Cdu47xiFtCQQ;ab^nna`k=xeoEVZ6XBmx`EUXcqv*z-V z60!yxiwfG3(`TuYI2VSH(!ns*7EY$*H=$Gy!9;8M-7S;`9MDbvxi*T*J;MMx(36I~ zmsr9e7j0*M0KBUSKYD3(=DxIiEF+C5Y%uBtsukCwwQmvy?>6+Ft?l9lxZlNmgWk8H z`?8Leuosts1&NCzMLvhOC3gh2{S=i3K3cJaTyX8oA=`<{PF?`T1C?>g@Qx0tJhd2n zP}0S3n@yUi-dB7;LLXU)I;(3 zniYQ;7VR9e>}U=C=VN9{I4oCPypNb^Q+K=k5|}juR_Tz(|Irx;;V(cDkPL1ZoR||4 zLbvvxNn$+x#K~)KD*XxZgx*biy4V~WdC4FV6%;+s`ppHL6%Yuc$Fd1)?Uj=Q{B4DpLqq?9LpmAd$7>I0d66B<#{%T zEmPz8t`sn@M^2%)ME1e*kO!T{h!nAfy{iVb+H zIx1{L?uIBWJ16)Xmf|i<+mx|-XlCh`4ligdsd4v+Nu-$cmN_9(pS}KS1EEi7+RM3io`$o4QpVQ+F9DKc!;Jj;FnbMY`yNfJS!JQUG-m<% z*Y~9S>l7aUdscOLdX0kwhjvK4SSr24^n-kR!B(Tdy$8GMT7edMU)BX(fh*4u=mz3F zbH36)$*|eZdR)MJgKb)i+$U8^-wdRI|IY~%IEPYk*&kO!mW;G759Lj5qOxoddQ2-V zhRNMdXSbO*L|?v(R`yv;U2K|J**6#TS+7Gg zhikWs5UFe&rf2Wsm!c1xwitv6WV;FW2-T6y$(fvex|5{>MbPkd{=h3Z!pbAPL29Ucf?)FdBaZz!XX3AayTcXggy!D( zH^Fp$dDcbfDGiCLq_f=US5Y&Mg$^lL3w-(BRBH+aIuxL6>B82eSx zKBi_YE+E=!K9a4B5`B-1=F%`2pQdrCjBw$tNP5@`o?RAp1p5b&g` ziL!YP`7-h*v?6N?qbEgT4VdZoJbGoIA^1Etw=-j>ib(kxIANMO-{SV)k| z?~^wq($4#MXbgIi{GQGkyY=&8>gj7_18o^Afda7H(ajUrordAE5&dN}T4?g!@_O{i zM96qt#)3|_f1ZE;4Z#P>PnyAY9Lq};HdD&6aRAM-rn4Ns09Z^mis7~z-Q#Z;#3rzI zd#^NLd6|-*rz0jIM61Hk>T9Dwr!MgY5IQd{Bu(>9k@Et~K~7HUGxg`GwchaM;w+D1 z1RJJ;-K{YJ2c*2HgmRWBZaM)C*HQfS{{X@x?2cT0tvF@k*i%Nns%T#5HVyBGQYZ)P zGYK19n?j?3tfS+oF=1hbRKY$os!d-al%O=RFJuegDz9_4>xhrZz!sHXqP#upyNM`; zpVOjU-v{kIW(9T8ilZ_9?2r(9D&ra&>}=fwHL*@3oJ~-~^vhpCa;49w>R{`c#+x4C z2{X44P=N+%yA7WjyrUt{O)KU^B$#Ovv}cEl%6(sM-KnE)SO?@fKrybZCTw*3k~1^; zFBKK4IiSIK_NbPz!CF4vB<|SJXnsdk70PGA?LXNd zVN*UR5A~o>O$u=(4WZ5vt2Ynokjkmn|(R+0-C1v z^u|9ByB#ObWnBpT149ObKv2!?re;d8*o>(A!BNr#UUcgyCnStytIL#=HV)jfW)f#8 zS};%M(husM#$QrSh=o$C6ryhTdva}PMJarO$W+R|v&21pnX#Yf+l7PID0|tAjB!I2g zS=4dFrHG6Q@u615tzvL)4j$U`HV#>D4fxs$_(Q=zG3GIedXjNXn#kjIqE5$08$P$M zYLbL&rg9x&X&t`g`n`crk0hc3maLg8Zd~RCTY~TBleS@&q#=W4+E%Kk3TciLM z*9u{+P8#G26KE5gN@;vA1q-<&WOIPGJW`Al9vq^?U&^{wr+}@#c4gw+?MdWgY)z#u zP0`tu*t>+O>BLzj)VcD||Kadx0@s-Gisrt;y-3sdKIhEe4&?9%RWWLt{z$xCE0_mY z2WOwx0wLU^@Ug8(zKM)gXcT(cV>YZOqqZPNnT^7d7o(0YZPA-(waHr}v`y%0DX5X?GoHj*g7HW(;WXyY$qbP1ELF8LaCD z^{m)YPXPy>oEp_Zrl1=jJWcGdVU}?bXEPdK4p+N>YeLTZ+9ZGKXR+McSMHZ}w1WVW zCB59`Og$_FC1jtA_@>tskz?|aR0Ha0$tGv0FtX;e{vZQbqN&9ok3Pmt^TW`eiH6IN z2cp$PHDV;wqxlg+5sE)vMFqPXkAd4+KmYB+aI-WX9)6QqKcR#ws_*r04Ww+~Ue=I{ z=6|ZAZM5@e*uQerLUB}-QT?eV?%n}iPVf_i@#JG;LOjhNclCxCJ#JBf^7-8yJg=Y@ zXwXG`6_$qT76@vQQu{Hu0;G%}=v8sXb~LVrO*Z7w z@+P~*NEESHMN^w1Al=j^be?+8*fsS3XlpHesL)d4EsP@IR4)ISU0bXbHy#1u05(er z?%v0^;xNmAx-FL?0T)x9q-EFp1MQXPxr+o$c;+LF3rp$)ER7g>^sz zr4wLxen6r4RA~O_*guu`@j;p{h|9vw_X1d+MqTTpu=PEvA+`|DNM28l#{~O;ze)W< zq9$9C;AKvc$WKeP>#)j!@oSwuQO=CeS0CIw4jK#?=P-C4H2owmE1f`>m9%RBF|CB; z3J<`^G;4nd=C+)Swlw+R^{OUIK*o3XP}|w92(lj`h(6-8aU>JKE}u8o!zT>|=*%HU+rLVS_{ zkBVeJxx$TQI`1V$6P{gr`v6JTy=+OpP8{V9?`59q*_%wq-Ra~4z*lh#9+MzC8R3GX z>I2LB_P2eZ+Jhp$opG@JW} znGn3rRD^qAzH(eK7+%BsVCdIA(F~<{-n`s}tpML?caE##setg(sW?+fVibIE!fnA& zbX1;6w|R4vKF;1bjn0MIK0*cJU0!FK&*gLtA4#Mc0XEejlM?KI*NznuSI4-m_W zuMnpU#`zkauZ{8w8gISeDcx!049vZt{aYN&&|zih?#8r}hIntCg|6X0GV`CtI%4p) z{ApdtHqda!WM$q~lj>4Ka8E@|HbxS7hCC{>E1k4VN|31Afjivk)PAI%xO9dlQ+L{B zo%l4_BRBJdfgt4dXa8cemu1lx_r0`^79a0;akeOB>oY&|_Fc&6L$k*4f}6AcXWQg< zpyt3`t3qsrh#RCEwh^SLZLt-_%cnHNO{RkO#XnBNrq(qlzvBs(qq5*w#-olBWu`#3}jlC>ORgrvNTixQ7#sDz-PK6<|Fd2kLy%;tp@Io#A`zemJ7v7Ubs=H4`^jSEp#7FZw7A^}otoD#m zrq4$Is(b%-QYI0jZ>*+)T3(?OU5Z`Eei|l)00`ZpfC$_7`au2)KqoaPy=bBb3bgLr zJg5N#B;6>Y&a3_s#t#9OZZ2m}=RjN-zB`Tr+%g@LlLXd_TCh7a+&&w#e9FJ6d*Hta z9}=%LfCdQ?7a`kw_m^NL(AqbnDv*x=Q(s%EgF+jq6yqK~Ca%lwu9&Ichc+Z2**PxdjsSQ-w} z1!J7rofa8|wsUvd{QSU%)Sfd(#G6{PL>O|Z3>rX#2qUSYQ

gaZxgoKJk2rNT!wB|< zA>#&wZP%^-@NzrF4 zn_-PJ$|P;!$t;|44$O>CRA)qQ$1m1(h)D#IP>SR_Ajvq$zf{Rnc6K*H>exD+`tKCj zNDLk9!2FD;jkSmy!<2VvOVT4SoLT7S_x&7_J4B1Y+vq&C`ZcuXtPC;%+_$ix_evPQ z-G%yLxImln>2?+o)BQN9GsFO~~^`TnZaH$XZX(zF>l z)0oqNK%z(J?$hltF*TiokwqL9mT9_pZ(@9!_Z!SJ1JT9C7-W>YP84XaRH_G{qPIuA6Lud&}Bd_L7?l)97H<#t&;6Z=rlvbW0+j z!EueGH#7n>LO)yO1sK}tN8J{@#P#2HJcPm{c}o=KXl9(4cp!ty+HP8)%uq*HFBLds z6tcE@5Vh{PgP0dKy0~N64O_GwKh40EWn$|AjG`cqp?^dy+tEa`}kS zAGk#59xg(|yAX%E3zv~IU*Hqm#*P300{{V3Y3%iRU13bGxOUZWqh+YWz4=?yZUEED zpOe#LqvY+#f0Zdfb<3Cl()XsCn|InuiL1IL{GJ742f-Gq)o2+lMk%h2P}}l8(%{{} zW4A`4%C&b4!EmY2lU;{4T~)VlvMp9cmTwm-zu^EnC&Q%}5q&%rc{CFLQ67=@9)h;5 zl$!|rO#iZh)zUu(^vFmx2*s|QJpJ|W9$Ns(Vg`bF>C^%Q-B3laE;PHbWhn!pIc zdS4eAa_^nuUu$W3fF7U#00RI4G54;$r6rnJZ|7FPqrHwp5j_plCxrzD<3v&-wrh;2 z>_dZ9;qwJN;&^kDmCUV$V$X4HhFlluZ}6cAsIdQm{+A;(sEb|9v#4XaWlIVII^RNO z%@5rpJQ<;Hml3o7kRPj%s2G3_T?(3GN9}i@NCm2uURGi2iF-WqUhywJGqF28Bx7wB z8Uo*LU*3X|+y-MphjeImnf-K$?$ilUV{K<;qrXb707;IF1sjD^^&uqE@-g}nbdZI zpZ(2r5U)xY0009304}p;>O!BLKhiy~4{V$O00RI320ZRlynv>yB{XmV00RI32;7G2 zLIhRPg}wczcL4!{Uw{Ar0{{bCN&!LYEBXIo4(Knk1J*DA00RI3jW05MptE>kn~-XK z8~m^U00RI3Mkq8BM5%TC&t|#R0009300RKDXz8R3)s897VRG|6e4(?Y#w>gjLgeo}(JTA3(AwjjnAx-wNB{|mfnfVgnSb@S z%|EsGmT*!;4*hBn&bxOGH*6#Agid~@6GfGGQ}wF%`i_XuT;;0{@`{U&y5#EcDCDTp z(4JQkl%ehaa==1^|I@cpmnpg8x)$aE#H49e5Zv2CNBJ>^<7p$iZYiRfQo-WF@W`o6 zJ2Z_;>P8geoa(Qwg$@7!0{{R6008fvLi;_OH*|cqgK+yaJ%N+09`Q`Wq}<3BNR4!q zF6mS|IWz4CRrFt^c1%t}VuB#T8u&X^W&O#>e~O-@UcGJjLrG)m0009300RLTtdep6 zlAiH-@WAg^wzeFdV^a_o%Yrj+%Di3nW!uZS|8Ju`?dwUvsrZ+Wt*0osvbX%E>5!yW zLfn^W0v_bwAjJjcd?t|B?Q=|y;2~5100RI30{|lfH+!I*8QRqKH8G-nhFC2?x;ICk z6bVyLQ#vc;5?pc|mE?R{MZ{yN=2nf>?$2heoQy*9CaR%WNYs{FF;P*`LwA{ksPooB z!ZD27i21=!id9{QXGsY||Ab*|A;N_eJYTclxS>(Pq*j-pu06Djw+&o00Wj~T0U}5u zHJL`a0uR%S@>Gi=>K`EQCmJ;A;U(Sx00RI30{{RyI^X~R0{{R60009300RI30{{R6 z0009300RI30{~QO9X}+LqcjUGgSYB(eqt0Te}td0vfLD9+ow)vlTp!iBRxkAj8M{gO&4Be1$F8v^s1bjNn`u z1Dz}XX}F&ilr-QdYh)|JYGE4Ry1V@(!~g&T00094noCi+MSdcSW;5h|wSTNtoaoj) ze^JMpq_Pi#W?d2eQ~=9}9t=MSIwl0+wd|dmg##;Ud!|E43=+UDEb}Y{hC9dPz#v@N zm}k4AmzqorWAX@1pinh(>qyB@<5%{iuntf3XUPj7zTmj*P6>9ilGZM^-SQMwObMVX zf*{*s*JTKpOp$kYC9)-*3oouU8$cwR5JZODh~+H;mCg8nu6(se>G~+8v2w;*7wXkZ; z`A2yiWFq>BRKJ3Mz+ZaC1CfU|exWI6^e_-^wE;-~%BmZTTV-cpIEUr77DDzNJkhbI zP_@IrEeD7;&-c)x_C;)*;%D*wu{`TFg(ZZ ztSpOMwhGGydwan6Xg$inlwxjJB!3!n;OgD5O=;UHC|Q4Sr4#of?{c-^)8#9$yH4dMEPx#+Na}p&`Ntwiw@C2D^F919RCmo3r=$McgM^ zDge8vm&We3<(P!dkxx6$hug3Ewlft&IJAfvU*CF{E!IYmxBXVjrHP{~#zr(3K2kKr zX8UU?IqzmTxcjZXIaddA41gO7cvl16;@a8b@1j;Z=@1?0;h=lvAfMeHrdE*OcfVXd z<>;(Slp{6(hs2JL(GnDnG4=T+;Ytwa*d^P8NL`52;tiQ}KhGuzJ^l$lp$D1Pk6X3( z)R4tnGgpL~j!38>1A`tG-F%dUfgoJbQxwv}D>OA0q_%xJLK;yBNN`f8N2D!L z*Yq2ptKI6_DQ9bzwSvLb3;4j+{?vTcl}blg(EwOnQnx5?)CTo{GUBqX{55P&S5^5o z5cg%UV=*qQrjuv(-u&m4J-Ak zsO&11RTzp)`ivLz5iVTAn|2%KZw(3IXZj>B2{midRQHWqGpYz{%h?_9$~CNOO&z76 z5o@CkU8|>TW`KNZd-dt=GGQ=dbRbu+260*j2*)MOs@Bw)-L!0<_7}t5U)pj=J`)#j zrp($@+WI|aDKb21##GHCLoCmoI2n>fzZB@-p(#7Rk_XUPs*~KMV9d9K2s`yY>vl%SL)4hL)T6JyEZl8>h z9NcCNHO&a9o{$0mT6nK^k*w@TK04>KnQX6rx(JGn^}ocl8xlq+UeD*QOceluw;%a1 zTY;0=>-SVC3}pYQBG?|#D78!JRZ<75AV>4?^M#r^Xno|xEgei@ovFTjE9fhhL1dozAP;08Rr8#w~Bqp8gxHW zW1!Ta0eu~X3f+3@TJ6%Z#*O7560ZTb0o~5cN6)!PX=^JQx-X2JlD-8iQnBQuTgTFY zE(U{Ke(r2H5seszG1X-cSj5})Iv-Y@Vst^-*DEyEREzqWS0 zd-3lm9!d>&k^1e|7k7jTP2TA^0Q~Ryk{5wPT7mL%&@-edEO*{LtV2n57-i6Y<|5*< zPz!9x<@pPdnlhYh`5umsB{^YAO$QCT-+|BJRl$%k>m_TTL4Hi$FvjrPrQ@~$5o+k2 zl$kx;Cn~kW|GBHyHFNCJ?C^N##Rtq}#d9))M-P&6?|dNK?l>#%{vwVe;Z7OC=_n`J zq4QC@FJW7zG+4Q&tZV;grDM7PK)4--CNDlRvfdfI>skyz zq?q__ll&5V(>YTgOIyjHA~mGidB7*3;o*@ub{bF!4Bzl35d1a$pc7i3ts@r$wdl~# zhPs$kk@@sqk^eo2gJvNVb|insVbW?`0)grd_k2ADrHN3_+pm}Li9P|-j{8WkI`sR3r$Zu8T)1xU9r#4P8 zd3ZZ#;xFlg4~|{RLUW0DeT357I*)RV2A^IK8 z8$f|Gv#YRoKQ52=HiXY=uZ)4x!3wA>ciDn$odBnK);*vbPoa95LmE!C$u}95?ZDr< zQG&}Nm<%pH9u}SXuQ=`|{a3+?``ftHpZlJwjZ2y3D;M?L?jOH{SOE4oQFSYG@ArQ+ z4h))>$5e27I$9trrAG9y16P(c{+w|OM3jjQGfUd9_~bZxjg9clqZbQ_Zz|7ZWoG$x zQ0L=oPz9Wy_UG?Rg?d5ovO9@rxRV00cN!(7MPPbnu8PN)srqAp27nKJpikgt5uzn>SQLlERlwKK)vc zT2!%C3CU)hmvpI0^A&=CE6J?sPOTpw>$?vyee_m7ccW47FjTG~nRlw)&*UB>pg}h% z;GfeKjmO7r+wngaaZ?cy1>yU0&v%v&YTN`vhk+4r!JV589^mG%!HElVZ{>bq1jD;D zxiiy3MNLVH@hv``BSb6^u_3b&5v7!iprcys!~#!f7Y)jja;#vb7O9{);NkGF50mD) zK~Cb;3>N?icP%l56bc$wjQk0<&y$M`x4tLSFd?k~*>eu9YeJbzs(6JyJUnp&BlC&Y zGI8DC0_|{jksJ}Q`?rjyaY7yj9xMe^wXwr%!;<1qzxrba&VqLj?%)}5nZ@fLdJG_t3MK##RTEr|M_ivO7nnKkN8YiuA@_?^ zwf(a9>g9FRUEJcPzqH2^?AOj5g5tN~gh11FmvN!dQ@o31jmT}$^8T&;U|P!{lH1^n z=Lt%Rvr?y?-#0rzBO~_A^h`b(2PXzIqp@8uP=Hb@dZEAx^mBT23nn22jr+(cE!O6e zis0!UEtk7HtNWcw9#)$qGe+7EUh##;&lZzvHWg)Cz+9zb5TBtW zd8AC=V(oAxGr$T2Jw&2>qIlXz{WA)gA{o=9J(*7?TD77eMD@ z`8t>{=f$_ak85n|42F5CfPWj@i5qhi{&alQ^A*$<@X_9C^De6Kc(Ek7YLf-#9 zxXwLB+rmR3^L)10Pk5EJB++}#y7(6NPAC^>P&@&6Yw~Yr^X|Z#Ltx>t#volXzW)GT z2{yl5fTP3`|CG(r@Zm%U?;cQ`M|M`v3fAC^l%D4Cg}~v!#+1Yf?_Yl&#Sx(Ew+lWQ&yN z|6QZ_a9Kynd5F$&hSPJ#SE(4qh!jmykr7e;3UQ}XX$=OSUb}iazO-iMZ)qj`uS8H7 zQt4_{(fXXtG1jrQ|8*tzuF_7n*|?wrUbeNtK8~!rZbp~L*C~Jn3ZIhbG+-?d%0)T{ z+s8NvT65$;`Xq<@Bqgux<+W%A9qMkBpORLJpan(Xd*NnEG>o7cA1Lbg?DJE_SR(Ik zfD;t&xk|jwcQeLuHePcE)>738>SX;BWp*FjFMDx4ug{$W`NX=D1&-Z6wR0n9_v}4o z_T`>Ug}wpd2SSNP%+H~Uau2Ji;^TNO-1)_UwZjmWUpt?{ct41@N~Ar!;B<3R`Y zR{JO*6^dJZa!|ekojmHSSu(TDKor={G_cwA`Q(Q?s?P^|I=D7T#ZA-KML6O?{KyYy z>AE2cZO z-Skwn7`>OTZ4PHWY_EizHk2gb zc5;>W65{xlJ4&>r3UPVLgF!id&o6Qp*@Ak~BJ(zv%ed#P10v2&glVrZgbP&sxfWWr!x`MFkKeqpqfeZZqO$pm!ze(w zi9BCNbTi-)F}|5Nje|pKQjX}s`Ec5}4HmVnU%RPD3`SLgb(@Zn>wpquEd>ute#&OA zr(q80stR=@cNG^Cj8F>UcUiL%i@(-Do$Gv1%f2Ybp684tB*(rV2j3RRCb+vDpH@oW z(4VYu=WBxY>j4kqk=_Q@Q%EMs0l;hX3nIsH7*v!7sv$xW4y$oRIxvxe^p8Wwek)A7 z5$BW>toDT7$-6TT%?B10nU+_+#t~H%r0g`HZ~xsb$3t46*b{ zTRO0Qwchx40`(fd6rK5;vaUZQ6hvKdY^(!}B>(M^Vv$b7fPR!FJ@|9mgA%B2sYg1( zL8Nq0CuY-)pl`CNfJrD@Na;?a=%5#!8`tQUUUoL^B|&HO&A)!+T1jl5F%a)N^*Bk{kLMxbU2eZO%K%}3!3f;-qtIj}5VHlpNv8|hk3+=>AtpQ$u)o)cO zu>7Jk!(1Z6mrv_ZKHsW;30#!|pa6)*FVpF$V_v1lol1K^p}#{$FaVRTbOy@1-g&W&}OD%e@z=xkuZ}<&Uo^4 zk2CWFOuhB5I$*F#8lH~XuN58bKwx0Wrm$&?<{)gD9yKlLx+-rZarQWhgZ^~2oHd%KJgS6qesfF}RG zq#_n3D8!&wh2)%OF3iqW+g3f41OQ@a9}b22yJD$^KEGyuV-6&p-=Ofqy<(QghZ*q&>#v;E=i6jmLkem8OWG0R8IQV6}nVFJNo2#VD zJMz2bPuw7{3r0w5UNapSB~-DeIc)vG%BND&xq-wo4P^G z{=$4R_^XvBiQ*=Oxriw~irOkc;|6iqK+k%qS!A zT7@eH_TB7s3AAmxG|I;EQ)xLLCFEDV_v4*VKz@oP25RpRxB9eH5P9>Y%me^oR%iwo zYXY3fZi_}|(}zWQAeihtt3A?d>Pj1pld?tX$5M(GZNg65_uqa5Ad9K29@|+arUKhI z+~(gT1Cp9~l-|kH3qgQq^as;bYiQnb1~acuy*Ir4!=DrYFmDUj1-OKwb-D{MGOdX< zk22=um$`KUdy&aghw}iN9LKCDa_9zoV6b*sSjpeE^8tNkKz0~?L%$sh6xzk1tKd9c z#TN%!`>P*e7NC5AZGmFHS0sk>UT^u5m0uttwOdf3K{DR>w-tYkR4X=Bx3FQi{qkCp z^$DQ>a4wd@hc~7=&h##TV6&L~h^ZV?cyeHN1FC&CU*xF)MOTyFAo2VcUCOD4{fbM1LK97`yP!HWlUZt1~HEiY7q zIv(kdkKs+<@JXdpF==Q zhLRXG@BhF5K6&4=C1aKOXpUu&=(?I^bpM`%l=X`E7EIme=^P1}7OFE)f0_g`8Exz5 zPEuypx;~fx9Y1q()|Tf4FgflfT$152M(>l3*wI8k<`!o@o60i(TWN}5R(b-#OG>GK zDjK=e3fdO65F@bctQ2_-Y}IF;p=NhycffBOudO3&Eqi3Y0Wcgrj1A>zx(`6tUM{^> zo5Wk=_3=aMI2Gy4&;E@3UI~Tj3REmx00QF&NQ9wD@tbAme~Vloi$<_`j}>a7fh_-i z>U00kma=4M0Ik)~ay+>2PEAo$zBLDbKe1i;A~V)WAbHd zVw`iNV=J?1RvJ5BJrlwaeYM;6i55$e75N{yDMjzX`>+3sH4q1B7c8s53p7)}YSmJe z&oiu{yJ;mBKb`>b4i>pdf3)r4H{2DubMVG~05jmH>z6t%+nx-~SBI6)5#dz#aHIX9 z!5?!iJPen)1nsBMjKf-%k~3`;xA%_#f&5^$g&2t|5Q-+1g;J=c z%84fOlleg5LRWJtiTKTyP@?mWiy13G4=H|&;0A0Hg_^KCZHbW}h!L7dJ><@yEaKaH zglGbH{dx?k58^O!*Gtp~`Z+v?z1NUlyjwHG15RHm7qT49m~cGp9ZsucQ}>+sAZPpA z{eG03)#b1aKCi_uvM|%la;&e}2^028oGxQ}tV^LJ8D?JfBTH@Y@nK6vzX(21&lgkj zE4KYHrDfNgUnp@08A=ED8Sx9=!OUG=a5KRys(z|`i%s`b;H}Mh%Zxtsr53@!zbGBc zo#l6fKdlUCfxcOKc3pbB_NJV!;>Z0Yy$E3nnVj1Q49Wx7`Suw zfU9jgI`A^<5^WS}N3nFOpMD2Q^S_(5&E4!easfFeImL-?qVwp{NemL0jaFHDF zE~+J&GOrO>T!`N<8GaD$S000kjct38==JmFZ)E93_(v9oHz*kKW_k0J&(TAiCSU(v zofAf3vsfEdZ<$`vUtt;fXLpx89{YQ}oPA=D094i+Rn+$&Kay=$wN4R9jfgdZDGPti zS!eHLApfX5nM%Q{Uq2>}SIB9_nhEq{5B$`#Jb7_v*#!rThxEmxXnH(9002JnILG_B zA+S}Xa^Gv=>a&!Ta%D0OrGEOnF&a-9E}{KoiYX>AhUNY?exKc4lyOFUXj4pkwW)7v z2R#T^r%0cZ`aU=@G65%0!Ri|W(q3m)q1<=F(LLPy=yRE6r9#2nonfI~3>7Qv3L7}RgZT_ngs<9mKkFiY%*^ys z|2gG>9Q7xWBN0$xEmbgiMk#$B^A9Z~ED}TQbIQx*|7mH`Dok}bb{`i`U!TeTb}5mr z%HfVkMNXRF+rT^+=T7_n^YaZEhmnF)BWvSk1N@0sL-@0ms3`Vf+n@=1(ZTxk!N2Jh4a0$=QYLaa*~2t&`Hs~XO4s?y*^Oq z-gOjUar@uvjP3X|ix@n;{s9tg!sYr`25IovxKZ;v5Zl1ht(Oa(eH-B*ig@Bdzn}#^ zH^#corpHPLLAtjQ2UE7Va}cZGTSxal>FLwBV$?8pcs7<%vM=^f6=-fi?3{yQvDtK+ z=kgBTIAHM2TvOhm`Ig}>8FPCbhMWWj> zQ|pjfW&c2k$O3Y+^1@xAMVX(}F8cMbB6-^64HY*IaALFP*pgA5!WQvrV{WXLsA~_y zWC(a9CP1RmcVJN$9o?T8gQMX@&H2xe<@nf zxS!2OS$5$AD{FhKxieqyPp&kR{=qIg>fURriC~1XPHS}>x}l1`BH6e@CAjVCaCc^} z?^E_9my;bJxDBsJ>qeGO==uZA-K`tIQiTcLjP2)2a>-E*i@ny(+uCHY%uuT7^z-6d z?VLnQ4+yco?&B=B=^uq1!N6y4RFq%w3}_mML^0X^7wwtzbc&q;R7{Lzz*W-Sv<7Xc zMN=WzGo_d1MGxB=^YD5bTBVAqrV04y#UmxaWxp9ADb;qfhG1I@A`vp?$tEfiYB2%l z1N=BGOln{S8B1XHn0qG7vqi>L)0MZ}gn2NRS~&39r^=~U8={;{v=$H4`A18E*Oq1w z=gAU@{EZ=7n!xnZ7y54_w6r90^gn-^0HR*ey0=O!6%-bAP(gW7<*7^9;&QOEczAs5 zdipGtUd%D>%&9#wNyG)s9`@$5gR$D^ktFFD{reZ{yGr$?1M*SdSib#WkCi{|!mO$` zCLbYWKvOVO{xuN2JOY4^)JSb?P*Y|c95@iGwLN?Phl{)c>-_8jdaFn`csbYzRdC#3 z`_pdqL}~6>%H74SpELxgD3Z@dgyW-MD# zZ$JCOw;k$vm?6>Ed#{@zhR=(q$o+;U`AbM*lZWrvCjK(%#YJ*TQp>DZ7a8H8rE_?Q7@hmB89;JJ{;P5gl3|`qIPl zHVhcKTNZwfbf6GXrTo2hXx&nSv7^$WHCgx%`##2ZntEiHl=w) zcN~3XtK!=41ukgAp{;`Dygg4!^qFLy;wby_M<1T{Wa%w*-tE z88|(i^pe4(qjv4)mg{EDKs)`p2BB4iLDYYDY>W!b8}3f{e<{6qhHt~>V;ItLc3W>o)2CHRc!~~iBB#^C&N=C}sK~W>BULXF&V_9kJMSyO<3OrN zU0Ma+h3!eS(tXId;WnrATadhaNz9ddC`IO-0C!Gw+G$?Z5=q`XY)%l{Y*khDJ19V1 zE~(4vgl~}(3Xj-;zzqv}aw=3~zxa07#YNIqd($6{K-acYgmRz^$&IkYZ@KO2)c#oM z1JC2}K!1AHum@be__RwYc+3Wq3u+-|If<5H9t<-0Q*M!c!8Y18rRI_0- zP|r(O7pe{AmvUdFyk5>@;;en`4uREGxS$N}%OFDHRB!;s@jvhE7Rlg2WU{Qr^=fw| z!0=}b9#wN|hBoGqqooCXt02ADs66VLslLB5Q{%+@4ooO$J^Zo0K>C5ofseUcXcuSO z#cp0FElHLNC6z@v@Z6Rm>egwg0u|wZ+Bf0uJjAr5nEu&5II9kmjd@JOFq(;8#zw2` z#=-rzbJ!0t$>Ir6FghqqE22g+9vu|Fj4>a^N)7z3|U|&Kv z27SuHAYSX!vcs!n(zFXVKy1KuQ?$Nn=;~b!&1Gfkow2px_n$KM)K_H9itZRO!s5!! z(M1yM!SlFn+T)NMU4b-+} zFns4|v?oddc1af>_$ev_pmu6rj}OBCn1;L-Fc@r_HxR9m8`QlEJ;8u@5iSChL3=+N zqM}Lv5YEnBYF#x3nd5n%tm!@$uI?3sE-zlW!w0piO?fB==Nury>PiEN76vs?(|Jdu z6sF*FB|6EYc;eMu=dJqbkhH+9!}NPGP~0-TY?mUdZ%gHu;fw z0;qt6X@Hor6N!=kYyKP+;g@ER;D@U`J1+4#$N7ivSK|aKT@Wq5`*lV08T~-+92z8>Lga6{!sBqx~Rg@ zpJsJTlxBw%7Z9&LZB`vpp$N{o}wfV$|uscNmxFb%TU%_PE+z<0!{2d+po+<(uz>d*nV!&LI z?FgC4m<9r998wFh3w0t^+yfpdAeH}r=-QZ#^nStUb8rZ^83{Yri(>v&?)wgtH2IGo zy{EM)(Mr=+ATSko9CR#y>H#l`>4BQN`V=xyq-B)w+Mws?)R@kD)&$CDwFO1HL1nZP zOuDCp72#PZDC-QS)crKlZDv&vS8?1hJlF7+jw?+BNB^8z%-2_nIx~m&bF5d8{nF84 ze^NCSId0u4tifCj%+3>|;k!>ayzh^xHrpl0gx0XnYo03=ZrPgprw zW3AS*5x;8zYfkk<%`j;#NnJ;hG#t-@-te9$Ooqjd5I(O*3?1)_XdM}TeKl9>2Hd~D zuGXQ3VNZDnS6}S)Rb3|Gey@nnt%+CgpuHnm4JS<&HUKv*1r)n=bS$LnwJ6K3MGMYd zY5Z4ho!OFo(wTxHc<>|Ep!wI8YYTUO??V%TL0iXjc)Tz53Plcc+r- zf^Jma{jgGk-j4g_0;mSuv$eUX?_*}E|K6QL(9H*55IC5ushxQjvvHc6RH7n_A2nU)F-%KFei@p**W1QtB>bUZs` zjf}W{b8cm*O#Y5lErK=Vei&fwlAq)3xefwiz&)qN#)`{H9JknLKA}MM4}7XRUfAE< zSjn|}r5$9)x0&Bx!pM)|rZ%%aA95T$M^1}!^wFCyxbkX_C_eh=2UdqY8 zCa|hI#`9-oCYi6d2Krc$@~J;{6S~9%crs?n6q1TI<&k`HlGM&t2@6v|7nn8jFbJ2NrbdJ@)Oh zvwVv+W*6ttqrm;^sj-|-NOljhN$y)!J$p{cP<5K2!V|;WTuMkEolFFt?1_rki~8Bf zE#XdHYxBmHS4&_9ih=Vz7IdGht~c^SIIdi60h zSM|=J?09D7nedSD?6qh>Hvvb!cnNd@zVbM(m0^*3!mTzME|=|kfFAC!RLP$jvdn+| zp}TwlOLrZWSeeC_51%Y!ke+#cr%dP-ZM z=n%3-!o?v7H`SuzfwRxAblr^#S+Q~mfD?(3{#;{SupZS&^ltg?mV?H@JO@I!{I82t&Yvn79sdaq(|OSw9~mNt2qBT)3!5eDhIJ?xX$wnR zXxISQiQ93XjF)KZ29wmFu+y(B%7ofvw+}$o;OFDZQOx_ zx0W#hH$&ae&PhxYTW6bGa-TyHCaY*mASsFoz*{jb8Gu32?R@e+Xyq*yr8J42MmuTA?I zZ{_N#Wsq%s%K*&Wa{f}9D$vFK>^9J5TY6tBTlTfGf5Lu!8Ojt(6!}t@^JnqWF#y=9 zMG&-7r3Adk;te{$iTlWx5oqIjqg&`6QSr8lm6kMDDTW9pb@Y6;?rCbv9s36g+uUxX z3IpX}jF&5^41*|^QbZsBvWMeuQsArbh{S;65j=1KQmB3VQm!}IzYi=qEfQ?k0DHWD zTcSSKyDNIICGreSJRn%D1Y205qtD&&Zex6(_C+-!lxt)YuvJ^OU}myia%*Y+Od)b} z^yMngrq#s-+FvTL2iKmg;dpBfzelH(S)uz*u;vtzKa7@Ah$=>ycq_E(dbCg*xDgMf zw0a|w!qPww2Eg4H%re5NJ^CF-#Im;xIf#wh3bTbh6sLc4ow5zUP*e_W37P3YX{0*$ z<){{2`K+=BU;wqUSd?kQOGnYiGBRj|5@@w$@Iq_7q0*<2C1&T{zX1dMq)_Tha`Q@O z7~*BSAEuxVBPMBLg3x~pr+V!vDu_t=lz`@HCCmg@iZ1~n1YtC-p$TP|SslTVThHUZ zOMo(-o4m8&DO_Xcwb;w33d1a#g3rG)Qe2R}8k*wIsph2xfp?r_JdMPA*Z~ZA6-{K? zRLh!U8$;E~lvl{vK(6P;*@aVd>F7kl5YbcYXgsqIR_X$ih%a%J_?Bfum8cBxT|D+g z{J?m47Be_5DSz^x6!@lua|9WbR3V>*tA>kkdDEUiyYo8@Z~M#;Q$Lw$^9Lu9se@|U zW8IFR&}fSFTIu;zNmVS@1pC%x2&4 zGo+fXnnF1h-fpQg&+zufaU)`{a-7mBMnR;pLAKuLD_1ou_Vs&X!3(t)v=w8^G6`%v0htock>dQipR9-X_(>6hQ{1^N(dmP=Ue1(&_ z?ZW#iT3o9*2A^p-jaHH9Y@(B`m%<;N{P|;wPg`ybldJ0>UG;kXAZ)?$_cXJz?_^bG zSqAf;Z_y-v>B6+CM3G`_$0q#>@yp^5ft(`im~qdpcrrk~U1O zN{mKjW8J}+YBM}c*ihJqcgP2zZDT;>#tk8$!6gs;=6a3|q!^UWv>C1*YX@1Cud&q) znr)41kFf(E^S$eo==b|Q02>mxLE~=00Z^ae(>a;VNIyZ*HuFLGmCT}LN^+wT)?;@y zMEn2%1TKz?ex22k7w!+QN{QX)HEnoK3ZRuqb}Qmc=eGCe8XiEM~4ZpfL*O}3CWpy3M+^bL)%9si)D!_gps~M`{$?XK`YAK>AF(MilxAwVhFM^m1bg} zm()s-W+NND`Q+UCHRguQ=Pj7xo)qb@XS=82OGo>1xsV>%`|^(&g&e^dPX6~t($in?}h zefP_o)?!-|4j(E^Kz(Z+R(@yBl#ROe^FAD9j#?Xj^^)quO+be!lNW4bGSu3oUC?=@ zvgBx4^K9(hPZ0iuW&D6G8jFeru;obk=dqy8-e!Pc5hC1+zsH~DWMjOoeE)YHGDa(r z2!psJFHWg!uO_f6g>xTaOc*Ja%hmmCzsWdnPY1nxTKD&arGznF{4gVidRu;QRO$&B z!0zpH&FEA8qMdduz5qa7Yd}G96}OW)Pzjxy9tL*UBt1wEZUlo}`q-C5jedc+-4G+$ z+wCj!IU!ZtV78)xG(l?XR*s7xk6G3Y&TpP3Ue*r;PYC={O5g3FiQ(HwZsvYuExnjT z+R&&dm5e$Us4V*ekQzr`cwmt8uR5<)%F2@dj5x+IJ83Br*W{;Ekb&;l<~I^2?Cvq>&*3XJTB3p$%N55 zxV8iGp2ME0XJIvAZI5+~B_Zc#f_)0FT3=$VKc1g9nip2ulr!%TROcJ>?Qt#dFQ;eL zlUcHykh8&57RaW@?5eT$Bb8uEJ>78ZDcfT!Z1ez2waz4u3~F&Mmcf*_&W2yLu5-HNb*=rbYy?h;_FVPKg95nlviYUDKea7iPHh~<8U zvBIFhdWG8`eJ2`_W5ysh(gcoquNpb80G_t&(!MoJfya^qBW^@>n+1N%*ATc` zZdDr?C?2(nv$BZ6q8sGVYN&j$Ri0rN-pNI`wnN)w+gpdCQ)cj0-i#l|R2kb{8O zbwB4P#{?*H>?4x(I6nv?xiYOTI0J#JTPyg{4i`7$HHkog-#fan#`^Pfqf6oLM^e5t>r3>@E?2sT+d4_A z<4!|%+Ywpcqdwa&ryYdpSN>EVb;=$uTwJ%6E2!~xbQ;ijac28ovc=O_u1Qdf$j9Bp zY(KJWfckT-aNpaLYwaje=mbk4H743gX zWd+;6 z7(~>M>$mJOJXflm^uHS;Y5oH4sLAU#IyRo5RbND6Kw>W|ov**g==P23*v8u^SS$XH zm|@#qf1(0TwMDJyvqEt%{D0~oM)US09wwOO&7kwG@~z?*XI`=mz^gGZM?2LKls32r ze9@e!@TErc7&B$fN;Vg=&m1ad4V}-H)u)E^=Svv*pd`MX1VG$K`yqneM`St+H=>jp-@K_e09+^bodl;j#dsBa}FB80>VGYuL76Xj;RH@aMd^$PlyH;SRDYj$-LtzZevsE3sQ6 z()%qaonuy5`_?@!{cK4KJQQ~DK$~XBW?@kJp~x)pRrHdVR8go%Pu-)q000jx02~;M z-0>%5B$f&88y~P@JhGg@0FMm88r4yK#EW$;3)Uf9W;s-xTfAceEdcA$8}ZY$MAL5r z^5w9xoD1OftYe%{2FIrIDXZX1gmZi=RsY@};x|kO)w5W#CpMPor$JTBU|6i64k=a% zdvvt)v{rK#(U~cp77!JGQ!8Nr00(6Oo?&!Ce*ge62|(y}5$7=G>m%Nk9>qsA0P}0e z%ab@|x>I?-_DVUf`MF?2nsF@L88EH-_NRQya2pF6OLC3%VJ3wjd>*CyB(_)xm~0X{i$ z4JI>EQR4BBRnB%rf7QO3{vfF3gsxz}1=i3NhKBf(+b^wrdX zR6_H0IISrn_-Qq<$iId*K0Oxmmo~x;t1cwoKTP{Yg|W&?<1HKtL32p&p0W5=bWWAW z#B!4cp;kXuvf|KTg!VNlzs3h|EW?wo_J;48v;R%4!KwF*5fa@nzgaHl=5+FJG&{6_ zywz_~`MEhb*6Re^fbF8M0OuCi%WI=uPTB)TBO600Wuv>7DGx?%=5dr%HI*sloL3Lw- zn=Ck?X?OBmkpRX)XTa!|!7hgMv=&*C_y^4pLj|KMft};6AQ%3s*z>|*>;17 z1o{*8mN(;QcC90jVK~_s<{<}h^INEb0X(nAbc&W_m5_M#T$$2&KG@;|8oGwmDKj)L zBSF+?$rz(IIW7swCXpdMZ#CT$X^YU?lq+wsXs4pCMQppr3O3GgK-DgC*oAb*Wdj2Z zl0R3fX405!5~vxRcYof_(i+kPf&f!Cmg)b2C;cdVDz@|cyL5%s#JTW@pT%+=rG$Tl zS1K?Q-VjvLueWn;$hOWLtm06M6((VZkwRj_;DMbL2~%{lDP*m5W9Ik?^h-(2lP zp7&t63Wcf!C=AqxNiVuQ;6r;c{?-KLey5b>6u!JMW+fdR}NR}@l%!NcoL=If*fk1LmVpxFVuH1vkYSb3~zM}Ote?UBB zJq$Rf1Xuo~=2Zru(i}w;xcvmW4rVWgulmaW-Ujx z8dcs`BcSUXau(RH`Rt?qg`GRAg%uIt=jg2Dno@-xD&A}!+8lR> zrt8M2PN4YvC$aUrqqzqQv{aqIGSWQWC8OgD0~8wgNnHna%C_hNtQWjS6;qglVIsWx zRk`%uh414F19S?omUskh^bi>z?>jg9Vv#fe;eN*+rVjG^Bk!Z1d!Iexg!>l-z!Evs z#9+h%?e7#!+jKs~oRTnMoW9ZQPmq%GV5a6;Jlh~>!TNYTumAvY9)KB;emaB3#I2;1 zVGGv7y)wi7SyDNq@wf*M!_ls(g$ps?QWm7MQio_!h25UTLHU})5i@hBBwEh@5WFt_jBtk8 z6pXDEdG{gfQCtGdnj#vH&EDdAGai7@qoWe)zPQJu%DEPS@O%Ls&?QV3glFD8Sq65u zGIiFozbg*1Vcdp80xx1(9>e8N8~RH{qr5mUy)9c@-2zE%a(|XxS(BjlVajv?_`PrR zMbo^E;PExs&l8p32x&cf$9b?Wyzv9!Ab9}02^39Ss0fRssooZ%!3TYIy|?_^qM0Z3 zp(8y?LGY%)`n12MfQUTL+hcr~I>S5-kP?X?fk7oh1~cGKWI-gB+=nC|KtxRhBNtJ2 zT)_hARup}Yh_5y!Z|C)z?7;qbH?zU!{XI8T<0W*i)t$+&b=U{0s2$nnOeVV0?jRvt zy=;Oza^_D&aA2Mdm=EJ-6cn{l%>gq_!OC5Fa+AM~Tk+&XYN(hYHz}oq9-uF;t2YTa z$g-RCR!#NgJWFMA^teuZLwR%g+2H%X z^}2@#2T*8i(j|aAe#S-bG~eQ6&_pdwyV?{w1~K!hEYYlWbODeKyx=k!lP$KSlR|HiUwwOVP04M(T6)u^^b zR|wq)R_i?q5)rBS2lfz^#wqCzKfK!v0tH$=W~7_zfrdsqP`%`C8VBl`o8H|+BQsmg zE%m15sJ|8YBJH39j>fOqFmgJZXT~`LwUHQ_`5(nBb;%k=#w~+CtSZ#>=6HfI-8=ZkQbQ*PeJK< zsFLbc9?wQ5gmzTwP4?achUyAfna|3l>=0}t&^AE^SRb+GV6Xf2T(p;5KqK^{-xuh} zW9vei1|bxo5F21EJm$h%KaCZoH5I^8CDi+1rF97KjF6jwr}U|IrP9hcnVpc7F#2tP z@M6K)2%thFj&CP&7;u=}m56-AtT|uSXW!me_y~LN8~fd+(Gf;*Gb=}?&uXUOpt8T; zd#X@(G-Tc#(hx1YdV&9#6TM2^Adx+OY6CU2r+1R61iv)UCsE2_b@bxD;Ph0+^9y9t zCX0N7V_Gh#X2A>)JW2dv^_9YS@c%akowF&*+HU65!eUNv#gW)Sy0dF_8_qYAS*0_W zlVF@-@VjqRfaq|4;u2rPjfWBwDyfS-K8Zdxwj1a&)7^8d!zam zn>${gA>ntfhQ**UoN*?zqUKI*F3)C{c;+#aAESX(BXDAN0`DeUFwYF3A8x^^#Qq?F zku#;F5rCa}S^iTPqn{sfCHdJETzhcq?f^jrAm+-=SjTaMDh0I~e{vO7gN^*rm)!Qw&9#aA){D89K60^RYY5ya0VcF#OgadHqHs&Xo=v> z9S=j2J02D6@4vv#6zrV_4%O8z5B`0otb(1i{d`(m7ZvA{pE{C8(bE+t@;8a7vcX7& zeo))rZ!^a+$pN9O)xRc_?Ut4wa@WkCKBcqnyE)SXA*^!J=mg+$sIexr8UlH3*r}X! z?v&4%GA9Tc&a-~T!%^C4GMnG=QC4qnbFJg{_1p+JKHjKR8>N%}&g<)?FkHuGb#Hq) zKPhMsh$B&PS2ko0*3`(5XroFE@S>mKtCYU38^*DP*5t z{FGqc*38%|DqITwFaQJFhyVdJ>b_0!Lg+OZ8D`lMiF}z8(_KEI`RZ8d&J-Lhz^Td8d9>7LAa&zzm1D+p{ckXZmt61NgDAp z(VT3w6nvwVA7;(QSQySke82zz86ZKLXi2C+Xqik1Z~y+PRR91EI+msY2>BP0I!u8a z=z7@VT{f9XyRcC*zoi*UNdWp{(z*W4g|8Ol=sYXb%D&5zF;g>*yS6Y~l$yXNZ!
zQXFvJyZ*e}_SK}?_s|01sTAuUxh8K!Un^w&*EABr)-MocwxD}0ZqRL*+Aa1B=eKKC z;@O<-K`d0UHLgR;Vh>Vn(6j>xsDiy+OfkMCUiHA%-!q_upy8Qv+4zg*;OLYTLJ#zO z3Oh=l{`bTRZA8_Mu(GcW;`<}u<1-03Y!EU4get<_h`gmVOhJIl2lsN+14itu$B!SPDb z7Ra+3x$%}mK_s@lkz!&Q`PQ#q4$jygRwoQeP6jVcXec0BBt{7X8}Y7p7~HY8|H=}O ziW4zXI|c7ZI@>q(O`2+^>Cos_aG5p?TVi+fySx^xe#e+z6v4{Ei(XCXOIst3vIEO8 zoEase_0Hd1jVuAEU)#BEbg?9rZeK=ow5O-blC2 zBR?!Z^YjInm?^p{XyzG!?Ut$Dc#$`K3O}MyW^-d|@hRnNr7qpWxab!+#*v&`V)!NrBY z0FO3{@yk_B*P&7}8FTlrx4yczc3$q1S+~qe;|y>4bd)qN1FsEm7076Y47L6mWzey% zLeYb6rEst`>ys8W)!vq(B4#o`S0--)U7>MK2YzT?14w#vSQ;VQxtlpO`K5oVRlHhphoJwlnqp~s~`|4Y0ogM^RUaH=ISvVU&y~zIzA#=A}gGP z;cYFxtx)F1H>PAR02OtSFDJDdPxTleBw;f6x!~RhTigX^;kCKILp>dksi*)pKHq4~ zfpLdu_pdIHk!stP`+8kM4l$Kq0-mGujF`C3IyhCkWSWvur6!z!m*gi<_5|gpi6_`P zo^7j#4>B;S-jZbFt8`@HtkyJsn*;I%?=#0#L)L|u!UM9pcn{p>%pIxlXlP8_bSeLk zluo!lV9?(b-dYUlPICa;Q%0;* z6hxl&FlCjkJj(c0XWG-+kZqTX`+vpBAufa(djgDg?!1REqd!QbQ73;WSb-u08En-# zNF4JDRD`s@2`AG48XTnpB2!yWwW94?YQ;M{1td?4L=D++4}obYvB5c2slG*yN5<|N z?ozQ|TWdaC)?h6B(wDFOl{SD22~UaOZ2=?lFI@6xkoPi@|BXzUJ2i!Zh(!W#SN^)KV z0&7f>8%Iki`Ki(h5!f34ZF*v#6g%8mxAxbPnbP$htWUiO_h-IXsB1n8GO+9MH<=7C zl!AY+r_f1q$|0$Zf8DQSfEB9CF-5xiIcmMvn3LZvKp%H`xMff*td^#HyOZ6Lv~=!VIqfoe7c$T5YsWlluOK@ryB-zg18K#UWey^nIsF zyhE?KEj-Rbip|(b=^6|Ew*sydG(>fFhu~r4P~Idvm9zp~avsQq=NWX3`+qLGJ<=f0O;6Ih>d$S+I$l%JCe4=AmNnVl+^Q zK9v>|04(Dko?FYkhUSTg}=j6FsxOyt0(H0Kffy8RB_7U(+W2nGG46D_5tW06W%`K01*Da!unn zbYNEt3CWYREdLfEi+gs$`>xtg>Y9k*U0~xeMb30srj!jSbVpS~Y4>ZzvAm;}P;DAu1@p;9>TB6NRH6@gTIDV~hzN-UJ3W3!W}R zGSH~rXT1)+Bbv~D?7=Zt-QfSD&Bi6JXpyiiz)5?_+@EbsJ(l z^Y={z*QpF3c)O-1ZJ5eoV?cd z{GY+x4Xls$i>O!3T=w1XQxIQ4<<8vRlSk3|qd!F%5q*(2)%I!lc*z*f-F*MLFZG58 z!y5WcPbrv%!G^-0xNgxYdd{{&c^kFtW(Ezf1ZQL1xVI%eh5D@~OzhTINxhl?UZ)k; z;gSBI--uc}jbe~j7zN;|Qn?Io4qAiz%X4VqU=v+GZDAIqKpGvWo6Tom;Ew#G=M{fGpaK?r&bs*Q%**Ip&ETv950o9Nis&e?eeoQgl)L%O9?Q>LblkoIvaETdYZgvm<;xsk zLO{CXT)y&UPI==PHGi>dM2fO_z7kLil-PA7)8MPPnt|14;SN z6Q96E+qXiQi{TTDBL-WCWaCydB%TQmvxa7f0+23~-1R7G+$|5I4!^TwMilu$grE@H z|8n-2lcKb*Acr=#jg2+<(y(!ZwnBQ1AO8H@g@b2hH|P~1?kCwKR?O@cN&JizNc{0&aiywAo ztybN!G~7s6;%1xL7wF5^U3d=-ys+O?jursf-JiwVhFVN6+qbx`@3wKRauqX~=Zo!J zX#`F|9k8rH`IL&BVsPFGz*t^Udy<9(w1NsDYsEGSFal?fxY?ki;Gb~Kcp94lYcL)Z zKU5{rRlyRE)D)`QrGyASfZ=Q`wxn{l=3a0mSH|Oj6 zxcD-sgl#!~CL2e{9iU-(%ezB`8dFDul-W zF&$9|WGai4dz`Ho?DR`#b7%J57Vxds>_3YgFTX&D-UG}B2V=?O=pjOEQm$PyR;^Vv z<34CGzHazZ6Nr0O{Y*yn5_9C#s!cd@jPDJMMMWZ2YA%qXvC}Wu2wC#2D*_R24ov8U z-qJirFu^YzacJb$Z~`p8ss{gxT@ z{`K=>)8$RzJ7|tP706Q zE~rhVr}W@&DyX&H3jV-0%xYl`2ct0K+`(&zmVarIQ0Gnru;1y|Lx;(jsM=|F{2)dh zxlGa0CS*YF$L}&ECa$kCWm45Ed{x&CoBu$wfu&r>030VOE5$ltE^~SHJw1Z|@9DH8 z2(17H6{z)Y4i_wrMuBz6D&ZzD#8tBLl6T(8KjK-0dAi-^{FpV4{sOwM*!;yYlq(%j zQQ{3rz>U=wGL*)Qb#`YHK6zVBya=Gt__Xg)W}A5~{kHk_s`a3s*icW;We-A4f-YKj z4|FiE&;O~xcBR^tI|?QN;$_a&fmi1%9exWeelB0j8ey7_&#b?G%K(Hr~uDu$!RTGlfqa(Pf~&| z`T6?bP)pD<%0zGn8DU2MDUKz5qK;9dz&lYsi#2evfCi)g|NpdL`M$@=$u{ar#p65+ zepXnL{UmPZ?K*CQ@M(5m1N&lAX!yb!Us3N)cg$-tml0s1{H?y!z%wy{J@kf5;_E_s zOAihOztA3O#5pa8XsBM;J-XRc)_WJnH;-7=Isr?p=hs#o=Jax*(uz&Efd0%)MUYkJ zP+R*!po(K&M00B3RxFeC?qfSe6({4;&-kWMV z&Gl6!(|RtxoVp}Psb9)(_C7qj-v4!m?;c*lcyP<+G9Dv+U$_y?Bg zyEs+|^#l_>Zb;BY(QBjYolSG+M)arjSnS+LiP3x5-s0B$D6xDo!XK0ximJz2D^)2- zJEo8}Tb|as$+JknKn>P7p}=u+44zbQ-9r=)PpDQ{ssNu=l=OSXWuXKiB>csXrk(k1 z!oRC-fXj~H-p)}dIW+Gjq!25_e6}0JJj7ByGG&5zq)NS{J{{w`*1@Ubv}oZh@$r%l zkjSv2W4(!jw&6l9k2je&S?Rq=L!DLvY8I*>wvgO>!%?C^H_C@1#6XG(compV$)l8} zfco`12`Wl21!uKuOA#&6ZCsNXc$WOSS8oOj0yko+cnjIl9*VP4gW{D1eQS1&=Tsj! zGv^x_2@Bfh9t{~Q`}^%u&+JpRUf$|L`7sDp246kxyEDWQJf3%m}XN1hLA&7o)x7q12gIoJT7};zXlMmk!CAv6}P(;)$o^a zCz7HvS#KhF(Zey-3kPiQnx0}S3Gd&1=flyxn+8PH(c}p#a^ts0w2?1|?Wc z;(`Y4_daxDj`%_1(?-M=qfedr13N`{XKUC3x{6ShETGS*drWTY&jg28jIN`D zMc2q)zjw6qc|ng4Ob-b!HB5B=>3Ay(nvuSDX4^yEa+EwgD+O;8=hu^V=~y_up0+#i zX-Ko*;IDZv=^)A%3vwU!ID^$VW|Nfvb>j=dmbD~$bVVq=B)dN)ay?56zZ*5s02{~J~eYBGmsg_6rwpN0sDIA6jvDhkxIAorS{%FYLQ2(z0B3? zccwxZK}prugYHu8e_N9w5?9#`_#NK8!eCo+Z|2q@3;U}r3s6ELaOhX)R~21htc>-r zg0R6j$Odp6-W{kY-6dB+noV+OWjUO9#BI^(bMbmFp^8w-w15A8OX-=6%?l_y!pw|W zH!bS*-=XJ-A{ixc|2?%*=%o7X21TWWMHUPM1wPc`Er9)3S>IMh%|s zV-Y7Pzv2O__qY9<1Eg5lgV^g&)iB3T>$E}O;cMzvL%Dj(hL5O0Wr2(@<~WTJ?RVj1 z32+065zq{QXaOp#L%dF2fkfC4I-gz?|M&BZ5?=jThC>QrBrO`y>W9>?Qh)T5#Sz5Z zK^uN0z8A}L;*R;{lXgv4mmt7yHf$ZB5Q?ftv6e3R(W0?b`OaJQl7F_uDs6Av3@_J|r8J(2D&^ zD6T!MZHU3X7b`=ZEW2C!X@sMDP6#Sq!upOT4W}2pPa%5j)Picr&eQbyUBVbmQK#<} zKE?UkeEr44aISJoKsrZjNjmz=OyZkQ{lfdU1`c+pmuxaRqz*i1NZ?&JBn|F+9$oG3 z#)0;8k6>T-MJU;;3mA`L4yzlkx+%d{MnG7Hwf7y0Z~crQVS>rj|G9O2*}1??PYXx@ z_*MpR0)VaSY|LA@DN~$5ZNawqjmJ>a@Z252vh9DO!Cz`SC93ScA1xa!lNI-4!}yn?~9WS4$uq# zBFMvQ#u^n?>{3K+dw@`Z?!ZZKNf7)0HT5l42dQoW6D8Un}ls(ITOZuv0n)Dx0 z3PKlTM*}`I2$w}xVf!7gelZ&+#w+Ol3Gk-&u|~uxKa%|QmL6kb;$8vd&%tJFh&4YB zB#7fr7;%8NZ2A-f+S5B^AMu`p<7>9KEWYcijP>)YzY1rz;~Jo7;};ia@}uDO-f_Tn21&Ed+m1ma6Z5R4 zIGdNp1a_8Jc24>PcTZQ%2uNl0e8Qoez_n8@WSSgFY|Zcl2}6Iu1jcOBPA@lz4UIp$Z}!EvG)@7ppjvE z0oo#>>OpMB6MY2+4?@F_BmlePwQxRi<4%r6`2l`CBMNE08fE$0@C zeh1IJuV@N!<0ZZlH+fe^y`ZKQ=W1E!_OYi=wv4GZh^t%GAYBCnqQ}(dmpne?o{Qsf zk4IktFXQ3zwcIIPBPEkNd7LeUJKuR~g)`Fe@}(Cch+%i3UM<}C8%OIJk4T=V4gmZ2_Z^qp5fe?0duqAm)R?gCz(nX zA_0(>`v?>*3{1oXvSABG=t?+8Li(pQmr+@l)z)3v-n&~V>jg*W4g>`gIq16GP_j<` z@-Z~&`W=`s@ty#l@PGsss8y2CgyxOPY%(oHSZhgj<9VN|eqcrPZih8nia%8OD1bXU zZ02A}=C7z~@aO0bM%oXRwnf`O4t|vP4HF}6M^^I;k>+-7sc8#!*H>QcjqJ6f_~D6e zur-xJbbW-&Fy|(64)iEJ4)W$tLce%sz%?MZT=8jqjCmZVE5jT7KlNke)2Ktipt}*f zH>w_J22*Bf-i-X27t6|WCPu!UvoxioXfMl)zVyVclzZAP2sZRs*PDjOrddQEi&;0e zVlOw})~sDA0s+=(d#u3eLxxTjCWE4~gU1}VDd>OJa9d1;|HFy2;kEz_$N%{OuSbqX zeJFLKf?#QQkVNQjEXP$9RBC`2Wu3A5+>f)A5no@wnS-s$iq_@mhxTM}x$)_ys5(m? zA=w2pS(j7GY|{&``PvZl&a?yWWtdugI3I6~9qz{Ovc0pKJLh73{2^b(?HlgISc~a7djMpW`e5Th04c>r0 zvMBLuiwciYr|FWoHO&_49l|Ca3X%N4r+<%IUn~Ji`**bhTHp263Q%eY*B|CPtgCt3 z{8^@_)6lKg-Py){z2Ao5p^)P0I4d`_Ghq%eBI-+G1%I!6OelR>TWtgOv0r2z1 z(I6?MM*;_W&H}ZEkEh3VK&$-_B|V3~<(Va{I{e4MZ`7I{T?ak2Zjw+v;@=D5u25Hx zvudyYRcE8I*Ez+1TMN9SWmRiYE0%t zHWz+6e*u>AV*#5;3Q<)oC-funbd>rj@jKPtKDJ}fP_%?U7FQ9Ye$$gEX~LRByd~SO z>LT$vGZxU29+3AjOGERqb=t;AnW_&!yVu8mJ=x~U)(^c@;s+f_I1z>iSUa8j`kX>An zOyP|0x5LhSq<&-}2d@vxxU~!v+K9d)Q^%3hwyfuzCyUzT2$7`Lma}Kb+2-;9ONP3 zt_dVIAaO1d@01$V=7?HoruCgudGL*G+RtcK53qCNdcAeIWCx6*vlwh^W|7o`xj8{NO*;vije%~*XdD9je-DK?U-N^_g%-qWKAUFY5s6&P zEh{xs@Uj>!F^Ieo#3ouG`Ao@^+|aeeCJb(_w|qpZmQql(Nym83{-Lc+9`W)Sdrn{) zJv7R(5-|T9dan-JKoJnK*SvntzdCTn6^$YrJdB^>s-n3A*2kVKi#`(g$VFt(5)&f0 zP8`tlOYv$tFuHS^l6FYJ?7T{;R*_2L4ftbz>!J$)@{ude-K~G6N%9T&eCC2uSqyBb*o)Y_5P~Eh zfSc>?g#`cr2PgrarD+hK001!j7#tPWSNHVmJOYnnuuxzFh=+GuZ_$Xl!E2N1j{S{r zG*9O7#}7SLJS7*HThW`jQ?fKddsl1Od;&3{7oOS!P6eTY!2?6K*TrbkKm_qT5bbg4 z-99hJzK@J9M3R`n&t4PgmQvZvXW$sF3AXo+b)1F)ryS>yQg|$sVN*itORdUqukN3U(6e#sTKscn6fFS^B#8p42v6SLh++1)C6FLqn;$?|PROH%^ zgKa5G&tG@tRMyDZr&mb2(e=jeqJ#Cv4my_!iY~Q^hAzUX;UgJay=f1?M)PiB3g-c{ zEagaps!-;s?B+eDP<4s7XlnkYX|*jISYu7Nr7Ri(#n*ATgpXXgy_b;!CJ9+posEQAx@k*yrCC2Oh#}2x zgDCCWD*!qYk?8cXG>hlCSW1Z%x?h$soK4(ki?SPQxHfpOC!)KDczwHYjgJEO@9BiQ z=#U>Lec%=-jqJSkZ)zKSNd?4G5`PdQHhT;f^2R8E914M{Z;89Sf6>5;|CMP-q7oGB zp5Quj-P`8)0Kp~63%d*`PmKZY6d#1%%Bf5sw;B+(pt6D!aWE!_H+0?+lM?%ays~=M zlMl^VU!avmQEHiqpw2=#E=KB)h)x-klr~q*25gu`Ve2Lsp(n$GUvrcUubQZFI;WI& z1!H!6Y%JZ!1x{U`#+Ydo1M{b4YWUrUoz!nMQSAd`d5{B2fdNT*Py+|<=t%WVt9Tn- zO{6om7SsA1Eg0R9X}5YK;V$HG+L3C^&Y8jzryDXXx(b)qHSUBW&XL+uO;y;K+HmWq zNMbv|9udJ6_b+6kf~4aZJtG^&9S3f=U42+J4GCnKgA7(IrT?d&dCfYVzqxZj$IZpXc@H! z6$zk)#Ewe3|D3Rb?#+Ft*VKs-sT6t<8H{H}3Fch=qjWR|@a&#dKVsUP9Rq+2g+Na- z=nVQ+4e~>Egh!n^@hDcB1>og|U7@m{4b1vyQ`-7XBjDJV1c2|O3;;bI?avQmT z<5jMtu`_5C%2x9Pg}2H~Vi9Tlmgje4Hj@J)!1D5L=_t+jHXj>Vg=NlR9yxo8tXETX z0n7Jk$!1>n8+8|>K~L3*!!wJF7u>o4BPU|ZP|yUiv2dd?uEu*J8R1N7TZ~LekFWQ* zg7c83d}KmyT0Cl10l8(WZ`A>$9F;YT`q~^0WjuYnW6$yzyx?l zl`TU`crZ)fi5m6)2U%2)4KE0%=*$<4Pd`(Cs`vRsTCaV>68baoElyB?I`H;qptHe_ zo*8z-W&2t(%tcAEnnlS?W;wlZ(1wa*sv5d-E$8&@2_Up8XT zRnlE-R)tQ10%m*p!QuH#pS98Il#&DG#wv1H*wDEKqz{J}eJf;~oy%$! zOjcbbF3_o+yq_;#f0W+iMY3XrW~f`>3{T1U!hOedDhk{8G&`?I5XmT3)_ETPv79in zf)Q~i%yOf)k`=?7D1Yu@`P#jW4P9&Q?MCj{Ph*MA@Y~?@s0?S4eMNcY#8nKij8GXs z^ahe{QFlQEfMl7MdrqVfa&`=Uld8af*}7dG+OB_)F^kxi{Ytut5GF6Zelv}Vvsx_;Mwr0%LrxlBrDHrtQB4tjlF3mAMh0V~DG)(UgHvbb3 zv;3|E^z!dawG?8M*}yf4-=A%Ow4{Zi3c$#0AM|zc<>%Wz1j!uxft!W?0f^x^53Crj zY2xnR>GtHwEIRG#p)xZB6-MPKJG5X9?)(F2qRGlAaBI~O6hCl}^;{{r-f(OI7sahe z=@GNKB|`GT59K~A_?9V0@`?EeT7_T)qf;+~szS3mTu;xlTAq?Nk9incO_)M=g5 ze3nIbZ49#LHm6hi4X)IyxUBy(EpB|)5TuoA8I3P;WWB=5xv^sIYyb)yKHl7OQqqm~ zp`R8bC;VK4iFuk{My}c} z5fhInQc?DOFxXH?t8Pk$%ewII39R)=0js1c*Eai6^?b!jcVMs_`-Ud;K{aBz`h3CI zKdnHmu|LA@lDg?^K_j7%_@x^8_2O)t7?)n0;0E?W%ws2d4#c!hkPZoVT}>2Gzk26p8)c79vw+WyryANm zX!Kwn4qvv}k;$p2b?5`Y+~bdRrE)z;7oefGn-wfW0FB!;(2Fs?0D=k%@mIT1;quAa zb9Gsah+E1!>>soOoKPjw-s|KLnXt}fn8rOpHBHxX z;8{NX>wF7#sc>j0kxy@kY<3>|_4}qL+#5{%bNZC)Z>GS8cGcLeF7J7-vVprX=9N_K zVj_gs4&UR^)8l_OQ%W5ne^p7zmNQ^Lr3$F zqX4y$;B)JUQz0eP9$--Xxh2$GL-E7Eac^-d9FRu|^zbey`s2}ca%0Ic2!*LtoIj18 z61YTj+f(^H0009300RI;Y`h0zfokheify$$+?89vQA7U*@*oI;8e5v!y34o<3n+az zW!S(kPs>X|NofWua#+?od3s3EgJ%<{e0l^4g#mcYnJ2ra2Hm;^Wf{;E{~01i6fx6Hr=(*sqVL}H8oLx{ZuUw5uW zf2>B;b&WGk3q6a2;_{7*)h|l3KpCdu+ViwkojM2O8LkV;PD9gtPHj)$>J;A@&}#B& z)%HPIqc}LFSoBIji71!EJt$Px6D>y{>M~{kU}zV=QfGsm8$5=l@qkIz{@dR!C-zzj zExF{3na#A`F{z#s*?JJ}$;y&0L`CF1PKBp*92!T*Jg!m0LUXs;UnBSVXowLi5J+3b zy!S(E#8mUgn$8Wv;Ivxi1RoymX4aVtRP7ExMUI$XLPI$CGH$a!jz-ra4SD`13n@~8 zNC*S_hP+tFgqQhpccd!l+An76j&@8=qwC0*llU}$DO?KVZMb}W2&iKK9P-YBA5m~^ zCehX|a!TGd+5R-_(hy16THMTIyF;uEZ)jsY@@ZE0lREf(d(c&y{*P_AIwNWunvFuk zegvpGGSp8c#R3?kX2NgoiP|>pDPyeCh$=%e=|hU~1qcpihfce?^5W4MEotGQAT?Y7 zD6?oa;3|w`BZ_}E+PA!-%urDO1wUf#UBb;5)N)Z|xzRJ>TaeDyBjI{l75dIp^ zgO$W`i?l99WHU+ZaOoSsG(u-uHQ7|2+w`K zehc5Rs&}8ZAOmz{Gu7bQ2UL$>wzl%Hw9h#0iEuR$*GN}{FJ#7MRguSQ zeDJr5q%5;eZfg|33dzGB$81pphyHmiYDQ{1hS;!kyB+TlO;aqm^db zxZYm2ETfa8U>1T(>yMG9Wp4jeHH7hI)d+YYTGld(u+QbFXl|1>!WMj6;64Zk>~@{j zz9AMJ^Pq0_&^H+vXzw1EvO*Vg=snn{k1dEAX3$U&aFsTiLh+wP~A+E=|w-p8XI_@22o%kX0-k^Z%9W z@5v5AvC)C*MNy=&nCz5xG=sg;og)t>iv*n7CXf2tEvN6+QV1ek+R?XZK51w-VcG^a zTe!|Lk%*v;rZyEA1O-q^;Qt|{nUP=_&lQ|JKB8$A}pD|26ZWHTre1CWIvR;vh zKYuU$uH|J|UF%D{om5KEOjZndB;stLwTZbXW_3GAPQ&z)CdUJl1}&hF@9#HB`QMA$ zey0`3MuPT=_&*v!9YFWoafJlL>abT6qd@7C?-;OlqvX&|4T`-4Utl%0A)D65Bp5Xlf14|8mA(y9XMP~dH40_JXp$WhuI#!W<{;t>eX<~)($W~7oX3*pxf`}7`?$M2Fyr1dJc3R}$P zjtcN8Ugt++(5G@8vM-&=uvF*i&6kM@(-lQtJ<}{jjwN=~Q1&Ca zllMg92)O_#@1Qd_M9#ZB#uz@6y8B@(KWBYqb|r8|T`zzcrhr9w23<+v#e!Pdb9}_B zXDYO3>t$8KtRYuXZxpT^JY^uVj77@wsRKt1iyp=zV9^*T_rXir@WRldsoz>ie^%n> zO>u!)opmLML-cr(D1enxJ3Mg~1tGPetmMS?i*TK0!^5EvjV06vyk8fOO#zKC*8M#w zB0>-a8lv<7uxD2S3wI5ggR#vZ;KB*E(N6oFD(;G7WzKUpnKJfQgmv=o$(&xTn!t%V zfO%+IsG%tGwE*?5kDjv$&UZNO(EL2L`lPI12@-;|jDBPih!maS9mz+W3JI@Eqj`ymKGv?I6Yv$%-u9(*Uc(Y15kA5a7GVYi00*7S z9x`;&TQeVHluvqtX`H5QJZ@%Lm6)*^$;7U^mD#N-5L)ZZ1jQ2)IcaaXv42N40uV*V zm9Xf)<4T!NHoQGo0gWhHYb!(tw0p^BfzxWB=rj!fQYQg7#4kNLZSO`cH`nZG%|s)c zX0%}^Eew94UanN@N$R$g%i|^U+D;$-gRy@M4F%PGqF8vWFld4n3lET#mwr{tP|tYd zcGt^9b0UI>3-R&NL6!?wz_I54ZddN`7TMd&u?mt{3QX%j>6B*C5bJP^f-L66R#}&5 z+O!rW60y!|a7~BAY573Xqj?a*A=ED52gu3T#b&2AjUdv)!Tg*=lF&%yuXr7^aWB)L z;UZ9=ti>toN)^~b}dReT+6y$T^i`M2EltFIK#C0sV7hK!a+Abp5 zKg@w9XN%K$&d9TQ{|@Seod3tCea1d zv;_i#&lw+OEb`_BMA$^R?yq4>@qIp8RCaSepvX?g;s5vvs{>npO94c(f*8^OI<8e~ z`5YbckqYKc=nK)Pt)dq}leV#9bRGEaAa9~NUy%_V>_&LcqtJjblyfR0IbaEiy53|u zFp6d;xRZrez6x*`s08cW0AvsBJu__-t}R+Y%o7{!1!S?J#)sU4zix6K8s?n+*c%vt zT53-&y-4aes33HT;)*^0)#juV7HGT_DQ z1~QMl42dv+-LAwB1I@;H$rMl5wj1Jta=Sd%Sljf}B!&EXh1ghO`EKpUv!OturiJ0? z+2{3(TLL?}rgz~?;wMTaW$a1VF3^~s>tBdpWF%kn%o%OaPQJh&G*#S-L7t@UmN_?G z1kq~e3X#ipG!Cry5g&iX5_0ZlCGt(&Mv3>?RQRCxNf?f(rTu_sqy)FM@~&q_<$%qo z$}6OQ@n0b-f?F~V4dLnrxDF6Vw0diXlG$yiQCF8qXs~gjw(hnWF{NtUDBAOUanG)o z;I^|^rR^vJe;4I=je+M2H@XKv{|Sb1@MMcVZ$u8v82suJ*pJcgCg3bn_FP$a_^LfKy7UgL4=&V)4Q=Xb^C%C zKI0vxX7lh)yf(L;5I!daPqivI%&x_0OYS`%mV3G#Lct%ta&;}39l5{NTeVy2+{pj}<^-);NEPWNNDrWInVj#VlQz!=$#~-f1I~)sot&DF6k%#Z2@vX;ddE zrlk*LrhySomqcjO7l%*ydHBCy{o zN7rTA5j3_!&{Iq^`^HIf0U$=UH|Qw!>*Q65uzvwSXO$g?oB2u~PXH;$r+W+juDUDX zvh_SHPn;8RRb^J4&t4B_ey(m`{VVoKPEFrDW07Obf9GOOcEpX}bUYr-j`;mahNWi2 zwWL58hG|NV0-r-DeylnEP{R)~<4{}GLex5g9WA<>?&A1??|R`B|1sN*m>vxq)MO{< zJ3V9{O_UHM1oOz_;kGt=g((g*5Wjfipfrtk@Ky2)>AKG^f7OY?^IP+hG&Sj@*6Uko7 zAQZP1bHK%;`Q>AHrljpF=IljPrvGpCD=8uE-xLv{LNy!?T_%5Zl^do|oEEdf?s9=a zBhe%!AWxMvSURrU*p00%$k+v?G7{P+GBEm80^{(VM4BEXZbuNis9bu zoIaJM%a&$wjE}~~gYNjt*eU#AcfT*9FLSNnhT)!}u{Z#$%IiY>maZ%J9-2)D{=VDi z66g+~ye{6V?f3V=?er5%oJ2m)HAAyj6>?ZJ8c*}`senq+&u(Z}MxsR;*dCqql4xTH z%Rl&)?1?kg9RjwQGV9?CplK(tS9Ot^Ynrzkcc;&$)7ARN^C_4h;PpYcLXJgfN&I+-Yl8K`{3h* z`2lf=7Ik^N`u)g!F8nQN2_j{8$*Pi}_GWpr81;s(NLpSQDY3hIe(I7| z$@vDJMfn+Zxra?l=(v0)tIV~k%~^0NN%q`#jDe)7BcRvAh=U28hQgY?!q^)!k#WI3 z);enws5w997N0F4%NvPc)TJmfJy-2|dGg4D#;)bnlO}FWJfFqgAA^=xEFk3Q({k#q z{Nrpx@ZdGE{8cX-;jpNqztltX2@$}rzMlDSv_ ziGY9A_dg$sA?(9H)7u}MFA6+j%PnKo$DTErd}w|0yDgb_>O+iFxjWD_HEn$X=-I`f zl?$fqo_Yipk|_0={Jd1?5=kg@FEuH+EFDSHF5uWDz6-qYda91+NytpE{ShEGKCdsQySs@zBqqI)poF>zP(S4+ks`z`}0O#H3+~k4W~#nu}q6UEJGAM3Y=*NMgH|`(B=sWx#fOAVa zd+$^O_3pM$kIx16Ur4Oj{KUV0EwLY%LUDk9ZYOgKzL) zBV`rGXo4>MaVEBU4+Y}SJM`N4zjhk81irA|E3+Vbu@zkGPHE8eouMd~PsFg&uI3(N zm*6-v*{Q_-cP8LLjaU>U%r^Z1t4(Xk4}Yq&qpeSCC)u4(4^Bp+_AQ&-29=TSC#>#d zau-42Vcv{?!8q(21+tAJ`IdC;N~+@!1UkVz9aF<0&pV_bdaL8`LenDf&PJaSyC-|Q z`#hP6+D$Dv(}r{8uNhvnZqExy{-^}U)7ZOCtX!9C&8vdp3kuigbd~+Mit42GCp| zQx6pU%|+Q2G?eQ{kDy5TEjE~?q_T$2RJX&%=w~q@VLeH52n5St*i<5W7^%S*M51O+ zi}{LYAoQgTlFF7Bh4uzFf6wU7a$9kOK!gRUweEoX#R{os8cnu@j*uBaU^p=u8>iH;u_)?;(3hVS(I0Ahh@@8Q(td=XvT7K5L|2wlH6yo&sKI zO`?WP&m04&Cs@c70XcIvT2@Zr9exqJf|;%D1vBeGsz)3sb1%<)vSOwUu~ z!mTS*tHOc+PEDvR`Zm-vV8rOn#lKxU`hH|fTcw{VtoA1<6%fo(7#LrdyUN@>FVZJk ziykEuE5^p4>ajntJ+8R__11W!;=&t-n1i}ZpOzn#={lt7rr|G(qJ@$Qo=%tt`6vGo}&UDm4mi znhQf@pvuA&RrL}0Jh@$Hk?2yjf>a7V++v$7iH3OW$hr44;duA5_8Ti(@vRJdnu@za z+=Hmp7Y6}aF4kb98s!O4!>xEoyNpi3-=(V8x{f)gwqV?I$1`)|^t!|~$!mxc{rfrR z=YNQ$?qUvKwvtb4T(?;i5xRARCrhmTu8^k!ki0<&B0OAKkL_#W>ICUh_o} zveqS`qV#papZRp9zeS0fTT}{7dS+BkJG+oM*nlD8DTqTPt^I& z^}xj0$tmGePWaGRAjihWn2`Ns zdI$F`b6tk+nKJBLfjdxlxnNa@*w@FUffT$I$u}_fFa%uR(pn!y7UOfY13h%IAK)Oa zS<>TZ6Mq0E$Dw^LpgA|9d6(GmII!SiiioW4s?nHGT*&^SLSrHN!YW$4+A2G{u8?tc zUw3QqD%5tND1_a+pUp&V6B%Tr6IdGRjHx`_G-*WN9Xu@Nw3rKfQK1&&+Ln%kp+1KT zg`b=0+wXi4nOpirm-&63`JHK(#EyAr-NQs7DQV|=ahGKJ2K*-{^v-=SD2wmW#w#OElhk&jJ|KFv=F8i$xh2+v8l6vG-V@SR9n#wjE0b09aLB}*hq*Q;-sne(xI zf4YgpREEN4;u zvP;&6dJ@)R5!jg~5JVog*QfHV8b7~5(q)d9VL)FbW{A32Xj(>U&@|giU4onUO)~{i zv{bw#mO1X+hGL3;yjOeXKQ@}S;?(m%1s{J2?1MVdVQKd6oyuc+-jHw%4(UzRR~ii9 z?A0TkHcsn}IPQ*ryg`#!5gdDSMv2WcY6v9#1AdhzbS30(&6L><)O_gRbannkosehJ zJ9u=;c`RKi8L7~IgC<}|rn&r`A+Y;T4|F$K}S89TT4&uuP z6W0{rISdk9RLoV(8C0EOpfUFzmE|34ZR6xzw42>NUNEEX_JB?B?V8be{Kb;`EWoDZ zAtLGTo_qon$%Wmokn@vI^0XG{OKv1;o>V}?fyN6<;d>!X+Df96D~|zwgzxD%YBmvq zjZ4h|QA)5b@M1j#3x>#+J8r)YI9WzMhBv4!6a*~18_r%(LH4M+?K zx{+kR8HLr!-mr{25-FX-A;b=A=7QGy3vga_L(mWUb^I%;4TR^3?g$P><7PMa6UN9# zdkp|Te_}QY6#!=57ysA-p2$^19YzHT$bSjewx;n~5kY*6YPXw}Uda@BR^r0k?3JL9 zzrVt;6JaXu1CXmj>s;?Fr)IvR`2_B8#{eNWi*J#7-2VsA#H4K{J8aB~kcMXMO`QJd zFF`gE15M%6_frP@3gNq*e51ANJ=SD?H+Q8fIoCtpeGC?(DQqi3n?!t33%57~f|Uo& zIA|wq(%ulPUQQGbHjLoBMco{WZP=7A-u|^`GIQMV&gHn#TJhP4&`=O#yh3lY0KZFYvGXk5cM$(Brb@0JHEF3HQpk0;rj; znc`Q108KKK%?j6*`@X3|kZPXXUEFw;W-4JDVLz%A5sjV&lh6@{1LMh`>K)Z`G|lTk zsHZ=h@WxZ_`OG1y6kGyYrRV5kL>s^P-wsjy2nrL@#Fl?0uqnCV=p6tYH<2X%u*k6u zXN&n19C@-6yekJ!nnH;@hvqu4Ri4Pr5GC;EH{VqFQk^>BxFvr&^#_=q?yJ-*g52!f zf2CrcC5rY;;6E9j++)`sc_tPRVp`Q}w9T)1cGrev({EQp&U)?s$UMd}S^>wJL0#dh z2j4SQgGqnYm{DYvu)5&t02N_>`-o9Fp+72P16&@0d ztb+;_p6f0>)KC9?t3QoCmV0dCe|a*hO%g|dT6JqttWnpJ5~_|5q5qf}lBb#e~1h6N0> zS7?-y)I9ueZ5Y_ti5pfkbWTX`ut>(-j^tsb`?jf=WT8!0OV~LLarYdtM0y-~(fqo} z&f1YLK{TUwR=)?Cs_pY1wFflR_tg!dOsmg$7ZS+URM~}rnpzrp*(hU*u?GO4DezzU zZUfA_{LfRw@C!KTnU3oqv5~eC4gk*KfIu#`@U*thk~kV6Eti|0xg;S-G3L35@bN)h zCX>(H?+W!C7MDryK!bJ$35C4WBnUN)DSv?N0sB~(oC$YIfv%Vp?QE4NLI(UfoT<@9 zi-#qW{z5wAIMieJBon+=v3~bE5cRVepk?0!BKp{->Av7ezrEApKctecK&{dlzsNVF z8}Uxc?Che$W4|y|4IyW-3-D)EaZ<~@-S3OpOjXEt#8KdJD9uy@{nYtpl~5mexP;1@ z&jFGbdoU>$#!C`C(}V-pA9l_Ko=zg(fAc_eYETCSpFKi?$1c~oKl67)MogyB0Tfk7 zhiw#4mNhMj+}y}^ijs#wod@~HKxcR{6npq)gFu31rj}G76OrlZD=4Dk=4?+cXExj8 zmW%GLTx=g}5n;s?#!#Xf2h)C`RJ?p)mfG$`@)jvMV1V+CcHBVz5{Utg4KCcfgsI!+ z5+MFDu}_L@x+LD%Q6c0KoCE8UvIYjYXWs>(-^1(I%wx_+eb@e9e^dmlfg%TBRYCKn zo~W2tWlIZ~0;nDp-kYT*`64Q0+Mg{#%$v(0GKN8Tk2eGDQmD+ z{MgT+im)-VYhJ-|RxWD0TR$Qt@Mn9i0mdw69|M`pYwGQ%5BJ<_u2w zcyLa(va6 zFDv~1%v8VD90#DkM#{)3&#rFm9L(wUQB|5~+idJ;X8;Ho;bkRa0KX}j@meXTQlKxs zn@U~x8wZ`9OQTj(>PcXeM$C~PPN5OtngjVV$&bMw$~5Eq$189T<1P;z?lprnljdab z3yzko(VdL^9J{b;4eIo-%4KlBcokQ7%k`6O4NY^K0UmkZ$$g1xDT{E+6D^3mWXb{5 zC$9%JG1Yp9l!W*WlQ1IuW^;s@=j<+8P?84CJn>l3SQf|WYuV2!Y$>1-qD~c5x#3P# zqmRQ1&)AY+S}{Mg%pOf>u-kOGJqTL6@oe2Z*@5tkyKH1c`!!>mCKQm?gi0DC2}eHs zqOh>PwZnK3Gl+`gQOce#%Yo*-w#%?*B!s>78-}#0rm}ltNtrWD)$lQY;0QK5@E3~? zi}UAM-8=}^WlE`x+kGBOR7F;y)PV`Yec<)uBTUUAWt_g~1==V`ZYT#Lj=qUfl3=HS zz$`NPi@ctj<;m!x^&gK*o;UpXk3>KHewRKM(9JOZx`LKB#QD8_eQYZMz&&OvRn=v`65|BM|u>!22g4wrIE z0e1f+@-Rl;$br&G{1|&}gr;j~$bj>g9 zh5}98&H=Nw-f)Sc8MU+8ro03~K!fFP{768x0T_n_Hcv0y-os@ToI$Wp8T%uJg(s;4 zEZY$r006*U31;2>|9+mowduT024H8wnx)vWobQA~GR!f3DII@X9ZUOaqu&xGVqO_@ z)FJvAxx1Li2(eUZty7DLuh-xvuLSIs0?PtqdbmSy`O>^JE%$VZSyDkFAyGyufy%ml zwp-{%Lm~zg+HZf`9{r%etRx)zp4N0U* zD@8gK?`m@-L7Cfj>9UCQWoO)LBG>*Bhz4mw4&{*!@lv(=4d*u}uZ<8?XS9c#6Uhg! zYzhw+NnViZ`Xwq^G2f=M zq;Tq9(E@~Ld@Tpyq;9y@k^pnYGzo;@;+jVviLN*8fi3#c_uvIuwW-KFF0_qBkF>VfLS**6pEJlZ0Ol5@*bc z*)O2;VGqw98E7#%#qRqNW0eqlKU(p~fUbH5)i z*!7WMKy%RzT5+>k^8*1;rq!R=AGMeod?xe{@DN(B4``5w^OsyHi zCweuEc)v{tLwgeLiW*S!gS~JCp34lyFomi2ZMOqh(3*FIHAxVvVMlSlf?)ijb13f+{Qx!aR%2ahxf7 zgFD)4P>W!Q?bwhjRqTkT7;j|UvLkN-xyKyeG$)n_n!#VFQ2XBBs|ew#;pSnztBC2B zZ`RHceEmU6oK-g(&p7$GC=?Nnj$DFyLPnNDbtB1FY(5v202X``qx)&0*^>Qg>)JTh zHvK|sR@h$tre>HvV}%$B)NfQ@O37|biD zl%Pq`dg?ZO@_Swtu2RL(NI9gXWqpV6mw)lqha$nPQhjTh*DQ*MPKgV_D3$THL^K8S z{jrwbne$z&^88&xY4T);^Xm>o=qR))ySMIiLi&vV&m0%*6AL9X3bozH_M}Yyr=5$D`<+aF`C991H*SG$i9}#%Sk4v zqRo#>F5^TxQN$=_+llms&ddIaEU`w1S<}wUv?+}v>&>V|(&r<0;9aqJ3cBHn=e%IS zfB1Kzs*7KEe_~|;b;vO#kXwl#zMBA&Q4F3pOJ(lvLC2?-#TRxH!Njo&zU*G^ndocX zC-K|>rv~=WGegJ(o)u)0+XU1@gt>x4jQ9n?EJzuu0+DH@K}3ZR-UQQ1tU;27+}}9D z0XL&XYnc^n01i*}j71EeLY;1JxvPR-c8@^!HF$w6X3u8&j(hIu*N8#fp?m&WChn#s zfb!QV(^2SmaVh$vy8RTgqK{*nA<7#=yAonazSH}R#JOl*glEA`q&8ERY|s(JC|QDt zLVw*Kj~+Bfcu>_F=T>F9>eh>R{I>)N-hHy`EJ=oSgEtnBq6lcy{>NYXnlHjuQH_{U zuTlwinPCqB3CFa&)v|$$wW?(EtaB@biK6Vxx)`r&Lo1eV${JfWs`g{X)^;c6rUU~h zB&}^kG+CToVW%^d4H&q$ut+IF_Vv19yXUEnZyhQwDZ)YJLk zqz^`W!R{DQ|IAUn@X@X-&z4#kWTW%(c}RIM@@U29s%@zVqexeBE7^|_lk4A9=_Q;} zAj8O{VQ}CDd~5+R*>tnYVV4AMMk`V={Z7S>hsQh}r*;nSea$-Us-iy38)@vT*&+F9|YtO~s% zC0`r`rRnN>-*U;9K%!AV;gN1G!|Sqg9u6*V_^tNAirNIqVhrI#6>5&E@+1k$y`7I( z1d!27n|}}`YxHiXu)pjTFS|os-Gl3E5T!;s0{&@8PejA(5j&LUwpvG@&oTLthWFINnhAi=MvN3Y3eJ3BIyrth8|V{`bUL;ZZ&Pf3xt6Bx#CYU-8~KmD?7 z6NVWsd?c>PoE9H0`fr&OJvzbj*4qB|V&0j6KMl-`WgQAj4nq{*vV$9!hPOnThn*(Ic z+R)U*AxxCE{HN+bC+sBARLNS^$$@QY&DEg=?;8){w29!kw&!q^{Ol#J4PIo_eY3NG zXqkSA!N^ZF_W77QPrK-zVg#nlkY*3b3$8G& zS!PaUcCwLgSJQ(#gdiStqZLyBSh>y^2uV;4wT%}Zs9&v1pWUp3%wM26*R3?UJm}fC zFv5Xfm#wGt8u-5l&Gr$Z`kTC6{!-cCNFwmSr8|S$qVl(hXhI5?8~{kLt!Y=?^H4o-`)0-@B&9^$cI1Yf=zy z%Ojeva;gVrA-bjQiSurM0Q6z@4ZX=J);BC_EiEojAEu|T@F{078p$7t9M#t_$tyFy z8&cz2_(2Z*gmhxPqEm{yr2H0US9C)XPA+Ji40`}z7w~@Js$Hy}nF&85d%ZxwSpTr) z-B6}Nqu!AWdcZ<#ZNV)vmMY34kYBvyxS-n|fbEX;9Y`yB{JTz-dF7*otIm)e05Etn zgaBKndxVM*ye^b|eO)|G9e_HL9~9V$#dEZ~Mx&lQ$Mvsc)lMzus%0loOw##J&(LJG zC+>agXO9WoxJu%OetN?Os>=)&zgL~*Tj+wc82Jth+oz~2ounJQ3sVBgL)h2H zonvDY>wScPceJ?2UiMR|elv;|1PhZ*#+XN)F$eMn9dK))y6r0YOYRaQz&jq5RIYxS zI^ZJxyMBBtw8**6D~t09uWa9hrjE$cS(b{mNhAJL+3uC+&+4Mde?M&}z4WlYqy0Bk z8q>*WnrouMICva+vC<5T7LX9+)tlfaaAMsQK{y;qd{kE0Z-WN%eoXI_n=V{_c9N}% z(ZkJXLJkWJ&0r(2gfzd5c~8BP$I3|<&6J?6oh4LzsZh9Hb&C)=F@TI=>NDRwVI6Rm z@^^)w?Q9sc+VvJ!saH1}zFa_x9YA*fwbMI-`EdW&%`v%z=R6H)nRnub4KT$*O{~YH zAz;!R;A8`peQ=yp0iZO=J{(J8b$vCZkaCKi;^r|0dz*bBqF>SK{=)B9c%vQ(LfLni zl`PTV^Bf6d-898YOB0fnhpq`#)2Kc?UMap80^_pr-UeM^E)i0eUZw>j3v$K6pf!{S zU4U;24Gm>>rvEXD*V(nrm9v|I7&lRx;x*AK`pU~gej$WdMj!>IC+GBxeg6_cfYK2N z3>3+=HzQfWJFcZpo<>J%j<~Cd?HRt}<>%j;f&-}m*TZ-lzleA8bop6fxVdDhTz#UI z`-bco8kM7hWMUUKI%!MQK_d2`|5ezLHW|~HsAC{tLH|V8^V>1JQMKhraI7<-QIvt1 z*wjny*ZhbG>tQEz84$S$Wr2t@EVL6js+(660!TlE{ZhIKw>@Nj_DQgD)f1xd$&%;w z8>9(A#5#w!`4-nQ+4pI1<J;{u*WB??)m#S^7Zo#);;lx z#SGq%tBg3q7U0XDuZ0h_MVqG_Qwv#Y?*U4~ws@Y1k#7q#iNIIDEr5L?S-()jLWnh+ z?S{Qc0$lWy!exsR;u&kzWlB|S!!|A6kwV$(rci0qF0H`voE=hENe+n-)C1km)s=rl zNTB2MLx>1tr&AfDfVDJ6uqo6$t|<%gib4TmViJM(YgVzP0uxeH4Co;&$2TlZ;reX3 zlJg)R@x{2r^wq?<-S>$+a{-Y{!VpA(tYrYarUBYav{f3Zf(lDKcCi7wz6MXZ4%CD1io#0*Ou}q*%)=D>&z)gH= zP6TwUd?BSH7$|=cgx@3}(u@fHqqcxR1Lo8ICnPh1HOuL5{#8M+knk2C4gk(!f0x@x znV2iQqeNvO?Rm9AZ0vvxy!xaUdc&9hva6+3btPu<(h1lRoa^?B-@&?6J){81m5YYb z0_5mCW({~gp_ReQW=Jt@8lO&mbRy>Fd|2A`kz+WOAmh?-vTXDLT-_ag=5TeGA&|Bc znc@iqW1yoI;sFnPP8MLKTj9bxb;N&`IUcmhFsbC~dd(E!A;LKZ;1qY7K^r9b7ogG1 z@A9#&%R7qVU4aAQMr~LB3N_JUVfiN-X^qQIyq6xOQyWp*-%t#|+#u!VB!Yo4AShti zCpB#W=ZfDrnCch5idT&1wgeNg*qK6j-6vhGpsoG55BJek+VxS4LMMe~6)P;O_Pzq#$84x#-f3sgN9cs@HRU@gnwSG-!>f)Ak z09YIIXTVfSnv%vDEgv)uEZk|LcURFyMf67I`z|--@T5C4{)uf@TJd&7afT+lYJOA- zcF-(0HM=m;da@;6>qphf+V8?e?WXdC3=?#OC{+hpLEX#ssvI;qHA>f+R*Dziuz`>D zASqNi{-3T8&pD;uPGczbDJJ0gEtA)FRyyBvrqS!HI?Ue2w;@}`A=aB`t+Jx(j$K>^ zMCXYggiD)nwz?QQOjYbQ!zeMUn5*uoOi1(v{&}yT;E3!yR0j4(-cj_W@Z^sj^9h>!US!hH5Sjd zYFm*)g&ZE|W?-klQ59~?Ou;zzSiqT?!m({3y}!yHuzd-_Ty(!IP5HoDPv+7YXw}U{ zp=zmKzh1jr5~%ALO`KE|#X>X+!&GJyAw9lMZMUNypJof9G(Kiq6`8;k9e|rV ztHAr3Aor8^@e*;^vWmhj1s8PqJk1Um^lPUlimc8jOwr=RKUBpO{(qy@65&aRH1O}) zOg2s5{5cy9fNSj>QY(G=kK*HN3ZZ7(^4*i`^6bE}jB?Ndu#8}#i?XT#>u_ekr}*9c zhs!C(#E?!FBy`-~_hggPicG&S{YEZM&$FRWlGx5~uUuH!-kZ_$zemAy>^pTR8O)Li zd-S~=O(^U^Z5<5fQgIA?t@pZ~^@^6Gc=KO~N|Up?K4Rn@ZS|RLkGvfxtcy~O?rLu~ zQNs9-2Yi_;IevNF(eEe6weMJSF8|==*4*`Nj8xe&{ZC~8V<7yOk+#Sca#@f)j+>z) zlx)|?Mn9hmh0+uGSf*?TRBhM|*sO8`W10EyHA`di?=)Uj&^%Zvm^M}`K*+w3=Ya(^ zmb$L`U=^XL@EID}1I$Np7XSbNoB_IC&?;@V}j@$bc(n5yG$7-it(*TuzA2Nz1;IP3SJHi?XXoP<|scj zLC&Tfq2Xwb<9`5-*fM7s2lXWs=>}`a9~*^lFo|g?6@S0`LY^Jz10)mA-yRRIkv1Dw zty5A1Z8`L$GG>)g2xm@8{Q8yyk1!{E?s2qtn?5BV1Z0@#AETfXT%7N@>TCJ{0J4w> z!rLlBH0oKS2*}+Laz29k-gm?j9%hS69v#0OhImr^VdaK|rma zAyddwc^B^{5b`N5gg<0o2>}n)9v$+Zgc}M9O&W;6C83>2TFkY&bgZ)pLjrz}B(@O+ zsfLZWwO4{&3iTUikd~vf%}twNAy8-km3fdjpag%-qpp>;{3=c6yW3?(6>?YE_`S~+ z0H+RDlbw!eJj}DBW6+Ilk{GpUMv7;2Wu?hG_$p7hXiGG9L~#<3xFWHS6f9Ub?YTag z^)L!B9&meyf`39Y$f001%l|7^zza+Qs{#NegKET*{WZ2iJ+xuqNa~cYMUJ6`t11_f z1A1oTI@pTV7-71eTtBA%z0sQKH!zNgQc#DfoD8ZTLOuQ_DS9B4>Eg~4SH5jsPDa#d z>aPR*d}nVKr{UV1ERjs+E$kawPKs4!g_)zw>AzrSeEhV$PCFF?f(YD=H37 z9sn6#g?v(9{bnaX{PZhRCynh*x+w*%o4SS~NNva;7dE}+3uiwPTC(nKR;!*t z5Q=nwi$3!0j;YSx4r_f7BKR_qLKGVK~RPdD{IChXMmRBX%=XmUJdXX>2JD$yh)bCj*$=qT_tSb~G=1+2jv z6leI=?MnpW?sTTlQ0qQ5<6j*rEd`MD5v>un zan?ToMtNd9DQz&$roj}0WN%ztF5=yzAb(1}gRNZE#7F4D)fvOhfG7!q8+=!=*h>B# zFplOTaoRH6??QG#WpA30w~rRqGyLT1+Nq7FjGvgHQ@l*xydUs!Z(?MLTaYi@h&#L62gEZ<6i{LM4jBH5LxP#D<+>p~ZU9?_<2FS4116phXb3P{*D)>mETLKARk4Ej<}=%95t6o$!DQokIONCdJ~MJjou>;}(mcwEJ17LhUJ> z7OZgto~1e7Eca{-^XTsHD?ZWG<73i!*~X`ex>XIf5ewk(5B=6pERBs97SZxn#w=tr z(?pC3zBYP0FGk8~5<%YDrd_d2TO7tAK1#B(lo$aJ9h9=fTzY4?WG2B2=2`*>;T7G| zt-nur25T-|ayuAqd{|6^@O(C>m#gq!-D0=Jv8Um_fo+GCetDkOm8a@F%d{-t^Eduf z@godUin)4M>+B3d_eoLc5Z_0U6;n#wRL}#+UF}RiCaJ1* z2GISVPpqn7zS93`QmN_rq(F3|D7k3X066<_olF?K;l7+_^Vw;0#sSE(2!yhf{v0($ zq<~8!28_OJ0?)WF?#Al~Bc}T1^^$K+0ib8%yf?q+M=@7MpxYLF|*w*!v6b z52PR~-Y5Ko9%=xIn;%D-6yIxtdE!FeBdKGuk<=wh&3fW7(m(vn!(fY0bIW;1Yv+mQ zo`pSjmoXv2yU6}E+k)C-nTU_hh_}j;(P3w;M#ojba($whAUc)qJ1Qb>R=*E_H0HQ) z<&mDD7Gf!86z}0&lNNaF^56p_rPJ zWz?sKJrB(_np;ga8}<)R>TY9nFZ07}8K}ww9-K-%6*5SoTqYa#huSiTG8%u1iVya; zppVA3*%;B?2;dk8cLJb+h8*vaj-TG*J*1B!N`z#rT437Q~&#^Ms6086q z+e!w`8A-Tp&pr(5Lcp#y7PhK1zHA_A&W*rHsfZhJeCB#CEB?u#-)B7}J7_gLx;x?K zzRAVONx2ax%AC|M)KiEp-{UgD;R?6x6aU0CvWU}bx(Fx^vh41*4@Ynets%-&~e##{*8eOxtvLPBgOF+R(nU1&4#>D<~^JBw& zpzd5)UIaRgjf)X9Q;{W05Mx{)96|eetZLJiJ5EzlH<*%OitAvGpsE-KJqh=BAA+yZ z#AUGR5w)JgKgsxmWZT$ftp_6}1Rw_3Pt+6mzqmT5AW?!YTeof7wr$%y?bAMO+qP}n zwr$(Ct=sd@%#FDBwO%TAW>rRRtZ$iOY_apsvJ8J)Gf^pT|AK=u4vD`vA%IniC`#w~ zZ{m=}vKzRH!#hcroqB3{Wbu|(%h<=GU}iqgCQ92#Qp1~L=){M}^k;QW)SxnZ~g!8<32PP2w3CME=Sjnf1r@Ev9dnVwm0HNuq*f!<9!9u3ex?D0yYN?0AhJ4{Zfra+ zhY!dc%^BLe#3Ij&VLnm}z#TOeFQR1Qpwp!Nw*30NgL6KT8>-Cu7iNxqYdJMG5!Zt2%+i$tlo^aYWj5%+PF47j|6@VUfA7Th#!34Z zveyByg=&4HH5fkLAn4=2qrR=vOF^V5myG4loAGyX<;CwDF8!idk9~9jk;PW8`9(*r zz0m}Q_F@4m0l6*Sy4ZYz!jcD&% zUpN5ANw`E-VTK_k3L`Mr^E*oyi7u&*o{xs$KjD`xqx~^`)U%9wdjdB$j#xL6s_TqSw0^C=##w}t}PVImkWn3)i$s*6n@>@;IET{ za+gOWqn%2r?w7hMM`G#@yQ4=xw};ZJOVcdI3Rk|n{sjl_llE0C95uku*z{rn&aIMg z+oUZc6vLpXM&XVOGs^^s^fIe8i97GbCC zR%_N6_PM_P(6bR1(0==f2)4s89tN`o9{G5oQot}+|Lnr()i~lU9xbByD+fXm*~4B( z65Rmh^#3bnK=DX4l7O~Aij*=VVC7#dySQM6>;HR8hLcCX3AGI`<1PiHDL63BO|aox zwQ23%S!arMt@~I`q9ImWaYAbai)zQOxTby(LU*P2IOqvl0-8UWvkD`D!-i(oe&mnd zt^kjOR`?5Q9&3cL@t61~kNXDN%}!tjY>U3Sm6@2UX1qo8WmCh#K8M0n@?w{LT~abZ zF`fom>YH6N5hW1<6kYvfq-1AG!nBCt((b)H1mWvY6X20*}{*ZX= zgRtJZ&K`eYP1S-mF3o5fkzf2F!m%!F#_uy-JvyASlV$5pzXkrD2!k--DTsCNnz=pzTa9{)nIEb~Xm_#sl$XEpe>`+A+&Jh(oaJpB% zG(Re9`DXcAsDwayhuk|OPA_H1l1i(@2u~lt!KP-nLn7%yN9mS&ldp25GS^MY4VLt0 zW;M+_Q_-;WhYnf9;|V&yK$Q&R&mnlr4(lT+Ie-9Y4Wu?#&lu`~dN)#svwluLXCCg3 z1*YX=XmA~k(=YPv1&8A8r@ zdMbt@06`z;r+j`c%c2Z&L~yDF7(PKxFT|hC)hDO3$RoCT{BW>cR!_+$LYesI0jD|z z7xsHruDd*r(+DwitJ+I+v|MjW1L$_@?JvQ$G=3o+|FDWu_i&TGUe_TPNmIHT)P_0- zzw%ZXdoy4xEhS$P{z45?@938&SU-ATlbt2QcVc1)aYYZm(DH9 z90F-&o&*dZqBGO+hy(i1BK+c1;-3z8`5V54@3#CvZykxJ#4fKpzuAqR9<0L586-_w zRG?_h+U=uLngcJ>F9uarrowiN>{ue?Us@EnDx5=f&utJ!PYSr*7?=7r)>y4bi3ZYE zx|s2wINa!|dEbl2Mz9mgX^mS!b1S1XYm%=kAgvD_hx7ab$2h=+g+2wFa#7XR3b!%i zm&S9W>B08RoD^jp-r9Nw+}=i2k$#|^dd&r`Q;`($PPn%#A&LUI>;-l?_82edKq3U> z3?_-kXgQ{G<|gfv2HHT*+U&XQZoxn!NF7wk(=-h=%Xxzw0C^7__MA_YFk7!O zCNG9r&K%4LBUCC@TR8r^Uw=@%6N<_ibzS4`Cjo5Vd+;!H{zec$>FclUjE56u2t@h3 zDTuedw!dQ2N$bxe1)VKiE9fwACBd3C?tG}O357jecOGc&ne(!0rU0WKR-&$x3VZnn z7%eH6FkJE_8>Rqy!kap;T7tBiN>lKO7Pj5oGlA>7&u$sBab#r(sJL!?W9u8WPM%6z z)-ZTH2;-1Q;0Ifo&9`U9l9DEBdjLCrKRh#lh5^(mrSNL5 z5fL^g6%2^tDn|FfebAu)*Kdaw7UAl0!|3I(Y5M8rdZ!bR+?ha;cyTDm1Zk9<8-Hg; zLOMuGFF#K{mQ}u--W2*r79(pu*Z-8-GWVMQzQ;iFCTDR~&6Qy75k)d!KQAuM-0M4= z4@(;0rNnvN)sHy?;gXW`IC#k9%c038>mQ_2tjcc@vu_W^n||Yas38Q6Az7fGlTC5M zPBAu|TWw9(-FvNHkyN~rViD${A`P5pXE0;-bt)u2r{s9`W(d%|DDghUTv1-DXA4Sl z1+mHHi?eZzcj5R5xtazzCan5Ve68pfRLO^`7H^uTkT`jZbN{=!1+~ScgdULuxte+-zL;@)C}hGF z`ozy4!QDY#IkQktnYI+cl6JUGWZbb8>92+^2s(zRxqy&?IN>2gro)(n|I86!3e_KV zbRw3|anv3|4>mrQFpzIytiP??^Jpk$|7Pa8lafJenCCUmX28%?GBScsr+<+ug4=gwc~HG zobX-CcXC3>rl*0~_xAiry69EiYu-6WtYZx=RYBrp0ge0f2!egD^2>(>2Ka3}dx47f z0w@Xo7EliabCUlz75yLedysH^m=slEEZ|g{V*Axs!F96An_*!^mRh8vdOcF9oNVPY zEWvr_^k7$QvZ)(pbLhC!Flq}1Y^SZoH8xO;y*oVej;IB-mw#e~9>v_9Iwlw%mF--E z<9*IH8x<0?52$v6QS07gE+^1e>@$E1gE|B`tIWZORZe!^7c0NI8lKh8pbf>r6Ce_- zckHgLu@bEEZAM2&QCmH67Ev)A)>GK(5kHLnw->f<5qTZ4t6M5k^=Ml{q2sqQ03{qX z5RSjPlk4bCXSRdNhkuh{quX#=s_=G$+wNSdAL73((R}olOPQF7e@;yLW5;!V*Pyj= z&~0@Ygzy%=9XhC%gYV!%#AMINDN}3sN$dw+c;B6jg%VbFDv?ESF+C;Bm1Kdx~8|_^0 z;-D@$@RegM|Cpd{!~j4sob5XIg9XoZc{n}r>~{v58G{}mlCRr+@%5gjY55m(t2B;r zg>Bunh6T!-XJW~)OAQP*#Xl`6Z_qhgbwzVQ=L6$=yN^pE7q3~w3&LkA|DauM2Aa|8 z@}ETk>AI!w3~;d4d<6*kT@N4)z?_!<6*T=ATYQSun>LwK|0hq#Ggv~YRy2@U#(#no z-+q`-yM;Qf@9D*Iw#Y$Xpv~>YtxZqPw84-YIwJ(4FQ5kBpB~0{)*k7*Uja@=in~;p zPIT)!951FWfL-8FER5pN%ttac9}AWqcMjD=F(=;+RcdotTkQ4X?pe~>^Nm2`IBh~p z)x9)|DCTo_JF`_=-CU4L0g;qSzn-lz6;!mxH#8&uEQZ<2YOc YulAK?)F^DF=Lmc4nLTluOszD&PF0RFJK`YSu$A+ zg51FVMcB-6RLMtt&6TIAgOI7DYnse?_J(x9TdFd$dgL{*Ds-yL&oH!H>s3|W2Znz1 zUOYw?f9o2l9Dc6P5+s(0m|i*Pyo<>P{q*Y*YA@P6xi8rgqS{soUpPX+^Wek6)6)X(`YY87s&Sz7izadjmj@_ha_4XchpsZFI~TM*>;^LdjA!l!af zm;#}~$biopc-~tHO1XVekhwd?P;3RBpD;PaT2^4@d}q8=bi3Q2k9S)a?y(e41!h9v zEVey(qf6I0Y`)az2kx=A788$}W2Zl+cL|&_@=334S38B6O@O+|g;#JTaAUwN+`2ch zb)b*|xa;477RimL@deE%E`GEIM8uas^7x;x3*$zR2fzpt|2FvPS8{SYtiQnor zkL^=p45yu80`SFmM>F#)1PC8y1nw18;GnOijbO`dPXAK6(_poS|5av-9d2ynyl#gr zplngI+hy@;Z)pDnGZH}gZ71PQr}2*0bUyt!8hlfe8iIU^dv7`!VO&ZhqN1;9G~?R6 z{^?6!GJe$BfrBp4*+Y3DF_{4FFef@xnWn;8*`?4k0U%mW88~f7P0H4DXUUA)HUNX# zX8YJzsr&Q=NS($p-V#}m?N@vxrPTKcOa9wIgTmRrD7rN0`1ZNZtU^0|P&Q#iaUqSa zmdqORa&ah9qvLgK{lqHJxnJ>T$TwlFA^6?I%+tSk5|5~!nt*(~#;+9egW>a~Kdwbq z*)DntIU+NQ?6^(0H$OC z`PE#bgqrqPF}!C~vIRq2v?oNPqv=nJS={4xl+sn0R4Cx06gtNQa*~b#@t0QS-84Cn zCw^>H!WtRqcJ9Gc@KZMV%CzWNO8v$j)V~u4AyCK;S>@Xv#2q4K?$oaA67#zrmcqym z8n?0U)aJ(6f^d_a5@Fdu)m4GKzX{{rF6>)bc1T1!g@ni7*6IVqr^w#j+p+LH5C7MUu)810`m1Wyf zt$=%_FNL>&L#|z(NI#=LoMC0)HES`5{I}|vh)7S5GCD=}+MdO19aa2mK`KXgcQ8|! zP#>U7i`@PA*gmY8KBT)5yNDk=yq~VQ(1COt-CmurSBSLONPIh@C+xmP|9jlnVxQ!! zb313#^&9DxE?ggMgLJzg2yx1>RckNq7igU6>I`!JuC}g~UE zwbDggLIYPyBZf=iEF`jZeQ;e(laDu7KOvr!r1DL zE;DRVC$#x?aW7)FJv^J-B$L7$EVE6;hMX=k3_wu@OZbH_F5+oXB6EjrnC)`;$VndL z>Vm=t4YziT*d$m2=VJ z33UF4RT#R?di?dl;K?AUH!7WVl-MHapj`FGJN#v&Zg1&c>OO(pQm`yjHRG=4kFF!| zAY*r}&4gGCx-wzSL({r|Fxl6?PRX++Q}(XKMvfy(R2{|Mnn%u|<5){E-s$xjiDEHokTWTm~c?!&8y~RI|O&bs0Jj zNqxXKfd(pEY^=)87D~l@b$0 zcF33~QKPZriICyY`PaY5mKnh7aJ5-l$?DI>%KW{3rS+a4@Xx&yE#-oQ2wt;|x(CCc z_%*yCTQr|#YJnFC7E))Rr0O~aEZ(jKGB4_#bn!^YBwXA|i31M^&K}F1bT+7ql=lKk zpz6IUPucjW6A*Z-Ly*G>;&UsTq$P%fqCEJcv(g62K|}Ytd3>++#Z$fmNbj5y#r&`RI;(HRFPpef9KD$=hL-ppA<4Rr7&UB z*teTD@CLI3Ux!d1J&NuZc)D8NbdSF;KmVTpVKm1{Xs=#8_bL{B-GcpF9*{)F3Z}3q0?T3s{Uk^ELlrQ~tF{$;24c)F$Ps-X-oUO%bHX*2g=zyWSeFZ~z z$6joTB%=0T@lHBlBDmv3>U3+cE!O81=3m!6tCf(r0MxPnwoS@`ft<}5Wv8NrKa6!A zn@#O05wajdIT{vx$2*R3^>2v2Ssa)e0|PVjEOOiW?-ldTDkQqD&1WSY^3Syc!hTxu z&@jEWT)@?}KvNgrLiq1Ltui{lSTAzgIY@)JZApduV79dt!l~944hw;^YdH2DFAF_C zF+yS4JbbHE$NQfH-{tsc2o2gmal51cD4T#WCh zER8ZKD{{o>lG=gyh*3aJDZYvU?KQl(bmgWP+}=8KY}4AgJlgqg*l?AUPl4f~B&^jj z@9%`vq)dp0n84Zg^lPUSxDcvxWs%ud>s7v77vUlh0c9TyDqu^+0(nF%aG1D1Cw~oYSzjBd&ChTe)H;scAxK*~ zgYrnlielA2#-Jr&KzQ6p+1pQ&VGf%F>iU4z@wcs6Bb=$YKs~uku%X3UE%L%Ea^6C0OxUnp3Dh|R4%mxyYA-zRkl-gp5V_)|MX_@Fq|gepw4F?s{$kK z7WgAeEJUltZqP}+R%hry-_Wf%{S{4stWtJH%}=q5)<6^vVuyN+1TAC|8o$E{@i-1c zjibGFyorg@)b?0ZDIm*-iN`B``L7r4(1@!qV7lPqk{DpRxTeQBW5VamTcEdF(wCx& z%MMLx2KNincgoCPw?p9pF-m(Fym(6m*fJIa)v6*Ec)LeQ6%IYd{krf@e5a`6Boo8%ThL zckH`=R!R5b4Wxa0JD{;|t8ce*ZuGY}&|rA7qsYmXHwCw%vi0(5gwKwRd*Yqp~1i-03IY7-SkQ`S1NsSw!4oIbmv?bs+GmMR`e&zDgSUUOFv*q~(?qHgtvLy3 z2|d@h#dJN9$_NPuy&-EMN-0@D6a}r5ExY96{t35}r!Tgr7e{&gP0CJK(st)PUcFU5 zv!+wL3Svl|nC`uD+)UqqdZP2KHEc{HMzP8iCP_Q$lp~hDR(~P#9O26!BOcHF`aNZ9O{3zS~4puw(IaA{S^apK~R6t=YrIC$uj zY!H0pw%Am+nZ=YCPl)|~ZwOu$Ct6I{y{?Ow&&C#7o;b`wUfuyWdUccsSyJPCbuN5n z;{J5}v3w-NSJ^;vtE>zEvrHx=z{d`Zk{6RpIx$4c%oANp8F)st|Qpri1HO{*KozdnNpbDk)BrMJ&)O$k{PLISLwh-yY8#OS2dPXoK; zi9p9Kxtq$s95gi(jYzxRNjAt^3(aAJzSPu90B{qb7>f}q(}++r82N7p9g=nWzPsN* zA=y#|LsUDDm7D4Xm(a}^7|2{`Qw%cU%S#$-dMMcEIp`Q`!OgyB5zf~(*gaco{t(c9 zwU6>-v7nmd8KamQvw<6z6Z(Xss zmTf}!WN%>N@dmn*X5Xp!=AI;_rGr>jQ5b_uf3k4TQl>NV`(VO$HLMgR&Gq*S3Ii68 zk3X4K0tSE;-YT)dtQnxnKrT67F7bm$A%)?2=Jc=j#tl5 z1F}i@b1v_qs$4|FeIjjHI+b4o>g z_+lsr&;^YqE@U1jgN!1F(&!;8GPkxaO5H4txR}y}^qn-89U%W2l69A|(S$6kvQF6` zHnAv;B~!KoEGC39N&IOvTt?pE-z%~~DXF#gaUf&_DI=ajgm@M73WkmyqaIyFNY?w@ z#LT3>g8iq=J-jh0jNs@sRlN6w&d;pb;pohlp%u~7P1v(*bB1jA`s3D;^YQo34S3`R z>FpNRE0MlPLnA>bpLaWzKkB6r^3)&WVfWySzK8a?Zps?7T<7DTp?MnqhL4+AoHVTG z^iOhU+Es_+MZR>*{^}tAs)(E}@(d|{RjWS2T6+qeuHbm_r|-hPZZV=>FDhYlAvfbm z_9vI)ZgOwJ1ny#;V)7ndno(spht2~wKgDejy@`lN-?g!6O*{QBQ`ac(*Xe~4 z1fYb?hLvtmIME}NJVk?gLl?p^ALL3w(UYLKlOIZMMIPqLy)1fvKZuyTsDg`vq8l!9Az{u8QSj2Y_JLOG=hBQFpdAhAV1(l- zbz*A>SZcTvg7Slq%z9Tn8 zO5L*brIA-1odC1d%X3iglY(td;7|Ixd+06Wm|oybkfrqBp@*1H4<|HL!dusHmws!Bm?^Magw_ucZBGwqGtIG$C@9WAc89J;2d@eQZ6{<;{ zXHR;VUl$&&T{qo<4QbwNa&Js-5v_bSf429;>Ew;5u$Ur^;7yeuZ^F2g_txCLTu9*`hmHS9 zq?=92f;c^S4QvC?RkMepEPoECyEEgr(i5Q=oE znbP^iJ^S&VwH^Cl2NX4cH1Vh>J*Y|?qSF_|Wd}7GjF3>bbH<U=i~)1r{#S#fFgGLQ-t*GAB-{zWnV+VFM&WP8%7K1og|z2cpd|qG zWJefj&`~%+pR}ocFDY4MDTXl97%Q{BZjYdi2WNH_zvYFLFEgzIw;}ROdi(d&i1Zh$p8VRsa!-fw;t3-Jirc4ldC*eBX2mZzFq2utk!mtsqBr&T$7)z>f zxJ*mMz+8Nfe8;#V|1X!y9jQr1;4owY+`yFj(4gcbdyM~6{G){bo$7%_?|?oJ)A#YL zPVECxl;&_LKvG9=FE)N=S4dXil9--?;pv6dF8ttkF&ryi<@k0VCVG>rh^pAOycH3U z%Hz@(8tNvm%9f)B4j5S8^;hA^&gaG$1v5oi_vq%^^YkRhc?YP^`OglBkEn&7dqJ-Q zMM5B1WeD`|9rDB(vF!0@OylYwrd=2AP?C)QOA#ojq%lfO)KvKsQNX!Qkw^U|-xbe$0 z+Pb#aTaP=Km~CtI)Wir-M`5)9m2+ts`la|d*EXgd?-3DV8mjQ_rduZOk|4|YDLzL6 zWQz2_Cv#C4rY6#9SoRNP1}OToANnuR>r1!~@R%Th7`xRGPeVR*oFzvZ6prr7`h zxa^+1M;>3HfS)KgF8cdz`h{2aG`Qe3C2CvUJ=`LtX!;?)tavJdx3icJ`ps~o6(u;N zk#M!#udSH>B1~nPvwAO%$U@HC`gYn~$k7QhtHr07Id~YSYEC4HpmwuW;No5->%1_z zw>BU>Aaw9yS`ou*dmXpvwdgF-%SRjT1`h-A+@k#FS3{8Ltw%xJpB5n9`^65b0OoxB zx4I{Bo*sUX?T@OX^)Ap`Dk37CjF0EYh>3ZYU;EO@k8VgR^E-!e{>cJ|ouize!4AB9wJ=5)Lqx4?HK)@iDLbszex&A9h!S6U^g zMaepmM@aN0yO22-wQu9xUv@%~j=qO7u=(Ci!8<>$Qh%N$_ARQ0Iy&e7?yzCu8UlrC z&As_4zJekf7RZyRQEIX%TU}~D%QhzHhC#C5TZD_7nDE1!fVqolr3I^(4v>1VGQy(- zlhW#E!HK;N^@nq%zJe9pphwi5r}H(+qCugL0H#(1L(8yc`GpN{sK4p+spGQb?4z(X zBHO-YkSOE-7A|}-r$RZbuKrGN@D+ExCl}$MlA4~=xlm404;Tr^mUKvH#M=&0tNPy^ zDzQxI;>93?r!dZK37x$MSR;^AbhBU06fp|%?asDTHqt-xVDEm##(NE~VBflOuRvq# z&y114qzbsaMm!j>i;{XlH0h|-G$`vAzyz%A?^qZ zD%NpytbcI`uTcg1G1)g<+=CIMici_@PgxlZV6dt2g9{IF7T{%b5;}|2ED`=NOnKpQ zd;0?GWfBL;bnlO+p~7^x(w)F1t_UMx%cZrT8M0EQAcxwxPhu}w1~UyS8UP&K(exz* znmO$4Af~8QqWv^E~~yyv7K($?9k0=^nsT(gs+%dTH$uiMES|d*>Kfb7WP( zyiBY~L9S$O$!?nAO=|s*b{m8M%wC1+I{8t$K0tG>C|ZpD?ZZAlySUDp)n$14buy)W zcIz=Uf>PeI?Nvl0G}4FTp(3Lkf$R~O!^a~-C|>-|BxFzE)>g(&?5E$ht8Ck7(FELm zX9+(XUTVMZX!Gg8D9W2R;BGj-;7Jm>uXVbiY64hy>yx)xgYlP|E2GmR>8~P`DN<=u zw`olDp-WoU4=jD$C30ipgwhxP=Gm`1#>--d++^CsuBLl?S!wQ;5{nN29q@bJGHl-zt7tYdVVb$LP2}C^dGQc z-9}dfKUvsdpl!|^G*M&3Kc9Wnjk**_T^-h0~yb0K?u# zRm+2cY{O0?q>{^4yTZc#d7OPU;`GbGfg< z^X8n^&rWo2Z9<1YW>zE)Xb}Z6hh8imIcEjiv(-9TW@S!*v}z*EHznd!(&$&gEj}R-o};Z!^n1KB6mDa zmLP7vudX%4XT=<~ci;?6G3OiYJfeGuN<@hnnwo0fs$Di#~M4{uf>hdgyQ3&4n-!TktJwU>a4zbWL6; z&v;u^RsC_2w|D|B5mc&S5~8%fd5+X1H~dfqcHK=c_dgLpc+EmoN(q@r4@)78VChVp zeMug6i+)2ONQ{gXMX>)2E6Zjqz5XDZ$C9R~E-n)&8XGjZlv?=_TgyV&%Fawf4l2!P zhO)}Gm1upC<5fS$a6vK*;8I%1x>_mL9>w_pn0_qXlWgEAoYC@ZoYLe&Ivr!8aBQuO zsnI{O&#A7)HRv@o(|4hwA+A_fNG_x&vom8>jNO5H2V?ol=<%Hb_YIwCpq*LNOXy-k z&u{3;EbWE|uPUhj);H168;;%mtR}+$z0K)ZGSBbK8qq36UlF}ILEXrM#4ANg)=&Q$yBAMPOg0+G8z;XUT0jBdBkGR=Bg1hMMJkr>WE#N4%h z;i3i=h8tTgYe|xCbA=bL*v8_%?f6?|3E7A6P4Z~hi(Rx~O2bgo+4xtkNIP-f45qm# zr^T;xmXxceJJ@9L9PI19cJe=}NXsrVodZP%=nvxmBVlADt{}yk`6D;AiRfPy5_G!4 zJKq;d=7uOB?mY<%R#dGPr&0$t$JsYvz^5Y#stHw>AL6blMLazk+r?jlptynB&z;H8 zQ7z*id)J3NoCkySFIW|#?^7-ayW4opKq)Qxk;uE3qZJnUgH zaZ(rC9wuYA?iejPz`ydB(p*FF{2&qpP7|IUqb?PccP0#x=d>r+JmxHc7RA8`nxl#f z+nlE7$;Dx|yV*+&w%pc7R7cgwDzV)LAK9LdS5cm&&a_KPGL=4mY&LA+k;Y?zO981k zfCCwzUBx#zd~CP22=1|i{ey)!VbxYVD2p$(3$DcR-SC>lzAm$7|Ch8eKwU(3+kxa< z6@7noYfABAj_?*e9o8<(n*pKsw-&CZh4#e|0*+aJp4@?Md`!3GBhE%*VI0cDYTf<-1sgdp2LW2xG4P8#gb5zoOjMRvIY#ENU z(Vjdv>DvU%TDo|DQqF|A)Tf!Z_nwe2Q6{RA?cj8R_meOJ$M(A7^|7^nU?*>N2; zsV=E`<9C@_-Sc>%HlvHUN!v6<$qGWqhBL;_3C@WonpnR;DM26v+@Onm%a#&#C+;V; zml?5#H)1nAyTv9XldYkDpq?Aw%A_to0*);~BDZ%TQ@(`l)?_tvup$YL7(OQAxQ`O% zi7p{EAcR8ec(MDNAgg7yDm9v&zag{rXw!5#!53*5&j611Oa+TUV^t&*WgS;1tcQ1l z;2r3c^8bh{3;(+*=78f#@$$rR#y@Z?7Fz|E39i7TDhoZp_`#hr;Z^Q=WY-q}zsK^%B*%W{D%{v&z26v` z#k38g@daHQ79U=J*rbCT(hN;ry2`%e>-SY#c7TlSHAH_=3TM`)}p6k}uCvSt>X zSY^+4M~yf*TSbv?GM?tAw*YDdZ)cnF*Dm?z zv#HB`5Q#;}F6=PEE}1wk)(tg`vEv+x7;fcz?M>Au=#>5dK8>KVf+Zea>QDwO30j;3 zX8hto(zwwi+Qb+!PbZZ5@Hq9T89$2yVM)ls%oyJz11SwjgIymayY{~viqE3aPkqNW z?anG;Jf4E|FXdbFAEwoQlGq8G``-1~_v?0D#rQn}T3A+i=(|LAjro#V1!dr{0$2gaSF zEtt;d|4;`BL;+Tq0P|&ql%67033C^dxa=yhNX8{&yBq?Bufs%5+E5USDN%gTJAa&~ zO;E4FG572JZPgSH344y>4d)8uVe-xfPC7n7eWGru{PIya!W$BSQM~j1(uA)*gQRl~ z+`t^{DginVuU(Qc9LVc~-4Wz1P;GTQA7pNf#wza>&6TuBv9J`MbG+LXAY+ zDewcsx?r4(mVn>O8K%~TpHK02aKZ=Hgx8#FGEMyPmcXXBJ}S_IK?3Ko!{=L(Ve|y2nwjw0SfUDX zenH>ytn!mO&!{~DnWS22q})-GHC?0|;pZ(~hbucZwO#_wK+<0ke5^0wcI8C8tHNK#+m(q+F?|1M}#P9repByv2W{jXxmhI>@;BOmOLv(;L#$%{=-h+-!7I|F$K zD7J9hSkgV1Y31Z?NGAEr?u`9M3uQZ5OUFf*G;wMI`AG|%&|rTTo~`$rO0>zXl)?7N zuux+)l8M>vZ~dc;0vWt_QZK;S6AT*I9VI2g2Ai9;2`5)^un zOj6ewJnV#WZX#v{TXVx(Wn&L>bup6-DWy`HmXyGy+c_+C>p zIBPQP80n@?vn`#s=pUb3qMPQOLjTd(hjCu-KlP?UO=g!4rv9~P;$XJsg+#Vg{TE&c zOh9J!m?|r2-ZoK%7bYP?Pelrzq#x}#^t&mYuS?T_-jCPUZ4R|&a`!D}=?qI*jtv%` z58(0x)2HW9+|(XKpyhuppr`QaN%Vf)>EO~-5n33=>k~~xvrDFofWNXDVQ#)7k;loO z-x*Vj<P#V3{ZamQEB!6J>X==Ea`zo51aw(~DKd z-Mjo@1_AB4;E%q=(ZR3zl+IXeGYq z6|N2Kt-DL}0-Oeb(EjSCQo{QT(d1f40Kb8v3soO!Cvcgl+9yHJm6gc4{% zOm%C6@rlyRT*{kRYP5Jm*Len=o#CuMoT2R_>l7^xB1kRtWqXO(Ntk9L`Iin}=X)-cxaJqD_O^&iZ*aycglL z_^Rn6L%G!t?~r9K6d>HAZGL=K9D*cewplB7$5}~O&`?mmA0+PJ38omrQK7-@yOhj# z3_2AWKUP!Dg8SPQVq{#Hc3LL4eG;La4g*-X%Txru54s7m?jWlHVfzBfCA1+1@1bNRtE#amU}x6R~{GkpRXe@95kjyE8JHv<}z0dy}q<_8kQ*9e~)oz zF(Y%~0PE$bDn^vd$vXF{b8DptRJhB;Sa$q*Sj);#9SKs;i61kYA4$%naPmiFUG4;j zKwIj|7m`3z|H62dJRyn3ojzVkqA(?u=W~(Om8+v_&;k@~#6h7ZI39YwA^t3xbruBU!z77m zrc=6kiQx<`(gj*W`th?&Sg+HoN3{NH{GM3wZ5m1kz2uS4hCug5M*cIx{=*j-5Xm$K z?1;5ac=j?@R@Gx!3tTNqm8e0z7~;da4L}*#zS{{eIWpaM?IW;53QWhRXtcgW>`oVk z%?B$f?ZkYujtYo@Ze?iDmsO;i0wk|VcijTzQE}u6R?*uL39fSFI;Z1=lR4xp7hP#C zfX$tw%-0BB_kiR>;7bRAZgYUi;Y=ZGfw5{maamAe=R&9*Zvc}#q^pQ@CK+af7uv<= zo_E^)!+y7VbL)7FN8S(~WMp#VQiemr#%TKI z>T?ca zc-XRI)K`D28W=8=qGtl&_8?S$%q;$ zA-2k$%k+POh}?+VzH{j+tYpMWs)wxc^|+t!0E;us%4Qh6OHI$_LzK9CEZg45uRO-aiA_u~cMt+1D5pGrsEQbYI> zGumTckvnayY4Mv|+V||!K{Es;?jAw{oIA+x^fG=@AHi3Nl{lb!cN3nf;%i06xj^og zY5J$cq8hyf2D8DOLX1R=!n@5^$PBk!_9w6S)sA-d=V0E7nGM>GN#tkejgkn7>yr7l zd@e&mfSqTc6$V#3v|??APpK|iThhg!Be%N=UT2|u3!I?ez>ZG>;GndED#K`Q_E@*5 z8J6|XFcFejTgJy`{)>Uz~{nmQ>6?q)6Kp*m;-E&3@4*n0e8s3HaguQ24 zcuT5rQfy^2aL!&`iT)HkTzsESXBwG`s-k>NZ`>45mSgM}q+= zoMp)ep_21jX*ZdOJUjm7jMg$bb}SA8np&PX7~Q5d{|-0&BD7I<1B_UoP=9_)~lBA@`_~T{7%QXinP&b9G+g zAO^p2gal{~j#dqiEhc|W!%Omt^qo|b3cP-zyB&bCK$^7p?4c`hVIz>iuZNp)h^F)I z67JVzj{bJt9n-dsRWMJrXbA@0h#wmBBWd?W|I`DhpeO^$L%o+@G+ILP1DLE`)tR7& zYH!kk>oncTHA+mNW#&(LXYTN*gXdrS00`V&9<2@zftruTHv1~k;i@HlC`EU)*ozIW zH}0oJZ-71{JR<#UDzfte7;oB*CC~ce{W85d1mvzFx2;UMdq=5FFpDns6I$1jVK^Tr zm3IW}d$t71!<%a@?x+da?n4Fd>~wU|v#(EOzuNKU4 z2iUI;LrfF?_-_RJg@N@-Datef(H70s>r*Gb0y@VWRcV9lXCOuD`gV z&Ip-GX&x5#q1Gq$&61`6X~3+_isiRq-8nY-2eZaHFDK=N+lhU#L7T0JyK_o#&-pDu zz=+9+nm|W=kS~i;pR7=AXII-d@b$t6)CsK&&9npnat0Rl5R;ZN$j!Y7G@Ji$@otR= zD%bm7vnw`_8{DU$&~_IE8$6)bIC) zAmGBowIS(lfn9rR5is)Oo@S7Vzn9d?FZr#+XiO+~myF!T_r+m?F8WZWOHOGD>V+Oz zBY&7;uO&pdQU}Bcn9Sybco+%U5Zf4xqH7D}mih&yrsPu^{FVSW%u0cZBl%ULOO?9d z$*ySaqvT^%Jfo?W#$0H#{whq>5EP*Gi$K)->RI2Dj1c&T<{tA}=8bp&p8)Qc*(GmE zN5x>6+7~=L3Z%K^tv?5?Cb5b-lb`%z%b2nw zHoW!ei<^R+K(I5+)kax9eEAjU*9M8c@F~qhqJD1(B8*SN%#%_Q79D`AG^v;)SV+5O z8Bh;!<59W>oEzxp3}kHVn0+nv8E23x%?d0kfi`_q)xF=7u+7)U`Gx*rIrsKW?9>iK z+lD8S5Am(|jd<=(H2ak^V!Ib7ykqxpJ9N3zUokjOsB>mt?WD_H@o%3h?ebbc$nOOZ zAe1S_A^@ne(x|D>?UL0YI^x_)19Ll9I+{NU1)q6`zvhi1P}^jaHmjH@VkI9bPB6j;NpP$Q{w;G$p8Qt+F(0T4KSHZ7&8$5TX$R96BJqL@%;;W?Oq>(8U+|!+W-* zY|(o!m~wYAmkSr7dd8<^4Li5sS_*0%)-sWakI;Kw0)kks&#EQ9FtjShR@S~tEG#4+d>PNm9Swd-ZaB@nYHvN?UcBH`NNvksTQiW@~ar#5&Y`2EMJI;u8m z33(UaXa7tFJw0wu{&x1QAz>){9nvshdhCfUnxnU@|>|^#`8D^jN(foJ} zuG8||Hmj#w5w2lSFq4}qqn-NUZEcfqa{Ga5yAjJ)Uku_WM_!g~Gwt^1FEBXSE1S{ZXGiJr2Y<5nxWn{@5Sm%G|0I=hlaM@x0mDw5$vz&+ zEy3a#TMGPhQTbAY{AvJOU81ZeG1 zAQBwKB?4?ZRPDs|ATqTJ$d=JGiRY6X0yr_^Z`Sjg}Rx5vXjoH=_}gQ1AqEP_yN$)ei4jJbdl2oZVa&>LzWZ1;yBWqQ{%YD z-9C^v(1k`g#6g%nFfM+&h*d5V{!tk-Qh7hpFKeJLQLa&jF1tLe!GzLWl%g+Q-c!U8yr&m z{-u1eMtg2=Cr(7P`ZA*XUD&NVZCe~ob?wMNbgM}y_tFWa$NE*(QNim5jH(|w}%<_%j z3MGOUJD?5#MQOGOWbh5n!%QvTETNGl<6joiZEb3|)W_)8hO%Gcejnc}-acQOnA1hw zZe6+3r&V&;HqvE%w-Fem20v?!lPs}WC2d2XvuCQ*uqMWfUnEuic-A@O`4f_gU%M0{mM}eQ&*=JTMC>BCdn$> zMgwShLAa)-v|Tlx7hFk;=#8Z+jVB)moto!1JrHE<^p9p$?3#hrLX0$7{+sJ#-5CHc zSc74jw11F-Wuutik#^_n<+#;zekY9MK^c41XMX|G8yj$qSqS9#iDwn{Cc9rW+9e

%9rAR4c;79N4;kD&l;WK zEAiMJLt`mqD47Awy}ZWH*(Dx3<0)k z4HkC36z_JNM$An<%f3S=eG59`fUVw3i!yf1!u}}fv2te@KRpb7r-`p?Blq3y`KF14 zFNgBj5F@*FtVr>yP%mK-6!Dfc&SrQ>gykLYc)fhP5N#NU)@)zY`{OmFdF@TJ_h9u^ z;~sbzqk@@zllU0QGVGM$RqBa|vL)Xeq%9O%cZLfW3!(J#$)l^1lzza}jnK(mS|23? zYdaVF#(zI+!;}iRF{6yG)h}xvwAQiJqnurTmum3DFo_X)NR#}P3Rgs{!^VOfaO&s zUXwmn!9#$*SAO-wwj7p~88Hq@e{b|;o&L#*!gMt6V_dAh;gSt?{S`){uIDJ_;^1Kh z*CT&|TwM9(%r<{yUMq5o+45M4?n8|?--LGQd5yk-7*Kh^e~j3e%@F3Mp%yxpOhA1T zNvNElRe6}*tz#MuAm0EvUg{Nb69?E(+KRZ~w@p2d{x10Z>LBNtsb}0<&hf;L9+tHh z!5<>~!CPE;-2lz87F@NAdc*lrkN57tqRmX>nw1w^hb%K2H#2+DIsY%NzTWvDP7A%*OW=Rr3BZ6`IhcqAUMQM^002ndf*ByE@CKf1N^vK#o0X0dyA#+e+BSw=1g54$o**w;)DGTY{~w>Q#;uw5Fu@i z#6LY?g6;>_#XX%n)65speF=&tKc?)wqgzR67=>=a5i%Ka7_dKTB&w7Tv101#@Ha!M z4Lf_F^L+YenL--sVpp#iKmFKvJ)>_iCz5I+Le+gwfgkJ7-yV2h2Fe_U1f1cdkNI_( zy=630XTBT608?(RBhxk9lxi7y(-~#dH_}|ixH5A{xz+E(*^IYwCP2B@)3J$Tm%E3o zNC1!D_=COYsmwvT8#)1e7B~-|cW8nDq}3fNJ$p}U6)8;Nd1wJ)XJ#I(jfJ(td6S2A zh@4XYuF(2nSVO&y*#giZeg^aVU9H8-Rf88hSAQ+AmuCt)PFl&p_b#`A)8)Kw4{dTb zRlM>v@Zd3+QJS&_f=Qn4cpSJW4MK_|VBMaVrm>7G>nbIU1}3*}SIOR5Gs7dsMo%r& z1>C_JB;L{LIzgWe{sIyEXPEDUjEk_sTnCEcOchQP_(%S!HRaw$ibCz|?idHO{ zk|DdQw_m?F4h#=2$s3|!f6^9uYhsZKXkD2-6CLv|F<|GU-(Ob(S#3>cA zK+y18yrVyn}qd++1#OZgiiQH#N3ogv!{im6L zUTtQ1dFiL+(}$3!Ki{gRm@_iiwk1Lf7){cq7%ngmg~tega-y0sb%$BFJX`+obxqAx0@$PlG1 zWxRfU$2Sw#wiIS2Ho19rrbuSF_UaQ9stX!$HxE+_s&1u77?4Xs?yl8dViL%3T>Hss zefM_0?nl5aa!J)8+@hHx@Rrj($11y@$9HFmvN>>JN6&o4I|<9jZWN5%5&+Ez7%;vV z+*6g({lkTTIH_L=D=CIE3C=g>zdqSsf5X?i#CwZaU9f`BKnhSjcU4L}olVO}MoJ5( zNWu*8u*>b@kOEpv*p@G;FChqEf=qTvlWE$gyqEg5Ze%-S1HH1Swa|g~G9!^rSdwB6 zBt&JOUaE2G(Bi7x3;Ix_X7i5gyQCivwhrHvLRnSM&L^G2&NHV)3f(<`%0y!qv_L~T z(|i{Df(*{&Wr~8xfcC4}9}+G26UH9DSh-fZj_!!i?RE#1FyH8`W@QVd;`##fKeQlE zMC69qVl+;oo)|glCQ)lh~j&RT!WrgU=}3fp?E*iFaw1~N7AyWt&P#`>O&3O^mdqXYrp-0hEA z0q#U12y^|p1A|e5nxpu|=VG);3>P|m{^(WDyo_?RQ?twJvM;S^*ks}*vZ5#b7bPFI`1!iDOSFi2|H6k9xwdux#<{ysZHx?k+x5th^V+Hyem% ztDpc4`3W5%8omGNP&5|Ps88?#Z2B8(R~HehM5dR~!t0$a=cK0i6WdQWI|Mm%Wgc{L z=j+*A6amFHa&~mWjdmc>Z5Mrlmc`I-^NP`760(Jnl`11zvtkdlpu|ROjDd%NAIvb* zhXc2<094JIQG>DtHCu}1Dfq^wve@yUFzCgUGKSS=dV-Y~ zD={_-pVo^Yk$u9y;VZSrrmo<5+~OMN5{3`78l5C4SDVDjAjWI|!EV3tFm1lHd-`De z36+m*hWMMznZCM`Dd1TY1EUJX7{xR#t8r zbNC@h#;1xLQD@io;eG80X$pF2Rezwmmo(#Xe^ZbK!kwuwHTTPDQ0MFE?IuTfSFZNv z1BhBy;Q(}|ji_aL7U0$?QkH6Tlb<%*;v~2+e)Nw}vyXC=@_4js1!W8O4N>W6>5WwX zRZ1Ci%9c|-0c8y4y@`-112%HoDC8x}b_!8WVI zb5x!S?0Z%pELJ5p2hXGl5{gZy2kkOh6uBi9FnT&_!T$G#CvBg&3phCl3(@p*NUJ+9 z(%>)O;YR#2dsZ)|*jMEfiY!>5YS3^KwaT&$gYqBty{+j|l6tOZ`wiu0pKp!H@n(pg!a*G3by;n(H$c1CnHZ}5M7H1*YG?HxiyiBuiC&71YbfJVN zL4#79FdyvcyfnTB0ORVr)rz-6vz_%n72{*xh(z$GW0Ixsfoqf2ASbGrwVd3zSayxu z1XNswknEJQgz-A0_Z&I6J_RCQJv@`P&5is6CM#w;y1w^k9Y)Q6a9kRn0cI(^0zdcd!7#y+K5_@Pr4^exgUs?!ckQ1q}TKW=}sW9k6sGT*Ryc#+N2 z?XLQ^{{4sl5m~4azKwa?7Rf*GnTy|ban!+g$y4B$%*?i0(JMm;%{$MasrF`Z@b6Lo z0a8hU=90%ktRY7D25!MUuL8Y@LC7~mi=I91_-%;#8-ueP#2l}1g0C!_s<5&hNUI|DA5 z6Uzx%z0^H!i)kX!ng|?Jx8O0$2S|q+!@0L~&PTn8gJ9RQnashNONTK}7)t!W1m~|f zAls)yWq5iBeoeR$6io}GL9W!}1k`*GgLGjKjoU z2_-JaD}Pdoi15 zg^ljZ)ZM9Z4(|hP-u!r&DOCmpt(@u={T%gW5qz-KdXuBYY{nTLzAgAI%YE4*5q&foIyshweavL5?>(E$7gUWqwzu!rU3lS#ByfTm^xG)>&@-Y}9GMq>htHT=Kqr?d={I(iS< zn+?z{w#*|X65?6~IU>yW8o}TsAv^Qy4md~!)83Jo_ocus8C)po+V0v%A&e5{7HO;Q zHS%4tJqA~(U`OOOg&GDb(X3(vM?Y)Sp^O^Sd!3`N(a0HLnSssV(?a7?&neQioHvf6 zll&RrQJfVXa~A47Wg^P4&#Ss;sXRUY==!X#2g&4CM4>YK z*J8`h2dhD2OPOp`>;{b9zaZNK7W#TxAI;(sb_#1efx}Mlz@3xtwpUBoE9pqJuGPbe zg}^sW-wjK&>(GfGiOQ@0=3qeLn;xWGps_e{4Sf&1jLj-M?Myl=C6zhb*961~SN>m` ztihv3m9}ftpx089X#WxMid_R;j!XY3{)l3$4g{JgLp~LSJ{eC(f^QYWmsj!Vn4TNh z@{9FR{p;@a%ncUgZZuEl14URSE%SOQ?&}!~p5~D-Yfy+=toizliwuy2ylgi+axt|r zoToe&amvD-Tp#91L0`lBJ7I=Zg=-w9YrhshlNCDBNaPR0;cSH-Wu_6HR7zixj#VF4 z-ZO3O4m1P}$1TtT80UwF#9y;%qyB*xOe-YunPW}ALhqcf+xK<%)XRRe7yAsf64+E} zWTKf=tJyl>kR|N&$+(M$%-rHQZ%8P49e0Dq)Wj&=`+}37-&5bQnq)M@%h}Z~S-_=>(Ll zuT7N<*3V1wCNE*p;;fX#j5RO}j9TA{lp?Hz2k6k5Usq+2$d|;JX;@j5ZGrLTriH!V zzmSJ>>xFff*M=}Ce*tV|1$x_woUbJ7bZ331x?pbQV%>1>gyRsh6Q<3a$yXgQc8?b6 zRY)&o9O#*&7%cbk1X*0AP1Chy4&%U`Q5;PN)*e5DO5`%HBJjiDMD{vj;aO=O5e953 zxb#pJ4AqcQ5!1PR3O8`9Uiqgjre!X456O{HxvxQQXGdr6TYCg7%Qh7d(3j+I0nOwO z8NIeK8Bh_2Dw~E3r3amGz!gV`F}664DrMC>sOdZ89Bmgw z$dE>s7tll*Jt8=LGlYmlOdieTI81S6tcd@8h0SO=7=-Xv&YawsV2}M3wn3FPeA0BO zCUd!bv8*Bg+w0(U-S>>Fd{6O&eaRR~p0tXZnqqtjq^_k>-@)QUf$bU{A8=4`K0}>` z_Hcjm9%`(-C^joSv%7)6c(1MlJ;brFVZp0iEo>K)L#Tq0wB9}Y$21muA6s%a$Mnx6 zu)IGFaXkO50$+ZH`8$)ZlnPqM21?c1(*EXS&EkQ z*$sPfIFZ%jpbQm?m`v>3ZnqM*@VYxrzAKqar7$KdIf}8sKLQL`Fh}UW39wl{aU-0( z5Fz`l=Zz-w)iePhf|-Mc=^sYh!+w`u;63`^!zW!F!j%2Hi@MI?f8O;*KvyI=(UxE& zNHg6g&>7A5LF~nfsx> z?kdXv-qtrN54F z9VE5-E2I4?jzkPjSCn9`rn76%QX|LbvT-)k(()+|YI`he_vShN%rtiO`D12KGn!WtSiEAh^GTgTcw$ixABpplmqH zF2uE=t#dkR(t8r+072|0W^T3rxcZ08p)}E`;!8n}=*{rEes5$Tb>f6xJcES^y>PK1 zSSxk&HGo<+{Q<>ie!;4M`NLm)*FVXS;3S5~@(;o)W{)ED#Fc~98pPNos4+PO=zcQQ z#062I+ImFa$WikG6wcfP36hI0qyrt1Tn*ieBbej~*X&v)$i@hsS$-6JXX1BI6fNTj zL2d_gA7u;YSu;NPiOK6LzG__iOF8z?di6WA)QX29Kd-hTb>OsKsr-*4d1*IlD9UbC zshw83Dg1KqX4wpL^}@Si2qLf?(RRm_op9&lVFpbc>)dPihI^0=hkEC&?#4trRrg@zW1bDcZvkBz_;3grZhae2=Ld!8{DW4A10-!?#z9(yfEDKt}w&eH@k|KB-+VMD_+o zB=OtQh`H6&hT3<4D`4k|qHni-w!9S_^FSf-DCWvwyf-Q#k=NJ?A<3FIef-74YbWFZ z`_|g{?D4DTPdaAxr0xQ8?H?Vt@nddsElo=4M;w?U*3y}6r@h_4NtI^p|Ef2y8crjazxSkC$L9~n6~wsL9DKYWvhLlm9u{>G7|v!z}22d*IJYv zl*D-x>F6?38ySVnW-|;w5!WU2Qvx0G%<4GBZOvb!=%Y54=twP}>wv7^WYbf2P`E~J zM{JPF38))T>RGU5UusC0EN$7@0(XeT!p7fk97l2M78+X z40rfl3^@asD<&4i0S-SUhpCwfzg zMN2H&Jp6NXe-w`9%bR{3>>7H^6RWu%EakexE)WY9%VQH^@3ay=Now-KsGvk7x0wYdd@gkvVith5P9fLX+ne{|Pte0;QQtNxAjCvXsQeIwdR zpvY36Oy^@Eh_1!8qKXspD_@T{baQDc#gd(^5*i) zlS}7x`~RU^>3}(Z{(oVCO0)cJrThmM-F><}C{Y05bjx!%D$c92{v0pvI4U^GQI-JO z(13^}rXr0ot|t{NwgWah?D7>Vc$cSxW+XAOxL3_I4@{F)=viAo(QeLp@(3k%Se>-%!kP#x1 zGdR4NgCgh=56L$xv_QC@n({j?9sO)otl*ZXfCQ#nNh-2D6kzNwhWR>_tY9RPtje@p zmEqvuFwIBvXVL4pRuirYu)>0=?G{9dNE^I9~$~#0?U_ML=H==87j_8Xa4r;%

6n36zC?r+XWMW-lvyng9`AKshZnM=2Z6l}whFc$dlT`Wr zLXFnc2%@(O6%bH}&WhDITP0iZ2RE-78ZR@-h|Y&0dw4`bO|(A-T>E~%RXu+S^ukBi zdAwfo1V%Zis{vi~LPl1Dz9r?nj--i)etcXA8ak#%dC#)6r@+mj8g(9Ml_@8*#pOmg z_wUhTTr>WYvs&v>my-`$Gp_BeFck>sP?83{n zLH0*w*lG_lU>03lkt1gDGKrUSb%KGCK_?jaX%~=y z)1e^cd+USad$H|CQ%%zO)XwrtScoBAmx9q-IDWzf>~_NO@{?%MzO3T)y>a`$f6&O9Jcza*p{%nD6Vr0SEV~YvX*Zz%_j9d&a z_mqA0rK|ci5#JhctU=j$P47Y0Lft`;nFTswDDEwDu--M(Vl;O$n&=36{Ojioy@91* zKU>+2q3-7WtUMCvpg^=EW_^Er}IV2;uMXWv&zjxh5MVQM84S-c61!Y@Jxa+%BAZx`ucc%TN*-p+Hk&xhFoG@JWr7S7zqYGdh z({FcMjl|QdztbBX*w7jy4dK*ps@<#ui5#jXN)9uER-wLV?Nkuq!Z)hc_A|ZV$Kblq z*hy2;`I-BR51l7##gX`(WkcLShD>y;BbfY@?zRoI8eZkrrAJ?>pNU-7i@lwDri%Nl z&{>V0mq5ic5d0dmUxTxMs(=0r0EUWaiiu;q^a?x0z} zF_S3G4=*XRlAkw!k3)iG?3Kxk=l>+D!ir%_;3kvDPJ56_>Gn&B!ZOC^M-HgTchm0v zo~Nbn&#W=1m=f+=`^B0*CmO=9WyKMM_rezyS7~^o-uH@4$ZJTS0GhG?-ie@$4QBTPQsMk6;Nc-&-aSF5AK- z$OhGh3klAiCf4P>bds~4NC>SwBr`p;)Bb&91*=&`xq*lpDMhA#Qu6J?1g5)>9F!~i z?wO1SMFs@Je!U`5B}ja9Tmp}ZX&4dsTi^EAh*yM3AM|)AT*T?ID^Da}j`wty&%RUW zA|?qFdy)t&SO?ybtZt6QgO5l}0S{Gv7QJsha0GRxRW3QSB9#cn4uV+O+?WP%$OtkO zzdAtfu6%eP9m^+{(i$u4LcJ{LEh;;7&HlMTe&1o|*oO6BTOB~@S*-i@YoP7lu|d># zNci`n^b@@QcPyTN}%>_PsW>B@g1gEkdFpwL*`#5NCLrH2^zf z*6;X8$_W@TwoG+$mYzyJ?Mr?2E5mu;;R%VoI#6ZvoHj=Q{0_SpS45ZDpDQFw^}%z@ zfdJN)Jy`7Mvwl@S^NqcfZ0hHq#n@44<}I?UE@$RFc6dVFO!v%VAzKwDq)$>E04L>% zlyI?GtvIL$A8h!K?1Tt2z*C$)^=}2Eq0EJ~?M^>0QN8@K7S?ofKsqt!{JriS^W)b@( zZsxaHiUCH{NV-N}6Vs=p#VkV6IC8qpqmJ;~?|x|46pV;^l}4NLU+3~(`=Fb9f0+pJ z){YkX^2oY^of-T_gJqz*@eetoX6C#mZ<>HPa%>j#>*nkNTV3lT0AAWL`Ovn zj5fDIR+}2pLFacz#uak#bRwHpjAmD(r_2wAB^Tf76doXYw(6IQJNn)@+4~0jbMMem z(?c++?xRArTxU$X4QUpH9?e_w-L>J-zaPE>5fu|_b#!Gk(|F>lmiZck$n+-wrnzk%^!;ZV=+TNL zsKe{80C4_yjT9@GVgA36H115QMfx=2aewUm&HHn%yyj4LLHe)9lj#;g&W!zyQRrt7 z>Ji8bOWGH6i2Y*S=gn6`V|_@qlEZxyS#j*PQSLiBT36xe_6BfRYyg0hoOx`|#Z<+- z>-Qzc-LN1*Gq6znXO+(T;}~jG#@}S51!H+?D>+oSHcbQ@Iv3c3KUd)3l?GC7$4Q20 z_Vu~ebTIA& z%9>H8XR0Pkb!m#ZoT$^Q1E+x%OYw8YiX{6g)~Ax@xDnx2BSa5=xbd6>})j@nw+Almvt# z7$0Xkubp+gmoSSzrvty8qQmg_muBhr)C%W$a>^hUOagf*cQvJC!I_9 zp73}WbOl2Ew)!6xR0&#Jx*5S_8y;B~D`+7dV3pYK&rTHcywGQkz9!XF} zw7EYm=Xkp}Kj{lEU~a+90c82sZyo0$2CC}V~CI~^tdwk!1 zanlW)lqO@Sx{q+nVi3W^DK+q8OI}~f=bjgA;Aj%qFN2}TyDfbqT)e#!L+vb5`UhvH zi#;?V_b$$mr%C zY!Bg0T=_4j!oeWWg!R*`XV_PnS~5)0Hz!~}YVXd%2&|7W1z>(!UVP`vIZEZzV?IYU z(e7rVaR(@cm^&{McOUfGX`zjhj1E25{gf!1VE_sA2&yh_GJ1CyFrZ$^GczlogOD}A%~nqSAdO$6?R^#bM;tJSVm zA4xZILjF=+vN#}u`-7;x!XQK&2?GoRt|kO?oKxI?DYDtke;whJGR-Pul$MBW>$UNo z79?V;y=r16@jWTyhJ|SXAO?)w4uav|zQuLh6Ofq^7ZZ|M251E&JKId}UMJm-Mp9bD z2=O-QK`NPwEicW8WFaj~W8FKT8{vW{FGnXR1yg@lGs?LhS(@hjnk)c-7X&E^yBn&RoD(o-O8#4-8CNSZ!s@O_KqO(Dn~D(8U-XU zwulg(-&KTZ%$VP5ERd}Hirr6C6fNa(D$DQ$t^7?Y$CSmN`7f^CL0J?nSdiSdZQHhO z+qP}nwr$(i*|u%l=sRy>I;Q(4D%Oh1$^^T-{x9GSP)enVQ{vqO{O`iM{24OP!~5#0 z5zdL=v;^n181+;gcRS)g%q&nvzS@Vg2Tg!H^o88LX*uhWE8@5V8 zHsVMt?D93ey1<+j(&&18TNNgNJhE>cG+EVq6`Zzb{A*#V4>x3^i1mHv94z@&aiRcc zLgiRJ0@j-W@}It<-dSR|88TnY-y_msgfwux7RHx!GTfp%HB=C_ z9byzUg>9(Ujh_tUMhXjP`NDU1RB}0e0zpHFSD><%5F*EB4{^G@EB`6APa9(ued6I8*3x$y{Xgi9u$3HJa~l$ zEIQ!)oIm3bc*8-(zYgLISvW4OWQGx|P0SUeh{=fIQ#*v86^_u&)c~*9ZUk39E9W_? z;zs&DB-LELAzM+k$+NeGj5GaJlUt&vK0X!%k|kD8`f<~b#<_c-PS4h_QiJVz_< zJs;M%2mDS=;M!eHS1!@CC+2ttTC~Chf!3@$f+)xvMM}F`HM~N*(1I-&GX{+u{H+yb z{Ba)`?CIKIAR5h|%RI2vop50;~8In<)KZfwwasJpW5SM-)hfe(_Sy8Ytt%*z}@ z9acN)2Y0rwn61>+Wt=z6)?rqkfWdZZgqySBBv8Qj&-jQ0pM|2_4(2-RMa@dC-}38z zS)RQ_{8JhZOs4KW`qcnBJ!4(z%aKxdVQhz7IN4Zs>CZzFJI88l^?;_3cGcYul2(`TXW#wz?{je79VV2&gcI;TY+pPD1`5MOUG<NrJg1PJOl*;2!Xi*7EzA(IxVc`O{lq0XUefe%D(q%gu# z*HrRt_i`$Wbq(FsakRo?Q47{^HCfDG2@So<;-_*&P@#tZoTLVhf*nwdxj89`v8M9p z#;=ez%!TGX^{#gl>LIh_%0p7>Jn!G7i{lqoa3NKt6(8sB#fn)&l;Eo)HUYPkkcu7O z{#1K%{-hz*+e82oc*W9IR^v2ZUU*Aj5rL-R=|XJJc$#s3;vhJjpHZp8-we*}F?_Ro z|J%Ag@AZ>f{p!9?F%u_4IS}A4(8TyAhoux$b^hW;o<&&ac2_;<1#X7Ok%w++_rk%% z*eV-&mMN}-7*vYA-xuAz9qt(jq7vwLErIZCuy0B-4UBJqQvl@wp8m^v&Rg&qbCn&m z3f1i_g?US)rwzV6WG?S=MEBtn47bX7=Q>Mtb9Tk7Of^PqK}F{x+8U6C&l`olLP!!l zZBLUN{ThJ5*pRtR1=Chi_d~v6neJw~M0|kzc(FQ_M;IbBPAdOkrAHWV-8bqfuPYE4 ztqh@!WLX~Js6g$`NV)SP{jFSFa7VRDWIf+u_Pa!ti^GBtB={}llaCy{-~o<;a@JhK z$6`60lL-T07!rLfd%QJ%VkSgbWiH~Hsr&a77`L&-NoEH=O9=;v^n0Ciy5iD=C*zM5 zPIo!&H0*DY!^g$uatSLe3abBAt!mPhB|H|opFz1ULnUI&6DibHhPA!-P(s@O?kOHm zfN6ulT%Kysxu)tAs(&Y#CRDotsk)wew;JS?f5`7t214L}RkL#YSJskf)%@Mx0o_sD zv+0hp3~7FA^HpAM!CI()xrV(Xc#xslait_^WVMJPtO_dMU+Ufkll=MwDZ8HD+IG zX}?qIEn9?<+BklU96K36FfEBUfl=1~9an!KVCFO%cjiLRI*9myXpD5AzbF}8>P@ib zoX>fcnY~6D?2E3kpf*PLNVx+Mb*UIakNZPC2KVGJ2p}63mwiC-jEmx0;?*s+Gi>IP z?5K<^3!W;(f~4Gp&kNLCu~NgH6h=&liG4d>O5tE`ysT<{$lpGfUW&e1+|0$;XajD< z3G46f+{0u(*Rcy|4d&v9J3EE!xLuOD-5OZGu=faepiih?@| zzpUsOX3qB7!?*I(=Zt(!GkFeQiaV?AlY8C4gyofL ztSy8IW1)?ghi<6u75Q?hF>|La+cA328t8{y5_!+^8rf-;SjOgd=3Itoh~i3xsEG9*M69QJ=zlpwd@ITs~Il!rk9JjxG4FPYY%diR+$MM)w47Q?lq_}-~!Fc>G9;d0I zk6|Q;9}NYLFw5TzXBr=HXiorGEjTb;u$$dQN}#(`JdDxA?AaT(Hllr*la290unWPq zWDuI^a`#|j*Cr0iTw=WU`E?GLc9VWYJ672bf+?6Q<|r-@Wpg0=fKI8nt(Cd{HO7k98YZ9ZE0g>W%nk8QxDblw;M}->Lo-{AOFcaC~@hV`wSfG zl*QOuq}KG2A1Bb(#4}R7qUQeC^+K+z1GyHeH+4CTd#|$qX7Oy>gCn)otQ7`t z%+tzI>Jwy6x@@F#7>;0qUolD$#c~k7`XUSKe||fX=(F7({i5wY+C}mKT1TdQZdB~e zBw7**U=W#U|H&^iwAMF#RA<+n@OXVvGC?;T1=ywNTQEcSdLs}DDQBpq+})A79>-o3 zPBrHKJ2O8xe%33-6N->s>z)k&H{dXeAw#PEDjYwXbF<{*P$`Y(xp4&O&FCDI?Upg{%6HTU*?ECE_EtZZh=^C*7MY=1x<{cq0?o9imJ`h?_J7Tw0>! z2u_6)e$dHwE1X6Q7_$6^HoUig+X%jsQ5^1>_*Mqt+cIe`)HAS|jK9x)$v|;sJWG6d z!ibePP2RiXFdPBBk9oxc!%K2w)sM+5{A6T9kAON?zDQbY%tc{AmszC3E8FntAV?0t zvyAzT*e#ec>h{BZx`GP!DAsdukK<6b*^-H|u{{uT30oWgW+_^r;BMN>JT)5f)s4Zt zmYv)1)0r}JGWkku+FX2^%sF>?T#xSFRvqv+kAypfT!U^y$X(fzzLXvx&^7HSmtHgJ ztDxsndQv~tc*=lNXdUOIcrnblC;-k_`oXW4&+@Xz7UlkX@EujoLI1Q60XjroyQaow zKG(*2ozhgr(UNg()$zyH7-b3P(5=5D){r zih-uCL5Wr7Kq}=z6K6zq?dpOT40Uy(siDW{RGj(xAt9l$FR`kBHq5+U{;K2bpRy-B zwhxR3i_AI*py+?mIc&kau>Vb|O)la&{}V!oa?i4YL7=gwk}9Yp0Nluwj&MmvJ{z~q zx=CRll{O(vF_GWwatWxRDxd*`Hx{ODQtqR!#%Qe0;z>fc;idpnQmaIO{&F7)x(<|$ z+?eGLhJ{elE{6jQE<=l4K4VMk7?fK`Ym{yGw2t2}{aHMxStR~%0<9rn;wM{rQ>V&< zoD-}IE9b$lbsDt+v+ZBmLIh?7S5lnzsqBC`CKD~A8H(;O+Iz-E0#s?Ba4(u zr&Ptlq2$i9KACp{&G8~DcsP8pyp{LRmaCoJTVcV!1sfGcscc}sr{voGY zxMpFwqH9j7^p$x@DtN0SK@UuZJt{we;Yb8eLMu%~Bx5xoO)_ASsZ$1P;9Q($Ho{5x zstsjECDI}F1s}QdX-r9qmWLP;?xY6Y6ymfyz_4&C6bwQOv@|gzk_7Q_^z)GpdQqaV&>h>?kvC9r#pE3M^B zY)=9OFIQ=%cl3pWI!fvG0;RsB&b2e&XHIg%b@^0NbSnZ=I@*|simjX5ff}1HY0hW< z#I*HCIYD7F-s|mrhNaY09~1l|U{GBlzrd^Hu{R` zmjD>&Z!C)fyWA2R0~{I1mSk@$65_@VoYzvofweO<-{dZv({1g^H?F$egQZ>#cy#ap+AhsK;t z2!6#C;!#c*mhS0Y3p0$4l#gKvGfc?{iq$Vn6bq7k zM?~5EfU(EhMEBZ&Jucme3U*H;`eM8o$7UATQxE5{)$VrhOK=i3!?|h=2*>GQXMM(5 zj!6hw(!o73xviCzE9BJI7dcr5CzAFk{J5O+TOUd6m>xTkUpWI|mPYuM=RABhYhxB~ zLTiLW54w91NM0~t9k=tp(!oTc4{gaP(_E${+bJx zG;^j?S0PB_k@kWHear#~@X#+ew-Zl%Dmz$8^9ebbXi0GHnz-OhJB6`dnZVDoizC0S(v{4C72`0RvgzX$ua6Qm)Tz>)h*~KD zm8oCHnAObO8QqF1yUY!O2_3g<#^|1lU+IQAdZDvE`a!;RbUM}KKEOdl?bL{`UKE^y zpJlsaYU{sA&7$s^8K8YB3kX;N+)4lUc5?gY0_Etq+ zE5wKtp7@&K!;LcZ_7V5|j@WKT4jY=CKrZ6dhxkP!9DRR~mjdjT)|ot@vj3Vc=181E zYdij)8yH*E#m)%lGt9dXmh~NDK|A120FlNygqSg4NUfY~2Nx$c>4%M)FJ>*?`^PHx zE~=w@{)tTaC%t$@npRh;Rf2SHX3{43ozkrH5LC6;;S1#?g{9!ztY;%5(KlqFMaim@%y+}eR zJR2$tqYPIXUnm^g|5&2RIVi${Un|0oz=hbC;giHqpO{VCZAjsPKr*N0aTk(Ykywbh z3}TENqE}WpqM~hH_`@e^uw56TI!I%m)vdx<(8L1oPJ}TF8149P4JlJ@8x=MqPEkpm zU|lA5g7LPK+X&IMBL|qUZan1McemJ;0ggWI^v%)0yY;!pew{M7Hc^N?6EHYxnW+LL zs+0+D%kAEJo_)CRUxyN_wvGXrlxqbCAaJadYn9!bp({u7QsBoOIJlR5R2MM|y= zv|4N^>pvFn8rmjVF`^=-9@f)tLk)MZZ&p+!yM($>@422uBCN-#Lxt$_2@~A~b8e{g8d|q-jB|3kaiwn;)IGhthdd9b;S<{*6H&c*krSzE9 z6mBqOD{bhf?MT3Kq$P}NWQ`G5b(-6orLE@YA~f|%W(kS1==d>ImoNUgV;Y;zg2udrOA`N+Pf+H;A~< z5=Q3vvxUA|Y?GefXgL25@r*oBy@$v;)IFJwmk<3)S2)j(WpA)YME$~z7B8B%3}TFC z>V3s;*En}VnYRY^II`Qe5eKmKZ&b)g#l@xGnR;`v$SHQT@_t~ zi|J^lG^a=$mG6#Os8S9-0}d<)HUgrRNfdxsjo*AHaB1cdAs##CemT{Z6No1o`{~-l z`D801Ri+kOvgFXY(*j=Iz|W?^u_I^Iq=3aF^vGCGXyh1RxxS{bK{j zb14s&Lf8*OmfGDOdbF#rEX-JBML*>(9gTx&<4~aL7-+!KMNG3>^A9RIcpBUemg}B( z!EgtACB$2e=s0qwQqh^ARW_CH$V0_o_KYtYsJYx_KP44M#Lf3KwAl&RN>wGHASS6JVJq#-Xp)tltBYrLE@C9`v(B(ndlyohv9|YB zlzx}VX_8;=$?{r^)6BI9Rug*a^+T8%foy8Yz63yMrH7@Nu?83cijOq%v#bqk-RcAx z-LSgDK@nj8ck?)lg1BVW^t0OYGgE=&OnNA2J{g_hRaMmBZ}=${!nMBwUnY zY5!lBBDQ+zm7M7mXOXVo8`KRBu#RV0Z$)h!nYOW&Zt_v$KHRpP@EZ7-hgE*jj_P!+ z__LwjSpf9W0ea!^t%AL2Ewtq-a?>Mn5bxL$%Ye2Q;)k1A4G|pO`9GkO!u3Tz?7wN) znlmN{^hc@D0T$YhbD)!m493^uU8)(LU052D_)&K^|2}A-N&7Z91Wh7OyV!OvfPL^6 zzS~|>yQ$WTR2RqDB5KLUh`b+a=qU51pY!`Dtd_rrXyT2tAMHEpT+8}1YOPD-dz>Q_ z-O{7qfqK!aPGGaWnZ4r_XLH+=>h=kMXdMVrFpt6o)VX~J%Y<>PG7q-MDrqvmcmJ3@ z2Ci%I{*|U5^B|A;Ilp~b75Rf5i#Aw4_U~s>j|?s~x;X^)%4VKhUvyaf2jV=0`3om8 z8I|3nP<#7PkfOPn81oY%0==lVlcFMx1aQ);Y-Vr$iI&c-Q!)>h4_a}g>lkOEw z5e16VQ?Y#j>>B>f#g`R?u_Bv^9dB4@`unrdM_CaPAX631vghP9fPRo@Ps4*k=mKww zo9xY$r8D5R&1r%voi$=0dF>qLMoyVRxm3FCbp5soXK!ULsPmqT*e0y{v^6ad^rnehhjY0fmQ92{Nz0U`$q&K)=~uzm{COcAD^%!o2lA{ zn4tk%1)>)HoHaP6CDeZt7CSwW1&BHr-U%DFs0N~s7B%V2!6@S6f5HFxuJw3jM^# z(rdmWsio;)jAh@^(kQ*@q&PdN5TdJhrOH)*Zxy89Q z{M7+!7XapsXERauZG?S-m&P4Pu&d=EL*srJ=yw%e^_k-kYzxS)&c9fXP2@9hOV4i zI?*!j=cIvOo%VX)chTkMbCZU6DLBt}xC?+-+zngMwf%;tD#ZgT#x8>u(_udok7|p` zVh+m>m7+bDrc8^)V~Ug-6RYOVf9VC(G^YMRT=LXzeOPMavVV`=S-TadLh^6@CG)6O|K%s?^1p?N#EV3eFC`cu^Nnz__vW{ZxlPGyeWB{M7i6fYhp zSn(7A=sU1u6%9lNY}@$sIYlfhKSsWwS4ws6a>;5|Th8W4u1b3xgISr3F))}z@~3iw z+bTct#P#u4fen+-MBTyTPvY2q&Ga!12T20|E7Z-8;*oj6x^E#qb#{qp4{c9pzY?$` z8n)WPW?VbY{w#8Fb zKSg5TGWVspe?Dyyf795mgj`yVhujf%Do84rHbM!B%~Erz67w4`x@Sow61--z7lGDpRmZM9$f|?wq&D*K7zrMb{bjVKKMXhbKhVl! zWbHD02?198@9xByQ&h*~ZqdWHyW@h?uZNAcK79DlS<>;he6&||$z(Wy)*#*>(#XVK znZwliBMHL=^WvKBB5~&;(@#7!`$anjy=qE#UMUD_%Jeo7q@`Pb%X+4qv`$gkjB0<1 zc0kq3a34i!;W0vM8qhNU0JQprF2chCIdZfSM=QklCuPC14yO$4N_f%s3O3??3a3&? znD?i(zhux{mb`Qm5>j-HRvPG#TS z_&l*1qwX*e|6pk8*5QAKtm`_Pp6bbp#yltlpgRBnD!gD;&HqJ0amKU@D|T6p+Q}?I zk9EB1#%g$wX08Je?c&>3d)`T`1XAh#ttQ#jC$M2LkB+&l7*K_orU$&5{bSCMR@2rq zN0Tmg4df{41|cE?nfv3_WEzX(M}9^j0ef8QC|fkC5I`0pLUU*RLqv+2pg%}GWQjie z6mC|0x95i9eKptHivnMH0o?*s&x%)?WzB05JCXr2BtiqByt)`TEVfS<_SC5*b6AGi_8JOKMwRh_lM<8=nhw7JPD9n}hbf(*V(Y4>@7tGb1$!gtd5li=T<=Qk{flYig>!?OZ zSXD&r8^d*n|08dv#kZN-+EGSMhpd%FLMGQfpEuYr;;X|d&|j=X=xRh6y-f7)D0s^1 z#>F{({_H|Btf-^+TUXXWm&|b^*B=&L!s|pdCN;EUs{fHO&DYHiOjY9G5(TN!%JG8G zkM9O!nVXAz>sxsXD#|_h=RNq>q+%b^F?1+|q87fi2~zHD8$2 zN-8jQ)23CKSV!8W^_TbGG9`jg98Jh_hF|*d#7J5^)4ZDg9NlwMLQIL|_&Gg*d5?jK zbti)5=FuuhvXYYeNNsrTHZ*J`(dBsAZJ0?LkV+7^w``{%_-p^~+!iLuRwTbi4%62< znm}7L4yIqjX_|TvARo6PXfQfcYN6bOcan+Djr)%DO^e&bj^BA$ZbtL9O@&P<5HA%Y zM*k{`J2`7HzU5*Kp&rxjRD6f7#J;Sj>x7PNV!SmPsb6d|KnHM{6nB)%N`cx>2J67h zU=ipNL946@D|LY%#>5S3)i=@&Q_F!}H7L+RE`*0L^zWIUT*;n)ez@O7tU*Hc3`Mk0 znA~c5wXpsfefeo}L6-kt^d?1sv(?6FN$a@`Uku=hOR^5`Q!26Fq31#z_%&s!#g<3m z3YIx2-SWFE6>JV@la~}nzU%uP39muuz_QCNHx&3xq}l}c8e1oH>j|J^Y`4snq#77pU}Ui4#X!hqzHKz!JM2LMzgERSHr*#y#E5V`#(CYgsGO&6D^ zz33uSoQ%#1?;xv_D6LKesZWrOZi8bOXfOD{Xs`&An|D^wB#FdOa4BGNp12rwqStD zH=Fsv${5xUZmo%#fo%GlaR85`$1o16nMTca96H1%XWZh(DEcr?{2dQL#(zhF6Iuv` z9qag77{^M`T|5X|Y>P4GPp*`SI9-ZJO{ciVu>^$xV_o_qerC zHHJ6uH#K@DLPozEQb?k9P*>xe#TrU10Q&W{fH$F%&JJHSL2GZu%6_Q-(N0N1Ju9&DN zozl?f^{yVw^=W@0I3&RYw{7%zZcqPWU>$qVpj*EOYDCTJ8L{e^ccv3Rz0i%6ctQs@ zOHdB4T5l(qvtpy+ov^VvRq=JI5AZxkEOc;h=flfKZ!(H*)+aB_c+nP@T)3?g$S*AG z`;aXJ9zewr^oC0?5A-nlH@wJB7ns}{`#LZ^SdKNb~~FrQc4`*dsGV zHTS1sTdkRQeXIpIj3#YguhXH2c)gY5W-jhB_w4)~03_L$3)@9vh>=|q4(J)I6$kx} z?#x%F$gB(FfMLYD^xZJ7mfBr{lojVp;p^20%~K@a_OJ$%BP2>v7Gp!IuL38^qx_JU z{SEDDSk7hN2=T@;2H=I_<---;KJ+cCtzA5sfjCS_hY-Iv{%l97wvkFz-v99jafdc$ z4f7#=Nt_w5SOQ6NEeuMK-JBf(T4c`Fn7>c7da0h+^-43u%T(7uYvlbD8$JY#e6u@w zfL@9pORM zzkwl&g@I49$mX_?t@H+6Ix9x2|^ib3|DG-cxQOV8u;mA?kT+rH^TsdxC|5Z zq4c;DMK`6Vuuj%nZr0#V& z^g;=v+KNDU=aBr3Cwj*;@KW8EOL?03ub^4k$)h-g3ngX>5g9VWlrE3W8F$*=-6xDN z%}1u=ajqo<;VYLO3|Os}pV*P|G5n5Flw`?jQX7#Xo-^fghNElzzlVz?Jqa2wS#GOS zBzw91m{oHqEoUP=K|6OUg)X)8x-fs9>M0($3xjlJY2Eb$3V=6rp3SU}lPZXHl8pmE z^uO>}vMBG8R5eKuv>Zz96zh%5rx_7=4wv}rZ!vg4lv0gXSMn1x|a**RU(M@|7=m|NaMY@>q{)7Ymnf6Q2{Lpu%N8|aS`NKmL{Y1 z5WOg58b_LJG)p@K9pjN}-<^m~!dkOczVNbMWFC-k z1`cq$GexK4!)ZjjIJUYA$NgYR@cOQffC#7vQQOq?#9~IR1KVSxdl^p$lIo>F=3s{@LK>lLpO=Dg&i(G`WV++AxCoLC5!%`$TN;Z2l5ZTVwRknuCd$8K(I>)iYR-JJMV(|d7 zK3k!Fc{=7CAmueM_FW53#_-sG-37)(bIS5i*WkOM$*y_G1kQf2JP0IK8A(mlFK0^k zQ8DYL*;!jRlFxE7m&3dcS1Yl3Yu%~gF&DAz0wr{qk0z`K8*0m=r8<140)zg??>{M9 zv>%F4D%fXK?3Of_L`vBH+I}e_&nASRbBH1xW85??-x;bzZwKw?{`S0pQ8gdmcKKVP zk9c5btCY_FEE#wNvl1T~TJa<1;1wFX#L#%M-I;GE*W?@DH)k;r<||j8t9D(>Fg0e= zzzwkwa%$Q|E7!ftj{lj5ShIC-i(rg(6j#Oj#)O$=6nQSN+pm(>)?p}z5T1w|ie9hT z9*;!1oa{ByD+aKO7h!W|BZlG6RPtDMyyB+gwV|>vDH7-~ePmaNST#Yk9cYU#s0nGi zJk!o4=ffhxwIDo*bVJk|qSci7%taeNcMtxOVH(Ya4!gc06oA3&;wg)GBy;dVWeoi$ z>xekac!qc~*m;3sT_~SEijfG_k09JKQ&`Ufe6 z@4Mg^_7#lb`0nJA5+0lrI{E3+FSop-WS(-y@rP~a5sVmq#;VVi03JmvW5N{-$(`a$ zCm&?-zhQlNCgZ5k2wPP>uc*ME@oV#~t&C_ullM}4OTZfroH6oy60WCccK&D3F*%t4 zTXzZ?%nO&WXyyRF3?2L_PdPN2Hg{2Cr3p*jZ0<9~p>*~apVd@Ygef<{buo*U@Jk3d zYtnr{$8@L}r(y35<|BE)X!MH)a^lklozariy8QW!VvbqL?qRI@=OzITov8*ihIah6 zjG7BQMQf}&ndnNU&i<-i7}5X&w^ay3WK1kH?lVoOW(_|stc-F#*&Z%{v6GW%bqms( z8f#xi-WXW$-d>qq%4xx8KB$y6#T^>{y&D{!42>%Q%7EZpx>jhv#NW@2-2{<0 zPBCz9L?ZrL=iU4B{>tdMDk7sGL8vEPz0)dk8NgT(A-sOPYsT*onr2>?N-WV$Jw*$6 zi5v#2!2`L)28Z2-RtDcy@b^oO23EMudXa!IBenYPZ2V&8Dnh{CAEswP@G@W|_*k0c zl;7@?jknFW`cm4>yTWJPTIEYPk_v~iycfH3zxb_DR40M4ae%-PI5>bqDUSVZ*^Os& zyuW!bEfc{!z(xMoRF6X0EnKj~Tu*9mgAeR{O5D$uG!y-jPvgoCeRQ!ABjXARZVVp| z9)Zv(PdEY2iO}9`XSF}WxMM~`$e&Y;`Pk>(!cFG*JmgH);HN^=c*kPzh6{sflVL^P za?#ii58f4$(Ng!iv=!djRc%1PjpbVdCmZ~G*$EG8Fg?-4Z#5`Ei7qfwThu|Hk{aAC z00^`=faMwoiH49wADxn5jw&wFwRZa#ig}%`Ok$DfCf>(hx%NsoGI9x>Xo^^^dkY6z z>!x;$V|r7Jm%6E);S(nMXTTv^MK*GEJM@FLT;*P$;C22&ti}j)CS%BtN7mIy4~Ic; z`G|8MXfH_{xmTge*?|2NAo*sBoq8n8l2%Rqq#r$k{1{Dg8w&~r|gAi~1U z$C5g$!laEeDKnrzwfTVT=kH%F&F4a*bo_qDp(Ar8a8wFlGqzD?um~}cWx@IT;5OQ` zeM7>YdvnuR4KfCPMP%=|gNR>} zd8C9ow8>F|k%{FGYv4;Lysfs$jC^h#-}Zow+r7V}GU88;LFqB*H;~~xhVkCTr}TJe z1lTKNVRW~b1H^T@Zz@}y9K(ioFfWSipz=rePQ+BR z^Lb2D+;fp_rjUa!U|nq$ShZ^+<6WN}$4BLz=m1DkgmSaN%F`9Wb)3c)g|y~9)#0zz zigIuuHfqV?C5r;+UbWXjS=XW$hl9g@vlsu>@;SEP+1<@my*_p+yiY|xq-Nwl)g>uN z;$FF|o`=L0lUbj->}%FUq9W7?ENXBPWb0;Ax#y z?Aa!}DV@|En#J#uaEm$gYWo^(N`Lj6vlPVY-1wU%?#mD%$~eC97;nD0#Kqi$OSrmC zt&WJvLuj9bolt0Q{(C4k*5RJaaV`Mh@%nx2;1I@q+&7Nn@~sZLKsL>_8O_(PS%Yzg zs;8gRMdO+yg5c;9O6*|tto$O8g#$q$A-)U zx%~BiQDhJR2p~%ny_rZ-*5$u5`41+P`**DYe}g-mudV@IhpUodG(7jV^^Gw*#LcNg zR3Uqga8AkzxB^FQW=X^wwNcooy2Y`~h;4{mZi0BXqBUaJRVIkH_K1gmc_qcoon94m zReN?5NOdu+9HgXJE&=VA+OssT&L*1SE>^jXwJBmRMhF%{F=BT{l2E_{PNMFHABl@)^?z|NRxJ+x%|K@nyU;qHX=BdYA#G)FSA2oOKeE+0VUO+pm9XJClKc z@BOV_HqlLLn3xR&Mmrdh&33%roiC}aWsJh~^(P>!B^4iy(c?(q{Zv=gt^1w9w>A!T zeZr1UH4DBW+|VR3;Rw*Z;Rm_q8MR>r_fJR%v*(WvU8oD8KY3FZqy`*wbo1o1nXy-_ zQ89uBdt(y5v7OqWi@8^UK8t+mn@4O`97zAAPPEFm(1N1p(w(%sCM(7c+`G22!-Fdh zkB@8>;VQe9-+p;?~Vi$!>fkgaJ;bRGKb}1YS~(%z@AJP1tx|)do|cB>DPLaAi&uf) zN|%!(tZ>(6AP>U=NhX-n&|L2S25X_tU-z47rT)IgBk@|CJDDRs-URKO`XF?qrZ2~qa^>iQC1DI;r z_Hx;>C)*A&SCj(F7Fq%0k1fZjyPBG^12583s1cjQ0ai1(k;Z2ViCk=Nh0ns60f>DT z&x@v6TkdvwysdF`x;PtuDZ`G{u|YVlX#%~EV)&RDIE2RfVzbbB18lK~W=^EisIKj? zEw_TUpBv*rH^=MAKMpniu!Xs8?_a=LQ;uj;!+Jr1lJhv#tg7=@fjNAJVUZDO$BiEZ zoYJzKkJCTXH6yzpfl` z=-(y}2R?i4-nanz;L<>NtRjAS8pgp=WYt@rG)?hGk*zj6mgFfjPCE;Q%tw)pN(|tW zzUt8Ynu8zC(a`=vETq6zBfHyQkq@N`3S^++x<5;NE=&0=5nnYhV38dWv>1O+o!Z*q zxd{HMWZRf~t-|hUmihmtANRG!ooyH0bU@RQWPilBTqw%uetF z5NZkIVaaU2e51p^5IVM!kF9{`rn1RNzGs&EQb)KLU7zj=F-l~s$M9RDq^RMkewWEr zh2?D8uY-3GVO0oQv!3%57*bBWeZJLcGOppB30-k6C&Bf1yvA5+mnD`dPZGXes|jo= zTLXxTDW$uYp=8D_8I0Zxy<)O38Z3g32>*5o3%Au#1)9N2KL)I3zl(QX^7dPsYL^30 zU`e3!@-QyW|2`0(ZF8yDCrjU#BDyI^t{sgbV7=%UGp+HCg`D=knEA39S20l)(S1{J_zR4?Y0#C2TJx2#>Bq^J?E)l$j@upthz?&`Pfjo1 znv3;ycYl0ubmk zJ2OxvI4}UxNoiVN9?VVkYkSZK0akKs?u90{wE=9PRd?bAaQ;*O=xN?vwtfhiHN4Dn z{uAy~O{^;j>s|5rg7;x|pY`s_er6zXF#965#ZEvWh~`0(dHMW+OvfbeECL<|_V4m4 z4>Go6)%sw)Rd{3EOyUD=x)?*AHTd>Rtykg0-VcuE!49VMdszB$*T#EquBYoT$ByFd zbqiEza_0S%Pd{7{+M~O3{?`(UM7nJaRv)?ev9srsw!bx_v1`dg`e`^*#c950i2A7@ zWubbYq-f8@8BJ$MONB|_=kaJ^&jpdiE=vBu8-FD%*Z;;w_F^3z;S(Ch^VGZ-zuW1d z11S`zauobSABO++FSbo@-2L)Qaup=1jU=ziZX+QBJfw3iDVvo~5GXKo_rL=E7crN! z|GWEN)p~>ZsXkn@_tkqAru1)&#r1u2Q889E0V*oYkq2f~bg`qfV4WP)cxd}}2njI~ zx=&+D6VG^0ypwg>UJyWvg+pCgnsb3B>+9wyC2&PhhNLAz2W6$IzppifX;R4<-sYA=j&{ zdhN}fRt-YzXAbzx4wwJp2P~P?*3s@gH&4?edFB;cZKL2~~IMend;jo*{GE8ApA!L_Dm!!(VAG;v}yd7BA1h-ow>cv8?Tr3iAF zPIbOg7XYY41%dC8B9G=S>S(zAwvV+k4PLaB(>u>}W$ zeZMXzQn`@20IGLQ04%v?8VYFajX$yNzezJ9*nq3Sy}Lwq;a{!8btdcUI!p{1l?0I& z$BLrq`K&)0@vJuIR_IV#?QRQ*a@2vzN;g)Vr%S^oNCN3U4G-Bf-mnhLJsxVXU*4yh zH2~!(o#54opyUF)B7#oMbIL8SySH)F9FV@r2v z0NlVWmqu6PL_Z7W4a_CoD@wKR>YHXqc^`r%1uE%16(Ac;Ru}{+zv(!ul-NS) z69+s~lH#I%^Ce#U4!Y;wt-&zjdc~u?r&!;bV3QF|Fg3h_x$aPfm3Huh*&u42a3dteZcGmaSSb!Nal?UPtpzGSj=oMHm;c))i(&5TE)4A3MN zUIsK|q!E|%H)v8V0-QxcX+e~0CyGc4$UH$Et<{3=l^l=%*zTO=VWC^VH|p38`?2Mm zE7COT)lIgfY^@(laiQ?mqJETs;(h#HNHk8yBMnN#j(a5gZ7Ir%HhNBi+#Rk#*}g3S z+tn9N;VuuL&wuA=R_F8!uzoW#A;=aPOCK{pK~bjOBzPW)vN({sKl3NL{3K&t7^&0Y zI|entqPsH|XYSZaOMGRBmM~K|^FKS@>{)L0bZxA9;?JHbQqX20k@zkClA#Y#QrlN3 zUT56S{>rT{Z2o7H3Jid(;qgsc0AHU_9FWFlD>(iiv~moXck%!ALE+?!N8~e-VB}Zz zGhwCzfLqw#=^8hEK`bx+3hI~gL}-^m_B%GCVj$w)?+7Dz(RfvGx)kc9ikVpG=vdQG+t@FNFRbjlLbmZqU zbO2_^f}d=U3dwKc6R6^n8z}uc)nmOrVaIF4XNbNK9J`Io3W_&Jssj+L>bZ)Ka>9}h zt=JU_ZtsPp4muC42LR8OHtwz!I6_YdRV%ON=+sC3J$0g1wlwabek;okUNSKMt!0(z zlDzwZEc_AP|F{TuiD@0?`M=1WA2qInx1;@uV+u)oab{u(V@pFZ&=);n;Pk+h4nLe~ zhJHl?-p1MqHt?ETgTbqV!yYUi3xFyw#ob-YgSmPod$@9%TL2sGk=%zxPhXDo^1}W= ztvOxBm}XFn0C&G3Oto^o>HpUkFpf)df&PU--zTPec$U>1zEVUNZL z{NyB$7Wkm7Cnnyc0`c_jkt&u6IcGzO8)LJQSHw6=g9VykqPHx9eR?LIRI}pS&z9mg z&z>EQM|1yJmT0iIgG~F0nwQ+jcB<)aG+{{}4kd9SEX&rp5RT%<(gr^5%o|ApPGdBo zq6(;u=t=ZtVAUI2?SX%6U(A(2S9iiqU?9%M)o9pSF>5lCoD?Q;x|Zet?x8o~}Yi64tffMRpS~ zi^JR`>~_5NFZqU2;k;VRJW6|!5w#MVdK;ExZ%=W)yB=}=$eA~#c#FJ z6>>S*R*V|X!yr8VeWKvxF{mLTQRAg!mVTumSzwuh<@l! z($donHPH_DCvNW;x=*Ogtt=&>hkCj!dqT zZ4PS9Z+}0u2`v1?KoMY*=T1Q?xoR)l9xOi4Z0?B<(AwHl2DlRAQ}p>}a2aL+9W+a( zo8uIgpj4=V_;&~5%-brFm%Z6vKIhdXOWm$CIU(no89n2G;VFosQ}rHbg;yfA7*##> z-aw9Av=B{m_nk6zx;W?AJ0J|GC>jwMgX|bs7jrSAkfMGDwo2Or z6>mu)&B+%Wp8))23+YT=TQf}6^uM?|rzKGoXuGy;+qTW!wr$(CZQHhO+qP}HJ10rq zhvX*~YGOp04$fwgACT;K#nvQzPIJku*1`k?7;b^IC}0U!9R8fPJGkC4KjZU>o+g)8 zhFmYoyJvFyEjoc-H^hz}2Z({FrZ&l)5Pys`6vHpJ4{!&@IhlC}n5gEki@yNAqr%cC43Q$%M_aPE+Oq&~_W zp6?uM8{3e_aS|c>-5o^HNAdE8ACb@ojbY`y>JcLgbSsRTVzNKzw`ZaoEp=({n}Ncl zO3$wvc|=;A*Jw?uYIhurTzH2KKYuDee#ie zcr;{VpMNvclmejP;pv3hV(pq$1Ra)%R*%pRL(A5Z=~8Kv!hrS-l0a|)Ns7f|%Mt0a zdA6zsE**MQzofn;jk{=$RQlrs?aJd;VAf!1L`yyVQw~ViuPPUTy$p0)Ekp z4VpC&7;*nlhqx2!De(oq!6!#_3^>)wVi8FKa=En#QgaD7LG zlAZ5%y(0x&6I<3eaXO1&Gl};Cx#%~;cyc8#9HBYdq8ZjnWZwHzIy1V%{xO4*{p}$N zukckdV{XA_38CS}n4xf!39AV4q5bsxi?%3)^1PVac_CSV$@Wlsg)7fpg96~-{Wwoh z;!+x{j>sSekXEABIg&ycvO{aW^Aop1RL+e*ekZ=-MB%cgy~#GN*(3IG1pTV`b`g62 zYFTXlLIzVr zOKXj;gxmDS1)n;Qkpkbhr1Glj#+El!tzPXGTj75<;HW&>{sPy;_#)6F>V8jnMPF{L zB=wy*J2&bhlh(k{Ue{iBn(;*A7{ae6^HpQR(NwuA8?BGVu<_g8{Zd}goI%VB66biR z&CmNW|ti^jd6j1vdE@ed$SN@JR} z7dnupnsV*dk=O^8)K5#+X=glOck_-DO-p3rpBKV55o4_L>CffJgE6PX%xmt2v4xZW z*OX_MwVSw(5-v>7*X|ijzF#z-7|K4p%xJ2Zy_=?Equ>DEc^>UY&#=4k^#cfYlrs(N zTf^u&^ZWPTcwf!58zEOuR78e!0LdJ}u2Jdz=Q`tCV8#0oBLjz4B1<|tj6ZeWk0Mv> z_r7fVVTt|nF_Wjzz0+|^+Jk(h`TT+eJxY|C@m##clb|XYb&c8w8r;DF;kI2 zV9E()z@N|)!+t5U161Rxrhi&aW0H_J;)9R*xjpn_gz=E6H(*8|?ab&8OZ4e%$nWgH zvOg+w061Fr!W46tdhaq6Ju>N6?la{39|7m5X`P+zc0LBzij}n)2tR?WpZWM>;2D+5sVIS%*Eu8_?&KV&)21(T2$qr|{KtE5A_p*U( z*ftw592ywkBbf6`Ki7S~ApJXKdohdI*`^@!6DSdo)oWy|#eeTD66NnsX|eJu5}iEo zufFz5r3+72l6n!WK~&M$BIJ7#YqA+0rW0ll{iF=ub-U!g-?g-*=Hf}Z7BN8Q$G~<- z=@)!gPwAripJz-m3KoPD&|8#(9&=3x-!=9cDBl+AT2@pRo&xTLB>FomM0uAgQo(f& zgVV~VdbwP)W#$b`f?Rfh&X~V)dP+`4+ugFj|2f8ylpP=Mp}B$3|0{QU7tFl>|16Ch z<9-WFtJ)n8vfur)B%k$@sr^8Tv&x)-vNI;(JMD`lDH{ROTEF>%0WEvd2;eT)CX06D zxW7Sq)?dr{m&8E#%pm(-pzDA#R}$Gd01ubixY-fIpw3(p|NDYO($bq^DO9ZOt0d2t(Z+fGaYXex^f z_3|#^e)AjwiN3mTPyKq(sseXNg6Oc3bCXs){gy{tRgTuTzBCa+9$s2BSc_d!=+~$s zU}fG46v2RfOyvrrYgp(+JKcWtCDi(_7fn1~NJNK}`MRn34vpk@fWy}u|*mb}qdnUfWVM6qA*QyATQ1G)i5n4Ed zx8bMG$H2edl99!W+3d1p;Wx`F7bvJn%aU99Vo3qj+X9dm{SqlQQt*img%_FtaD}g- zMED&(L$lknc{c-7D&aZ>{f}&1sGkgKOy?Eo=m_VhL^do`zt1qpPae#ozuoTya8#2Y zQU3#y=pvh>&N~Q&IIN<#yAIPp%nAc@cFKIYtzAx&`dOwwj(UOO!3S#zi@8+TooTTs#N+01;~gv;d-wy$W37I4_Q2%{dZ_a7+v{^4sAYs z!u>V-pfsrOG|ly>*?AEG*scuQyiZc*S7`->pq>zVe@pIw(Ugiq4RE-3k!iBrjEbWh z$?e<&FqR@r%ZbkjG4;%{jkyrR1NNh~iY*n?r*TL|Pr>>T z9gn>ILfH_wvk#eHGIXiy4T@B~HIU1xPTHCNL+o80sUga^7L;=*tWk`jQ~3;&ZRA>) zhi&g(d-evdL~o7sx{wxWk1s9p);}Rddr0l>$LuMjSqm~St@(`)47TeS{3pNbM<$*b z=9V%-O@SiJ{<`g>a5!d!bSvK(1uF@?J@qr1JZ8q{x0FWcNeu|f>)Q*1aP&@|`FcXU zb=RW^?H$4v*A^;(qQtJCf6?o=&dG%be+?js4kx2ZjqW53`CFFa2pU4n#za}XIC3k# z0B{`NWYn(8s}%0(vm}(zwf2r(?!x?OizAHUlqU`(RnqhgRW;?VTVjAE-(_B>kX0QL z{BJ}5la&l(#Kr~QM@SxD>yGQ4^-IoY%ZDPHiHrjGfbbK_J=}YK6z^MH!BGs1AASdG zGG!t89Md%JcWcgz-PFGYciEnVxmX%G&G0El#xlAGehL~oc!HOm@IHHH-=4+(dL*?% zfryt8<~|BwR4MiRPioD)+35iLGFxcCHFOPI(v{j>{SzbLbrkJrOB;Eo+k65LXQX7m z(Z>rjdiGzXYpv5AH#E0y@Am8l*1hMJ!)9*{MK^EDxi6sAE`6bq%1KZn;WIAqnnxCl z92NkmgZ8SADIp+gvhF?PS*#=(k`?;afyKuM9UNaoa+QVuXkBV&O@$o;p;S+0vdEXZ z$4ubN4OLo5g$K-&Q<%V*Nt>C9>6KLfhqpX=lS~d~E=Z@d^tBt)6~;pmm78=QHclW> zr)GdTvV$&=lOm%N=xv!z0=_(+0JU9TWPAmBaq%$|=yi;U^T7NAXnp@2x%%~#;rk7T zS6}d#CZ=!XA6eL3x7SnVXuz9M7)6ll?-KWO=5{YO0W54+UF2y)*m6X{`Cp=PEIG9N zFe_WeSk- z>V@ZVWt+YqgzgX7A=ra88?-mBv_i<}nFH;#VE-r{jS>#`v7JAdECig%LA9s zz-P7dBB`rci~#Oy-xP$^!*uf|58ztXaZCP2CEB-%ZxF&G1x=e>bVILctwh0eGy2ze zjmPAFwRF4YYwsiZ=B|QDj>3z`eYg^+hrY^y^>v%MEDOf=zIjm0<=wgGQyn7OQO~+ycmij$R`<89}@}S(YIECS!>T&~I^%E7c^V;4s z?^i5LVT?3OfkNPlg1lMCY1#}m_g30geA+HEO?Lz53Q}cVW@xF8%*W7rDSR64zRl*n zJN41sI$}pztX-Vegia z(0&q~OJu}*N!wITB`An3{9NmDD86DKgFs5XlPpyqMqxm{ZQ*4Grk!)yX|U1w=T^eL zvMisL72cSelKvP!iO<~MFF#($TmK~2un1Gh(O8|<)zgpQI&B*+P?1pCvBIPrH>jJ4 zBkLTf=TtS!E5jRKH?A+z7}%C8^^&WtBz_XMF=3iC`33H#N(}D`%Z$rjHS2xUQ-+Wj z3!)eRO5JN7css=tU=o(n&RBP*c$rwys1?iwOI6a1Y2Sx<>`mR|OB*i!dx_C#-2~OD zm8^L%rl95Tq%C8?a`m|=kW7O-gyoS5+M&Uax`+7$Cax^)=nw|X} z;A+%~L351;NdsmJmOQwS)VuW_u3?G)FN>AQ%VCvKR-(BfI9nu&4R`7(BLHv6Ia4HR zwHgX1>qP5e8IndicBwAcsIq)v0~g|*G`A~3=Lmy9ZXpzu?evsmFF32)VU-`Tx@q35 zY>uFK1PGbzuLBK3#|wa##<%U4gQB-EstC$e-6&!VFp=Xzm+}M}nc27_GrCw^JgqrT zkg=wL-@|^HgYV{T9(>O%2(GQ@<4kEW$o-pY2EMd6!QGnYz>uO`3{D~2&yLXIxkaTv ztZ>12Yon(553A6eO`=`q6pJGPxQ0|mtBu>uF2IkHUfLw~J#x%H8Y^|_`P6BKYmLwJJov{9T3R#mf5+YW@h*WZ{&fTQYk2fMX*gA4NB2q_b#|ajRQveGX0Q^4(VU2rW#=2NL{!Uh zkcy5V5m0r#*MgQzeHbmb$+ecyiQO%!%QbI&i%9IlyC<}(W-AVp-ces^$?-scl3YWumHLak@jJ4!NwsRHZj-;>e{i=(_?jINVTMrWDs(SLkOb|x#m5lSs zL`T0jvVNu?=-ZY0i)?p^iR);n$`&}dT`KdW_Z2gfX-A@KnVr@uNEpL)bym|pna8@L z1ivF)ys-VpSw0$+k^b_$pJPO+O1C$oron{LsE<^D2jLYTvUehbIkYyX956w`Hzs9t zee`x|!-F(X8~)(pSJEU(g|LE2V@&x!-!Sa`)`l(n28Q?9H2B80#2YS4--Pi4v68kA z+@fK1{-Xk9HudharjDFIrPPchwtZr!Ed{zx(c69nqJ3cw%5yk8<}jRy1~F<49C$U_ z>{Uwe@zk4FrQjc~tXVF3o3Q3~pxG68>Mg$Twi0>)Q*kBnPM|3OFy!Y$sA z&~6MW%DpjJ>IYIXI1?6B;c{Mb&)K4at2n-y>om6^Zu77tTJKJBDdwK(;fd+@uTs6w zSipjnW?R(?H8zX_+kM69gnUrG=D8<7_{|3!DqAryhyKBSy<*3xZ~RtXEw zkt_&f&?z#Vp%_Tir+{H!K-@5vK~Jo4c3`klz+-swN5(yQxif-JQwzMqZ{S}Mv`AR1 z67Wxl8GUaMtY)DZgXG8ul}yPOPm2M{x5(ljZux~#%|HFmmb9DuN!rKYjUqr;jJR6J zCW+!}1;+KtC)cw;wMxnI#Y?)#qs_;pi(Ym))~0Unq!Qw zFG-r89u}p2*GlDeD}ytEVgJI6(oMYgXG+72`-00h$wfY)W{Oq|A_;NW4--@h73Ny! zZ?W~SLTTSB&-{iQl_nzmuT7kz>eGZ7su-jEKro6YB7Smkon z|H04BnIX$lUH%jWUc~S1O=`^`mNdmX2zBV}%TN!8`a>Jur%iJZTV-3d|GRpV;5O2_vEH*OGhQZ_qm}svM;Hrv(Oc({`2!1UD=Zo^8OM_zQ3XHoiDy( zsw~U(G9M_ii3X(4_u|UhlXJ}mlJyKYzj89C9N*Ejz$QAiz1Q=pfR_Gppk^np&d_3YhNl(VPcex;`}55y zIf&X}?)Ml$`MXB5DuhA->Zm#4V|V0B$TIvYu6x#oVhv(x4CtFOGf;jz5-Md)Sq3gt z=|($rkArcJhGypWZhEDUuS+(cLx(Z9^Tf~C;8x7RymV2!zjXxs z@xeqp_qz!oDwqQMa)|tzU6DcXt||o^k;%?m>nhP#Aj^d0eSttfPZdK1j;gR?SAgu0yimU zYA;!5QAK!t(_ri8lkY+}l?&5DpZ>?ROdQg{qU=`jab+bZZA{1{;<{upf5Nl-nbO$s zg<^kg`028M6H$hQA@|Z&VT|G@@6tJadZdyaw!RI^WciklJ1WHvlN~i=hL=8sM^Dn! z!7j-WaOKsoxNgKuOAJ}?ixRSdy%Wh=_L3{M9&Gv_=gDF&R-rtq%G;?;;>A9KrQMlx zmkeu-is$Zum@)hSvf0?F=w$v#S>j=E^oD^R&g3)CPC+!f9MqBXAT1+x8SSLw`ow(Cruw&9NN4Tbui(6* zq6K9XZ~pF$6peFm=g)E);GIkuTQ@~~W9}owMj0IQ0kG6izJK5HRxw{qI=%a7db-2g z(I#*|h<474`0^QRf`gInQc*1!)Ig7V8JwT{FaFjUQ~}E`K#-eu+9uZtaxC%CillsQ z?|LAA;AoP5`l{ULir=q$VQX$R>(--`>AWBp%n4SAkaAr>QHFdKF(G^H-wwI>3S{^b zMx3qSf4antU>@B6c-KhVT%9vd0#|JXxwr#Cv0wze{l&jV;sF)rw_>Q~kV$}J(sbH# zX1WpW^$flqsVM)YRv$=&r9KTB&kmPbWbz&w1s9Xf?=*R3;5;GaTDFDkWPK~_!?Bv< z|C{L)_Xi&`Wh%grz4)t{_zzYi!giPkxPBu)fec;JP$VkrLG5gw=b0k_Jdm4~zoA@C zk>Id;Q^-w1KxEEe&;G4d#s0ZllDqOVcH$Ml$++vK+W`6;0vyLSwf5pGq<(VP2QIkX zt)hQ?XH0VqoiJxy8p+O(s%&XWNp5n0dQuRo-ei(4j#8orJGgHIkdI(EoJQ@omAa1%&d7FldNb5ERYk01x#EX3P+<+htte6Si6Q;fRK+=WgiRv ztcG%x1qMl}a@V8vW_S@3$jxZX*l}r`nz!9c355N3lEh;d&C&cKwSVA;+1jY5`LiU^XmsUL;Tcd z-eb-g!b(lxe(3Kr19&Z^vS4~WZRS=DV}D-oSoy-e_y9&z4nywT%f9& zO@IRNE-k9HOA|lBhzg!jjla2r|D$^P-nat2jaaf--TyOWQ3QlTFSa13Jzcvge1KJ- zu|`IX9)zLop^Ad}cTW(>M#@f=HLJYQodWYr6Vr1XcVx$UjPm{TJpFp;C`g|B4EBB8 z15l8UwS&Axf9#@FxMpCqTbv?enYm+dI}-&uZ-)>byol%n^%TdZylb&~YGcU4J}!P!IZ6 z?;B%sEi2bsvQn{dhFBtw;`#}AGqqJKvyCMKMC6vSaJ@|lXz8a#ZU5|1AbaroNsjv} zE`_Tdm#U|oY7kkyWBZV7Q~tv)#V$&ke6UmKuUs)b66MI$RluM=AAEKD+XgZbG?H=3 zr~O}hrh>WdN#zcnH0hnpVD$)T++6G6BcLQ^PcG1YO9cS0RnaI&DJhdm!8EGBi+@_k zON1uNndQ}t+kc1v0C@#SJr^`kY? zULP#j{=KT9@Pl;Uv!~MjLhuT*y$ov;`b_hzh{7T#15|?x4vnYMXx=sDKeG&CP_lUB zNfGY`rF_d^n&Bg3C0Ox@{|cZhD+TFqmHOTXtPk=f(iNKRILuP$;Tfyz2?ocByO}=I zV44R3#Q@o;itmt)b*W1iPT~@*$>Vg4(jEykIZ(i-?E05?UAO9qw$g?A2}KF8n&Z93 zd${x9Xu7XnJgi1_{2VIwchuz}vO04jpp^0nXYV;k0%tmy4Bu8TrvyRQb!};|@Z|Wv zzQS|W$5|Otk{c?V@}T-_%Nbsg z^>pT@+6>1=Og^T(CS-yp2=w_vaq>Hcb!zst;%_TSA)q!uO~)>(v6bc;80%~a2VhA8 zA~*oPt16S&;JS(?V=M-GSK}wcD6iXjY{*S>qv~S_E51(E$&gTeMH`Ba!I>)n+Pfdz zb&p2FqyvIGl&uWHVz0dN=mjZJ5s!x>3Ww(bL2`}ne=ekMT&Yh@4jAyIaeQsm3JYqc zw*xEX=ouU@-GC;V&L_98>?WhW)}4#NX9B@~y7AGrM<1(mOhb=Qp$e@C{`C_(q%D?_ zj!38e;;}g>2{KtCBfIEnmzEp5Kmtsu?9-)0e>M>TK@+m0{en(9FS3*K(?#NZGHMDD ztAE!c=|~!${3r_oJ*$B&&PiVE#YOFK<>srO4SCYZk$(ZKAhls3t%^T<0O(sb6f=Sh zxBeI3xos!=CUx>LCdf0XBcxBfK-XXc84yC{bOW;970fQQxse=f^-_c$=VA=t43%de zsVq6kQopDkKRGocM6Qky-Qda0;f~KyzQrlQ*DskKrKeFw!-eO<^!7c}W=-f?HZT%g z$riM=fh4z!=KeD{h&>Zpl1KSJzSxA+yood>w%EjDfT!cACmp>T4U;h5#tIkJI|O7V z2oLBpX+Q~k12tyeI)!xQKXFF{x-ehQ9Us{r z7R&|hM5EfL*LqWWLu_GLaKX>sND={Yu4$XN=O+vz=ar}UOv`V|A1P~9!e6sA$)BW& zMT*VCCOM%KN!ldX=dBKz&y11*_*o#RW1h0Ic2VqHrZ>1gOF6M7a8Fzo-(zR&Gwh#? zqb_`^@Jo!a?9g;XJ5``-*(=DX@4xHfT9Hl+?XJa=_HMpw;h3diJD zV&?Jtx*S@zVqny=sB}HLja}oPFrr|PKVVq1&Q^T5$sWMe^u~64)KXI zb_N=8mZ}*H#3%3!jssR2{KAk&SLNu4%{znsBU2J#Q#Wz+*7FuuPUSsse*w@tVDn0k zvOMgLt^g_+L3@gefallqDBX2}%YdfS|0TCQ+yr7Bb5I4$b(>XIU~t|-|mlbMTr2oBeAs08N_d#KEYudx3n;kl%jG4wT^ z?Vg7FTnY8_<3FL5S|i2}Gt8?h_}blSbeeyDgdkd5U@+zmsNi@z0lK>EBpSb z0u5TSN1vVxo-KYRri%@(IG5^*VFWJYG*}M@WzkjJ>6|~AoQ^AEB;pZm@Qw2o9HveI zTKN|^Z)KLW2-|=0nisaN#X36#kcv-G4{k(t#_in~N*M7v3o&R=ecu*qp`j;-dC{mW z&k<;ga3`3VK=q_ZX(vlY|hc|ii`Nxn~5cC&3 zd@Zn{YLu_IDPVtT-6$Pjc*nh1 zQ?X2`Vi5293nrQooQ=MFU=5zf!;S@MAudygC0&dlf1J5R9(Qc>sqN83F*rn4-p8$^ zIlc)*4K?+~8ZU=xmXzQB9tH`+6`L{q(hz4>1GydRv9o5UBerNpKl{p;quvFdV7Ic{ zLFHl6OlTmp*-i42FAkU`HHgxSU8=6wJH2iV>NcyR&!=@O0|WRAn%tq^L7m&OVTF?y z8?uQ3FT_E?;Y!)by9}3>^fZ5BYY~z)%Hk*oR7{XT^KcYJrN+l_h(o7aEulWb`r|V0zGQaShS_K%U2fw-&^#L&rA2L|KAG& z42@MvDPZ4}6OQA*Utk6>kN$rO)aVBHrrZ);KfM9|>%^Z#mW?7HTM4{gZ-8NFUXbhj z*6zGR?;O($X|M5hB{rvo>ef*QBe=B%_XQeQU93`v6rC>_%Dh0h zGW?HD;nU(Bg`6wgO;(uM&c~9i!qb=|+#i#o0%+*Ws&t-BA)J5z!r%NK%t&-S~`raQK9!ofw#1K?l5HkpP!?7XMmZ|T^Kv2T3 zrx}1b(Aa)n!Vi3iB4ghw5u-PJ>e2nZwE73?m0JlYR&nSoW7d%W+SA^eR;gNeUfAZ? zijt*Is&(X<2?%5tvuJ$h#to4ybB*T)*Kvw(vO@Nwe;HDB^N+-EFNW9*aM2mt4CX?^ z_1JN7Jm~9tUdEh4MVGFCcIf1gI8Jw}IYw+0E2`N@7>lkH9*^o1MH+)W&wakV_~39) zs{E03f@7n+rlbkob1yWSbm8e>SU`C<7^@Hc-bl+w7;>>+73O(Url~iE7TxL@Oj&ZX z*&W!kHj-ZaExHAqI(*A9^5f(1-Ko{#$lwm>zQSIyJR^p#+^B*4&%HgBqGPTl(zK$}YGZWTjNqtx`s1`0 zXq#Iq?};!oyhrjH{aKG=mY9RR6$mUKME5tR-^;5&U?I85Ph0F10Fi9I9rZ-o>A97M z4fy-A`EabCTEClpML*=Dha$$Ngi(>dXOWT0E~LYL9LUBhrvfp<4xB$mgP$RH0FpPZ z$%CV}$C)jRf|`;M*(u7V9XO>SfmA({uBJ&4C`om1xO5E{S%PZS^Sw)-rV z&R*G;>-NplNRuMs(7faVYY;45N+p(_IKwf=c4!Ta5~@23n~-(?F2b{3ITf zj`b@zY-6f8ECov<+Vr|*rxFSL^V`cca>}autLr35KTXHrB&mgidx8{_TBd7ygPfJP zH7_l33kwmPc%nAOa2vs1((=XNZXY7s)&*yFl%Ms+ z*dgZl-GLfZuOmt_w#>=sTA_-F^}R&vmTqU|XX%)NDxelW5k@Bs8Bct)esupy5Zb;e z_!*WA%EGFpSZT;fd>A0dr>!3w_mi0|iLk<9+He8`6i;{t9TWd&SDfnojg#JrjOTG8DqP zZD_UWe(i5iG>ml9+6YKJn78c%|DIU^W+xkb$s(x1K6ag1h&=J@ZNqW}qGuUZ(QAQ8 z?pyk>Tur03;ZF{DE?aROOY~Jj`~LsxJGG(5f&_w zB`X;~MWux;(AcveeY8j-pO!1 zAnd?gZ3;OX=i1%`-w4e59KfkJvj9!weH!A+Q6#*awa)Y0#KwO%sYZ=Kg4J2k@7P|o zABh>#0mgY821*`{%%kXZMsOp@X@=hduA&kjxEo%oTTRBHRe@Jmr*yOSbzNk^u{|a# z(0OkDg;{XKy>DFSs)Qr=0Nq*J&1=mpn$FiX)ax_xYuNFY{ERvDH+QhhDp5nj4JI<$ zQG${P%|P9wk5${2vwD=Uj$n$f$^wCmC?Q~o20=DkOV6J`@E^c{pJD^wR@DP|!r}hN zRQ?T2G6*_8l6?v|wf?mI#l6s&@qrL-OJ+g z+L~q78lqEj=l#YrC}cG9&&%RFz(T4%Acv`3gwvtMF_|Jf;M2m2q`IMZljo&QBi~70 zf(tjlqBsq4H{PlyIo%b}w`?Y{Y}kD<;~QfAlY=9Nv-_P1?2GEx7L3>qI`;XDm@C zH@5-h)PFpYfI3w0xdp-%=2GK73D3K{H$iWh3eOG3n+bk9`MwI*_0@|WL)Rj`^b}*= z<1$;ih6~4Fp6F2yVv&eRr~d|n!8U7wqza)Y(w&vGlGijm7ugrx1eQcmFaPrp`OBem z1@$2-h6UFHZDHa|JF|&2|rG^L4;+VJBA1^1v%S6(rNdfAyOk}gvJnGIlk zW8~~s`f6l3X4wV(+zbo`y^C~sdYmGI1KYWRTJajn*~i^ZT&J>7UmOl=zoo8*9eFEFg@%f7C0_p zjU1*~4S8Sg52LTrNjlF^Ll38SEblFY*fQ!@6{>O__d~lhdzv0Fb*?a)#dDp({KY+0d@PcJH38`c6 zozUK{s@780Pd$z8ZDy|Bu2ZvPV|`MqgRlqjrXr zq-)G0ih(WBX812U=#GDB&YElgvASHv{!s_PNy0<_yzfS%(<6e+u$BJNel8X>HsJ-F zXYScN<%E2^_XAe(kn2DRu$nn?QzC~)4FT8?ErHUoFWKGI@-QJ7rp?jl#W2Rni4R@K+tbmWd6qV|r&`LT`@6+dh_HY$zx?(-t zR2~9tOPg*vzfSS;1Jcs@zPvg8W9?9Ix}PT8R@)Z{*DkwZK1@Gd6v#IIq;!K4vLj}n za>=o0ol^cp$omo*j%d_14s50NcNGVKa<6`d5jcXUiCG zVS|-pgl0!kIN33zTih616V1x3C8|e$Unr74fb-!(MjuaA>d$Co-hRDsq6gNKS0tvD zC0|$?!V#x$>g$7OA_06n)~`OGEZyh)n^k^oJTm;0WvBe66f2FRQ3)hNPN+!728vvQ zD?9OZ?PP}owPyUVH5u-wJHGc8sN)3ObV{z-Xob^`z@#FPu(H8+fK^p5;KfcdFCtN6 za0ff@;d3Y!J^RoDA?}k1LcjKygZkO~;CTNIKqxH<2>GDpJ{5^ztN*V1ef~s63z*9H z9!u&}+oi|^i1ebaglx(zCm$pdBgZKI2Uu$MLtW2irbf+=V$**fz+xrmr41tF&vAYs zDV8N1m6P#dZq+D&^|vseX>@cF(eijO%^R=gL7~=A$QDN7sg(7^qUnJDu9tn1C{YFjNNuI^@4yDz$7* zHyzoN515veuTKweDx}SU0Lq?nruSA|W?XqUtpP=(B0by?WBq2ph4FUa8`o1j?Q!fn ziO^Pu_rl-fI=V%?*_s$@;x$V+id1+-4B)C?p^cx1_{3;II3987(d1^={bL=Rk4%R- zu>faIm6?tNI)FRGuCFtP95iY}7)m8br4_~?3(F5K50Rg-<-}?RJBOVw z*jD7GOM!Nt)#FHwlz!7T1TxA&Fpa(P@y#W+PDy_O5aTt;;`!@o3ETl}a{h^0YlOHm zA2b5SV@`BKH&=esjz}a}%6X_h%CXUJQAUC1Z%?)s8J$5C3edf1)zv+`NnQ*1dcWCS0-CXAYI|DbNS z0_5Fk^^5<2I3(d?7r&;mlBLMHNfRK2*AL#6QFH}gRUI#n535oVQuTex zD+qjGhp7W*9br*ay#`zp64MNXZMD@TA-eq&#&3D90#M;vbC2yNE=NtP+rE_=xPPe_ zE)l4z``)!Aknb42Q&wM1bj$9jC3-v-tH!_0uGr*n;kDHE0fw2wST(L z2RuE3fcY;CzZ42=QjK=&{q}keW_Dc!CRyaq&j)?o1lt$m5BZ2yh{WFt|8erphIT$9 zB5KfyIJ#rX=DZGpifo_{ES~To>~%2idq`;}_O%>!mRnSB%VZ_@Xap?v-_Zk>i^Jvy znSw~>VFywlyn!E`T3gv zh83$*N`1BnU(-M!#9l&sxym#`T8ksvR|9wGag^#wGmpEMI^7<`ly-$DKs?t+W~ z&2J6H1Tfub46S>fUqAf;ABFb9O`!tGNw2MSWb1bc6reZ3joHdNz#*Mdufo*3Ja$pG zLfgEa@drIioFK%1ZO+PkGESH~p?6B-aI~x^)Ol{YdY<|pzZh{CmQiVn7pKM6B=lwm z?lv)cpkz6WXEYR}*x|?_2Y4b`m}%Xy#(Gr`P>88*vY}_y*m8?{z}5aN^`Zl;HP9l8 z*Q($PJ z?V86s;&$Bn6HNla`TCWhTKf?!^SIS22c{@k$`h?^hu&MY-*xx`X<06*)Fw^7$f5oX zSm?O#h!|dup!NgN2S&QzH5nVwMY7FqI%(4OMhgjor~-i`GFePaj+_iSA^Hr8N^YgB z&`ABex5;${WPNc)#Ke@+kC_hA|3#=`6JpGps4cW2VMPFTAqH2?FiR9hrl716Lx(Y< z-Kx9vVdG-#sF(bJ$<(m^8A>Wzgj76UpsqE)IN?BxVCFDRIK8K={rJC}kib-($bfI| zzo*D0^Rk7R>VHTIitIS@z-sOmOE~P#vBpM!AEsn6^}37(wSAdJMgh&*|AN;%kAR`g z_Lo$OgY9TaUEni*WHL|Aa;)><;$wH$z;-dJWp5(lS% zYgX!AK7%|VRT46EU_N%~$*S%uGc+7{Hu-#J$SgaTb||*ZGiGaDSKZ$PmaYvbX_8R( zXXmy~LQc%|*FekkEFOII;)ylIRFcrBSj%WUOIQf2nfdU>`gO6Sc%DvDC&?eV_?Z5+ZktG`Kx}j|AuOATlzB|tuq%CxM6S59TJIi`jqmL z)WEAnmEyaH{plUR2m;K^aHZ?!*mUKg*q;5qY0X8Mr9FrV&jzMQV*zrvt!p}1zrYWB z_u>;oanPU#ZXb6()!`e8n%l-M+1^D+qx}OB?K#oR(3iY;Xwuv^)U~i49Jq@}^w0m@ zBcyY(dYMieXoekAKk99Q-k5ioVLZ|~grJc!1z&93$WDJDXm&q~ZT#qz7Jz*0+1~FA zIg2{G(8*41h}eb31oovIzzIOMwMEr`&0wr)sCuXo3XzIM2ryCx8;LsA1xL-oX~yLW zvf(sz>pC+&OkIDi4>p``7n?rJx5jC+jOR(m@pyq$mlheOdK4bM>L24yi`trKqe)xu zNOJJr$Se+}PqAXQBM9B@1m&CCJuc#HS=N2#0Av+(gx#E*?`?<0h`kbU{88wQ_W{EnKXL3f)+LqGZH zwzuxGq_2QFxz19x_lJ~}_9Q=mBbV|PC!6|-YaL7a0;ta(8{WI~KijGID1XYRxgjzg z9h8-xmVXtO1Ly)mSNC;^hrgup7CL_$cS&Rbj(3t!wVOauuksJxe6z3)F&vnw(wBnL+0KLH56CyIMlTU#n{`{TZkZCDZLU6isRvSpllk>df^I1rH(iX+4iNaB_#k6H?g&O5g1S74L?3eY5v`vAth4|5iaztQCH1_L z7^;3|eqAHaBB1?pnbOEBf+%s3X3KVg6_T4KKEdbv&bX>vaTYc$()!BsRk@&XLEB&i zrsjSzoa8IaK3JdTMnvHGL$#c@;yWm%HO$Ix63gOh2w9UU5Lb2dGqUUj6`gLZcAc@s z=CX;1V7o_lq1^IaIZ?`wOlKtoPh~BLF?H!PzY+4XMF#I&rh`QeFJeVz*jS$HtOFUu z5BWp+%HoS06roL4V2GKpB zQrZ-b>BeG8eY9=V^e}yP?1rpi1TS;9V0uSmkS~NkexGibro2CN7c5_cndmK(OHx-W zF|x4&S-<7gd&24&dZqn9Lv;`p`hy(oxxrL13){)^u1!plU6~Ah_PrV9_*$fJ8`A}g zR=Ma=N7G;)^_BLygv`g2g{k5BI{G?WVO%R1vDR5tYJNGu-aC>y#yDe|b4ny8fziIJ ze8TR&q8`qpuU?s;ra9(&pA6%E+OEN}_m;`ROY70V00zM@U2b2nzlh!a7$%K+}}YC_h78cfpsZzUuNQ!1q8*5mDK;h z)f9%pT$pclLmFS==l%+$DKRJuyI+`<2DO^$84y?#Zdp&y}=f*A{>F6e!dfgq&Lh)O}a%$ zN|sQ{R8ig?UW?P;LISN4f(x|b{O{eigw|GGT@;>94XD`$NT(I)opWEbX)l_mg3J+7 zB{`w?{?0tvA6B+FoV2-p4E9EZ(}iUdf};y9=yb5q%H2R0I>%;dk$m{9(3|^r#s+yR z%NZiL_kRI}KzhG&7+I*#y8Z4py_o-y&Sn+OVrzq{<&4LP!&C0Qw?@p1g2JNMKpUii zjyC{1=bip=3RNYG#^!id{SWJm2onC)HGmj+P1p@a`h=FuE}sYK&l2Qd(J%R=*uRhM z0+D|u>8YgAFdn&UuIGrSexa#RTGj>yql7_^Yn-lZ&!DA8;y*qzDVb0d7(A2lyC7TE@H2^WnMbhW|=?Alf%`dmjfju(`i` z|K6c8oQtgM=h@g-Ll;oh50~{z7DACKVHW=at<3W>?NCqO6g)C!!8?Xr(qKh2!-E`b zUd||JiJZ-o%YEbc*(RkOKx0SwiiEp)WbkCVohs_&9%4K1*%B+t4kdO^BTa|X3k#Hw zlwoveUAC_>!_;GIVd_xTvyj@k+{whFpOodvf*pN}e$p52-};M|B+8-p zW0)}X0*$*!LyoO1Ulj4X8vB@`@K?aY6@sR<<{X8Sam?AVq6jb<)_(7sGU?V~X$z~z z)x5nSLYM#bj^^gmiD7Ss;qblJ@r#ZL3Z9?Vtz5>Ym9Cxq(?G>2jBiOZ%LxXcl~%3z6az@S^T7Y>! z_qT}BZ#C=)EIp{U4a_aa3gZ(e|KTDw>C9FsS6+OC3lVV}h3|fET0T*|n2WT|j~W@# zvz{1WI+i#0Q`t)ZM9+S$8@i$i405`3OL@zCsBzU0wVF>XzTtW| z9{Y?Rqy)M8#jrqep83PFoew4UPYLpeLkC+8FvC?#sW*LZL&jebU=Wk6J>6O^v6q<1 z3;tV{%j+PDQ3YFuEe8;?q=_bfIR8)nt0D4z;Mv6DLt=|#e)2agyS6Y z7asmC60L=4(=Z|C)4fWkdQb2Nsy)v&4(cABjiE;Vu|P3`D5$W-FY%QMO8=x|+) z&cCl`G^A-@GjVd>R@iDFoCvX>h zL+?v6zT1ENt7)~Ag zX0|Cfye^*Cl}b1R zIm>xmfa9=ReUqJM^_$+8(f7rPqJHPU_}i*gewv)J@uAPDD79~#-Hfv_Uyjc&`L@?_ z(cTfu7EPwRPT;Ck!^@UdQ`{PKL?Jev-e+eg17^aVNR`^`q`vPZIF%|>^jWTI@ue;3 z|4$8PkK>TbCYGsTQn;g(3#i|TUlr6fW zSK3}X-)U9{Jr5WsP;(xLTK#73R35NCuK|JgX;ry>v#mr9_ zfYCbNpg(^P#H)8dx<7YM*Sq{%RLm}$2`bA~J25|7n#u*b*>ut0o*zhi6!yoE1bU#A zzMl9*$@K;@Yh7Lc*3>RFyGTiWPtVJk2AH-p%Ro_|V~5^f`l+lwL6_Ig_(;q^?uHBa zY^@-e7Qi}i9Zw1aMv%Aqp{U3uLp1>nTcD&Jd_q@me>>`1M3x`3(>*w}*5qmtU7(6G z4SmALR*oGc^c#W+u`?5m1r`VgVpoEfON|dk*4kk4je0SlJbgPIBxAZZTNX%5& z%Iu9zYgFuk<_B~qCM&!BcZ!dsP%mV83qMhDkX%O+_~iyB0SZYEm1Nb4z)LBmrgFsu zm1x#*X_>(NZ*J?yk+_b(y6$cYfIxhUCe zdpXAaenX(#w~GASR$;Qrs(!T-448r^Eitn$App>{Jcrkz^OCZuqkZ^Dsl}~weP@|jziv@?=@JhBcu9dK#vCF zIIPC&*-4k+T0#zMIcH_yMR)RPR#H@&W-7n=0X|e3;&_)d-kYISpXyW}n1=e7|Jpzg zFaR0%o2xX0`Bpf!7Y{yP*_5PB94k&&pL6}oh9Gi-dMZ}Nz0&zAvegSnqx_hNRH=ZE z6Th(6NB7R(g7)#oei&bDMMHYRTf8H{G5zS6_uwrYo$o=iCF++g11vJGQV6U&=S5@G|FyppPm>}cC!oK zf}5AuZXG`vf8&)jZ0AJ!bzmy6p%$mFsKr31`96W8qQ}{w1pCzrvD4}KKDqm|9p`i& z{^CCSVf!o3<)&pms!Ow`d*&(BDV!J>J&Q^>{l)83>n8TVmE2c(0`^5rpcGPoPV|D7 zUTMQy-9{GoHkY0BXWD$v(~$AMr>^4|{w0uBh7K1w=NR`)~{@;aQl;)`_0WEevBi8X4#cAH1mMOuQ%1 zz$p6zSHn02M4Dr8UEnCaVsbkNvy4sPsc(TiuvLsC=G2}&h?Dk}bZc3`9AUtdKd z<)+C~e!5FwwA;kdBogQ2{fNiz99fQGAJIh(Jl30D;Gpjk6sHl?{%_%uEDsUYKD5@} z@;p>i9@5o%+BaHr!zq`5u*r%N9!Zuo;%9nR1&2!KFkG}sW~KSOmYodbO$vXi17H=E z0Z()oGI2`HU}E)?lz0f?N#FiAKz$XbM`q3msTZyZ;9bWg?7>v*+*^>aB3}O4GcV*vQe&4B55$`6O`0y8|gXA6rE zC5;2lEhyFfsklc!{4e%-z{!&X3opUFcIZh{&>K|%afP6f!K#pI)A2@`7u3Rkkx3VK zRK=fyBE9lnxe$Im=;E&A2qyjF#-r++4~d%yC;-s=sg3mm9dYD>PHQQ;Z8rjTm5pQI z7PRKJa%r!Hr>+Z-pU4iRLPa!7~ygE8nANLY+TJ#AhML$EDFNkP(Wf}I)3ZqoK(pq5$^toYs7{n%QH zw~v=t>jn29h<2K5N`raff9SpS*BUJSLyDQh6eASzK%zB`Bo2UPI(|^C>*aY^r-?vD zGtzvyXtg{3?klMTHj-0mMZJYCr8K)Cnr9-+ByRw@i<@=F>gD~$qD1UyI8}%Mi>`up z4bct(?r}!LzhMGR&Ybps&NL}%YlR;xxu9v_l0^yqtTY&U2leA4=D-k*Od@)P4MRfQ z9Rr3je3QHNf7>$>$kAfxRj}0a8zY_#hZv6n- z=L*-M*G>WJw`?b9xH3H*TvoR3B3mSw6wj4G@aG_JfgDrOp;!f zPVp>BUSJ8V9AD*cz&Z@q;{~Fn0^E^N(0DBXd1TMuKAuu403Q+?GO1T8PSs@0BcAQp zD!v;X+;S=(vjb{spUADy$6fY_YK~Dh{leSh7}qnZj~{gBienXMc45aCq%8%Xg`^os z{;Cyz{=uMc@9N>PV9lhio=WpF{&wBn-JKX)9xl6Dt9}j0K3`S9?D=VPYJRzY+rqi; z8i{~6j_yCQ5C2AIO4)p^2VSw#!iyju3^j0fvw&?5Pl=ivNehY;8A>%rm7A=pLH&%;o1{d1xhqhNq^RiE8u(<}QDTWKyZ;XV1Hz_kJ0XF~A086i@5)B)d-~OSjEie>Awz_X) zzd3N~W;+yd6?K3=~fAr|QL`riZyK!$nY55X&sy{q1URF{FX#uJ3 zsTdXA%JYwxrK)rFftd1)%4GmE_bL+~8m=)pd0#5he|xWQF@?m>PKxp@qTy%@2{!PZ z`WY8oet#eFkXaYa9DCT}lxhHwAOu~PlxUX1NPDIacX;wY_$Nva-w44_={sv6x6Dw! zU_pKTeA*+QAJ#H%2iv-y>irqS_dfj=SKl3^4#+AE^8T-!<=>k<8Q{ z!GIU^tnj-;9?egY;VE+cey&5LdQk4&ZO~62H&guB=izm483yT;zJ9?q|6V9R&?O@U z$%HxiWQv9R!Yu!`i;WXh)(ZL^v&!WeMnk5l9*`y2CW_dOBRp=O^X_9q;g7vsek}xT zgn>zSKzG-EI{yRKhm59>(^)h-kIY|2nZqYm8w0-*%?Bf#O+ornX+$MD=qyjkD80+hE>}3lK`% z2nqC4zLM`~dZj&Q-DON1SyiOss*%ceQgSl-PKOIbzN<3_luAipOfd}l0!P(xRlv$a zi~wS8Rgb^_(6HIqCGm7Y#y(X4(dAo_&dG_ zx(of3+)1a0GFnh=LDLv@r|KSm#4#ksEAx<08@DhVcM*PqUIV?mB|0=P0L#~d9nX1= zoLb%8Lz0G-a7g2(iR43m!gy%NLOhm3oRny0IWpMM&_3}muTJbtf7`=aP~!|kkE)3X zN=o;}f@6oE7&YIUop0CN%W^_BMWy@EAM8?0mI7%o#e^?=Lu!}R@((eS&zyQoIM(t$ zFq1zrvb?=Rz%THeUh*g8`F2TLVqM4Z@@Oyv++u;I_BlrTtDa-p)~Mb{a?>^nIr#N> zR7^Ip4Cy@iCWXSS6B`M!h4sN$GI=;RgRX z_UqnQ*rqnv0x0c6{3HO*p}-?oSgEMls}*=?&t}n@TiD{Bd*=kZ1g7L)K@jG^^A^w| z_-(@)Idm$>4CX&M;oEJZVGpOAR={N<8yCdE0J)0-n?!K)yRWMFpMOM8IH@;-fgArn z5SGyZ9gwM~x0WTzNjDinYWNwYW}Auj^P2a6qgnPZxtuizY!Xul{s6c80bE!U77s#O zxus}<)5(wYn1>+GsWOp$TRtH2 zXT(O!ZT=Mg2%7Z*B%V7t`y!f&OB39jHH@_+{lG52L>z3<4OI!xOU6xnP%yUFWx7Mi zd!a^#0=%>60009300m^)2uG=~EWNj<7y_#*vjc(v00svEpK)mrp8x=SO7^2N9D_Tb zjzZJ<5Ia7amH+?)000EfxI};)L>K_RW(3>CxkBY;ZnvdTmF;}fQ7#7?x+E7#;qO@d z<{cFbtZh)X^#Qd4;+d!o(12hq6d2Sh)s%1&%6W4lIq^TmGf-U#Pz-V=#&YQ9CSe<{lMTX_UT76CskAVUY9o*hQN_{E2Kd==Q$?2S4a$d;+!BL zQM+~egJ)D$SpGBimM?#i*irv599Bwd|7-RVI1=<7m83oLL>jM)SoXnH!XKFaH2OKX zwxTO%?m+08J90@-xo9bTJ>GVIE@{e1GCBCs$+ON0h=TsJMdUR?La2z)HLAVQV?1-% zl{>w~;459-Wn$grHVN1d|JB;m_UoX{I_iBXsk>mraACC;0TD@fUmJN)fms2mHIrwc z{G;lF26$&Lg=L_aYVat$L)KFZhe;2D+z3`E~9e1lmnR+O@m)ilx?J6{gA>xcThOL2sT)4LTmBta< z>rJQec+nwjy6Qp$nkND2uEU6IEpYs*@sa+Xmy+#m8tk(s8Pk%2pndfnE|DN)spA2K z443N9;yVVh=r$w&!Xrmo#pf6@Wk#^I^LNg4kx6%+OamT?4j{tx8I6a}PdzKp7;HJm z5Ngkuz|)%>&MEmFUEo00>sV0 zB?k>xnN|`SpC~(oov=obG1Cc}h;~l{){4evSJgafJV19leq^jO1=T6A8zFy@n1So> zgIw)kU$xGr^ECsP$>sSMw4X;#dLCvCx9nV|!X6eqkg%nsg&u)@b09HM9(UR`cNCEI zeue3HXT0*#i?d0u(=YaR;E?oONMAD2p~MrO{dPN#MKcRhtMQ89A#~NPpLh$=04ooUO0d>iu0+^Yeq4}JrI1$Bkz##Y zs|)i&LG!zL4y>{2&RKx6D9lIalcSak_*4X<@Wxzc>$L@0@8~2z$^+Okp;T$n)9dohB(&U`#au_Bx|<4ke$tKQ?)PEmj=S; zwU<=^&E1L^e>Q=rRqjWqis##idQ{6?ES^F|ay??h(BVvvYCdTo;>6)Jde&6*IH2 z?m51|B!IQw`{z^klfiycRHDv0Mvev04F(A%+@1NvZI= z^bH$5!NO`@YEH4KZ6Hi3mBt+fh3vm=cf~! zaw$h8GnMGQ4YHuR)Uxv6_E2wo2M-@En6>Anr8l~wB~Kk?*4_`(RDvZ+?OMvhEXiEB z#|iWst5Pr^=T+)(4qzCd4fIpBP}E2d$G}Uu(MCBt<<-xh0A>{rD^Act%KS&vfbmM$ z0009301Y=*1t26eI&ux51G@kK1!@7Gb8bR^002?oCz%Z*YE77f)?xo8xgi9C!vQCy zpT9T=0Clr`wb&PE{585hjuxMtz)|P*|56r@iWJJTY~!_GShxKBvqnZL^@)mV^>7b9 z>n-bZKZZV7+}l+V51s1#?D1vwQM^OjhxxN-dZnT6zE)cPYZL$tYL&sIxdUEKQs+|m zx`qg!A$ZpAo?!}zbgz8r&?mk07YAH?^NLoqsU!Wkpx@sjtyepzL@actW_;_M0=NHdejK-R-OC>DWQ~PHhD#4-P3vXtXF^u?@8pA8}t7#5#+;TrlvMZR- zFxvhnm3S)YHv@Q2BP!rI~# zmE`{@y^AhA00f$*+}F;Z{~P=XNdq;Yw7Y;G?(wni62MRFigkH6ZZ z2KowA=S4FJj@j4kRzOuEKWQ`0w1YEZXZNMDHj)^6rJP= zCrPj76*|fpGK?%1Gx>{r!m8B%maZ`}kwpxU(VZU@QslS1sa2^d{phF+II@WuHnH+9 zQM4SZtl+Du;eu6Jt{)bx5MmLXxhOpL#Q^vyJ@%=7N{)azNMIOu3;2Pf0sEx}@Eg%2^rG`=zOZ#q2&A#_9<$I3$kT072?oLZfoj2W26K6Ya#Q>>V7^l(?b6Tjb zS|>V+myz@b_v?&gCR=lF8nV&hm&mbq6o*T#w^@S@MOA0zj3f}HfaW2A>%252HnBho zM)EBB_+b3UM)ytNxu9l)C*5obSDPM<`L>~&>d0f#oeB1B{R6t;0k&_?3?UGX3R9>5 znBT@7&B>&zFmh%l5p)Jap-Now1Z(dEt=>y>(JJ!tBCj$~y3V<)0W5~R!^DOm9-?mz zJgbbKNzD*c!HEmsV=ydahm+x$1hnY)2Jd2maGY0DD~)0MgtWLrYuM}zjtF>t!}x*!=%Cp8~C`jOghV4Bli zady}xuE3c@fQPh@JYzE+mMVj|NPOqhx1>@n4ek000)$L7R9r2ra2Hm;^Wf{;E{~01f2Nr(r*U7U}p6U79;Q?4GUwWzi|UO{T3` zX_b&|dSQl$n4Y7!`@WQDW=W?Bd+?$Ka?@i129h66fEdjU_{sjWc=%SYv9gay74-!C z-C-8Hhq4J$ww(CafS*&CdGb=x=hi70`xbmQk^1>w^sGj_)Dt1F4^hU6&=G2a`}O*i z9f+pLE`<=HJi9WF)4sU4WvzCe7Wh4yC^a?5C zg7z^=w*UzhKDJRvo2;Gd)%o(ZKxqBls_w04F>Ry~BkGbAizJBTld+WIgM9ghAeWZS zc}S?3mJj$y?GV&)dxj;@-8ZS<MCYxAX5;SS^EaUTRM zMvCy;K{kv3{(ElV8j8k}_1dGnH!s&D6H%y$GOljm?1P10{_7n0Ym^?sv*!Uy+klWOjS-Lls~_qdW}TKBu#6R33l&<+qIV%K=nM4H zW;R21keD(U*DP@lK?(I@k>ugk~N?wLR(K~ek zesVYRDn={mRBM}oymr8?z-i24VZ0k@=Ju6n0i6Xn=3}hY-d0zTEu9%j zkN*DX1wg?bOR6(h?WkKhmrVj(LESafsu5;I>V{n4+sPOn1|)~b=anaujx=$`-$g=Z z4~V3F&j8`>Dg1>T=xYaMCcC?M(}r1-?~!A$@ZR%iU(bhBF1Sn9;Aa)XFTJF~^G#{_j?0c7@O5K+D^cEFn^OL^D@8=5dR7T&APFkAzf%tmNyUtMS- zW+#7O?pidB))@ex-BezVRU)$Y%hJk8C%mkQQf5HRra`7mal}4gtyPMEBa1EsI*E?0 z|J@)5v|Q2v_Rm-$Pw7V%x7N#=8e+;02XYYJzo6gY*r=Yi5)!$vChiOm6|KbssR3VQ zR3_J2NC-bbJDF>__5Cry#Lo!0w~h_yerPiSQL0;!THCp^85&zi*XirU4Wm{7K|1;F zG3-ONB^9`u_%#!E*t&ZAg?VM3K~W^f!Tr-Gk`gY}WSnv1X@_le<%W$FX~$15G2mR|7A!QVPqCfSq zE5IoJ7)cos2yg|w@{TJ{7YaZ+XMX=cu3h`UVLxJKE1#dORt%5w((zr9iqmyX5!_jN z+UwxxAK>=`iA}1j&*9A#4*(&WR?p#s&UzC=b06l5;(vz1HVE#emafF51dzVJ)xQe5 zRmjzzSiPnjyUIVRE93ibxfx$XGUU}m?l!caWM;X}GY{%`2LHq0Idv^Cx#L_iA4{E* z?t+OUACTeFW;+<0ud8hTgE3wEfa1O&tt5=lg%9+RS>bKUE3~OC!@VJ5h}bI^f5UR?fqV8xnk2@thfK_R z*N*Sqt$!6%4rffo#jMpCI}`6SR?wwOw&A15Z9KF`&=Cmi2&{M(McUNa0lE6+Z0D*7 zhJ=Q@ec2#9Qo*?W@tTv-lfRPf|{E2*xYa+M78VcuWv-W%7o9v5uoN>TDg zi$+=JW+~#6ar_Mv!3x%{;YQHpL5pLUigs*0piLxK{a@7c=$iWgxy!NB z1oZbn#h#zY2-~M)hqkdMuBvya^44qzFoD0`LN^!r+G zv!RTuQ!1Q}l%iaC_+O}9&^1(EQMf>s4m-?LgG^;U3XcerL}FtH*tc&I$hanRj-_{* zKYdDvWrbPv4eKU#zIad1@3!4@b_C1yJvLW`upN!@aFoDtGaS^aJ>@fh8>&&m7~O35 zmU2|>$l2=?^eybyYL5S_q@j*!e zM%f8oL$E9Fn%EZo)o)J~lK4#6Ufr^x%^480HB7_{@4(lJ%BBeJV0;-guqNp} zT1huAz0qAXCkPUI{sB@cEY^@mOE1LKn6-O$%gAtyXO`F&bRZRqHs2ej=m3ERQ;&Bp z0{G^SY|oy6g~cLdbS3~fr?zeYB$l<1DNm)Bj_)k;j^^kHFzObYW551zHg^S)<~@q*}_6xbB|~zVqaY zon5oH8@J8PoqSoQRvbHj{*_8NHitUtq-KxaJCGx5(SF8*=E5HOt&8Ek3J%mk!z_ax z{L4HXm$6IgD7%<(N+TlxPJ?s!=k6K2D%^-%-+Eo{P z)5=?m16aJO*eaJbz@H*B5r-s*+IYp+$+xgLMN!r)(R|RgXX*O|>QkPE{Nih+&c}V$U z%Nz|*fCXHwy)1oTof4~$de?o7P7*#4xZ&q`VeOSkegb{AYZ_a&3QIN?0r)A>32&X9 zZ^R)<58M3(kAbmg?9Zqsw@U5w4liz_`E%%^M`}H1e-m8of9o9pEaerW!O6 zluya;H?m~PlX~!oShG2QPE1s%D<<(avH~`(=)*I^t()D;ycb1?r7})bbCqINho8DF&du=>6$y_ zBP^9U)hzEiRk_;D7Yl^*vW9q9E8_8zD&tgWcB!@8ZGbrBdaWCx2qgzO&_9IFhfJ~6 z44zAo`*N(G*F5p(9AW@Fj-^jj4XC2iY|9gB5gUNj7 z&GJA;DXPBFLKzKbjLw2L8=aDmWjOZ8c+S$(62hrm`OUYYk#|Gmf@?CnR%1H3*H~Bt z1^74Y?HKg^;Gi1@*%gexRYt*d!=$mez9^_4vXUE^epGa1wQJW^xmWf!vYbY+VHf4JNbGy|? z;LpUqJ4jSl@>76dQVS#zKmR8qFKJSnqm5JR4N;SLT>6Nr&--VVs7t;}q9n9{cFc{z2?TwcMUt^FmQ#SzEEA|K{oU>+FWmtYr*N|WW8 z?{3~3A5;L!>u0)S!khR+L8}yYnEN*pDb=Z~EL;M~);igCID}Jp{GD%ektK}Q-7ZtC z>?ZcqtUtDkvx&wgBYm&PO4^tXwlW@fh|XvN0rBF$_@C#Z^mC0NM|)_+r~Gd(YwQ`M z9TtohJYT`j5T!#2&m!_)l-cdI&BFY1+Whn>90 z@71|KgdaF9w!^@&PjG__ zSc{Q9KG%H%+z7l#-DQ4ABbQ^?ZPb=#m_~~l&&qwDt6DM>$5aq7+*PjGD$tS}RG1$M z@1C6FSJOhPYN*UuS(1wpW0j$f$G_;U=joY6Hp3_5|D!eJise&nhPJ~gCOir; zh7QZ!cG#$iN)zNDn$J1p_=HTWK=b!L`K}vL$!xo`CONzDiSgby*UkK&n@aGTRrYIy zJ{i{Hktm$4O{&%%>hL|Hj~0$7SS))&P@N{UxrL)H3K^hrN%g!7MT;{E%I(M($9x;Y zkC7@iYx}9)^xd6QEIulg;HxCLc=X!-1=sDK!at{3(uk+-E z4Y{BHcqD-hwFJhdo4r8PYYlx^A~SJ;g3~k!`9A%qd*#Zo_9O{v)WHX2O^zs9UGNt* zEEnNzERtBViS5|R?^c;(bixZ=FcRGNAS!Qlx0ZiwvsFpwZK{0+&Pfd?NrvP_(WKP4 zoei9YJ6EPF=|;;>{ldfFmNt@sU@$hCB~boNrW5kz|93@t2-8FPBR(X|I)?(}Fsa1w>$Y{#OYYAOQww_A(EVt?6^X{k*}Z*cw29?hrd-SNXNe%=K(O< zCPNROuKW6rt)JSuEt3f47YuM&-#8F48$`l zPYd-zNQoA$y~la%4j+C=LmS)x&r`D(PB_F1KBwv`RGPns+q!RK{B~sN3;PyFx{CZ# z`!Vxzo3+EvFYmjLrT7PAzUFGFK1BubmZl;}VOZg}6ixL2b0|?9Jw+%ZTnXj$gfmUw zSMe9UFcIwW*cNat$y5%TwSp=Hz>P`&*xpIu?eo&@!f%zZ2T-!9 z*SVsN6|6&{m2+j3XDwLg8eR>5yUeKyUs-cK|+AsCU z1=3)z9wTzKeo!DvS-uYM)X<~53fQpU9SF{}X@O;$h12Is9&aWW?iDVZSyFyhUbQ*UE7?uLI=XqoiY^!q&ly6s}& z1%$!UTUl_+I?Ak=Q381npv}Vxx_j4*dw+H6r)G_cOEG3PPrmiZc!6pf@SDR2KuJ~_yMSP_O*3o-D;l#AMCtXdJty&d`B>Gmxk_@e~B|rY-9TR z@bB>7sA0e+p$jK3(XM3r+6%H#G%^?!;{x-qYWqJ0Ubr0OA)QA6I4bDb{&5bp7H)v1 zhleptQTGmszC~tO#BT@7Igp<}-xX#a){*4Ww1mDu@4p;pWbx+ODU@_xZN5l~n-FZ_ zHN-=4U!bV`<64%+WP9K`eKFM*EKZ(I7KnlcWhFP?iOiyN*ImIAxBa{m{aQO$OJ;k& z)Z&eZ3M*jb*3h{olm5l5A$x-WrpVvVFzarO`r^2n6*+Mj$Uc{CLbj}{YV+q@Hwdte zD)CU4A0gzga`$wQbSAfYHPYn??c~fNz)~G22i@m0+c)a9zWO zWiLpd8Wy=Z)lx_*mazhXsbt<-I%p)Ft_lORe4D*)RM!zq;Gc04CnQl|i5Oj9I$yi? z&cbc1bvFqmGXL_UT5yjUQR_*|`&*Nl(kXC(lud5LE;G#TbL4l(4HjshR{UK`L-m_5 zp=)*h*kb{!>9FV*eXwzO*N8ofhWu(DZg&Q+e;MnU@Z zej)6o#G_>r(5>@v8J`-}$_?Q9AJNANrYcsIU}^H=9k7}9(66xFudEAEb$c(V$ScmW zXf|gy*~=B4qX(Otq&FGuSNM7#v!rSt5?e%r{RU1*#d;JXR5MQgjzTlzxfrz6;?a_d zZI|!9ZDMf+z>%SzV~`oI_T{L25!F+Xv{@+vtR5=SxD2?&Jkqp?13WEj6MUc%XjaZ# z#4Ya5>06}*x~D81|6GQzt!jRBM3{z}K;000NCL7$dnltf%B{{R4Al-LxKX+KY2 ze*+MtaOvUz5tYb6T6QncN{kg#c50j9?di^R5!ZcX~he+n(ce=eGNkDA?)TiY#A1FfcXQznMuWU z%4?r>32=?+>s+sr1o&6pHHl^r&P8V-s)#R&0?X&Jp(i1FKRtW%?abh}kMXX{uxxDL z1Oc@&Db_g!r&D56KBykXzu1q|>bgN}%EtBy623Pm!t-RAv`S+BY41`TWifc8 z?W;xr2O{%3uVKxNEKk~@bYr>1@6r!ga^Ng--yP*jLC3P(NG=-`kF5V8x`M25pe!6i zQsSVUJT7N!r#k{VS>PLyBa_t#zo>&}zw-V1ZZ(K`i2&)NEHK3A``eWkX_E<*R+c3QC zX>4eS>kZOJ74J$2zWh@4EwG~Mx`#OCb;l#BSb*V`7;N~u(G_t=5K{E5Uy+BHm_V|R zyFVY}fzVXnT+TbXM&%~;G1sno>3(?T)|>Efjx3`q3p&mNBBrj;@dpb=k3)rtgs5z< zy?pgpzZULG+#IHWJ@$q_PjxlEej-PJ@m_4SN<#Y%J-FIO)QBF1b zr#N@K7p5eV26j&FnPIod{57GZ(`^2@DswTA!iWX_YbKm4i;SL^Z>SV|R^+HUbCn4Ap{Hv9}?dHp}vs9$h_5c=)(PGs&Mxj?^i4ux{ z5Iu&vrbof1Yv>))yt#sdmU`*0?mbz{Fb@dP0$qUotbq-%8p5* zko}l376JyR%N>BaPN0zQ9Z&@_VCf0y@+)K&g*&vr3HrSA?>>#Mj1|3@28gX+%1-@Ie0{Xo!)6*Y`+$s;m^ z!t6U-7xsFKhVI;D^_i^)NeesQV_w#ePwsG2aPxXAWs}F8b9O9*(d`PT7pT@DEIetD zcO?b5-Ma~O>BF1$a z&{tbTKXMfRM}S4vOe@sx`>-_l4+S-s&m<-+KxXftB#M*d8pJZ@z=tJrL@}tl_EXd_}R_$NLp3ONuf@aSH_O<%6bT=^N6njCA)A2>WbB!nrv^* zGz;g6L7IN)D8(OdE%?BHe4VOUaqo=wnlINDAs1BZTM7M^8b}#aVouT< zV{AjCBRP9CHph`Aoiwz5m6Oa9{WEd_u(P9kW(FYu+|Et}kAiuI$@z5)BpOCNRs>vCMA@QxwY3%}jaCS@%pg}4G{RNPo(@luArZO-R8d9?M3x=)4IxAo;;Yskxu1*v;H^LHxe93GRohL>5wXM&!3a8t+yGXB9yaaH8* z48}r6a+Pn&xISQvm5~${C_P&V+?nu^C~{j5HRGc;7YwUH*}P(!G7Aq7`Zm%#K$xs0 z$d&;qaywKA53Z64UTai@`^5JMv#yhhzkGemrX0FR2eAi$Sgp=6=l~G5gqi|yFsE7J z6MzcbAJZn14ntqH(U`F8V=dz#L63N3A#a!0ohcw>wDI^BD%yD}*eO~L1($__#keiN z>e-wmWQCRBET`q^_i@;RtMk>i-_Hgj3juepe?!hpa?h_?gVc|U9#-`41vzclkv1y3 zM@G}DWU^qMuq$ryB0SX=1)$~g&m_}^Tv?jorqcavPQWx;cd|!dOG{eCEsP5?!-=uX zi6j#9`P}kvKJlW;@VJb(pS-~Y(4!4{zYk59mna&CNpG>5N$->Sb9A^P-HZ#9w75=8 z;s5{x00093M-S?9moD%F7lF)42VwpI00pN3pS5Wap8x<+&j3gM^1L)E7x;lV1-5$-Wlbc{@oO_TutpSkAT3~~od ziX7lGlK>> z`oy+v+qOHlZQC|Gw(WH6j-7OD+qRRN@4M&R@!oUB*neQJReRU0s#$Xm=KX~BEY2fZ zM@LPpjVGp1>n9I?gNDxS4%Rebi}Sia0l-(E+VK28lvscDHD8MH%F|T zo9I869lx(&^qv-2bCp^1u!{TbPVM4Afw6qFc<2_a6&@4P8u$U<=DY?GVf0En#HO! zAvx%_gNQCJ;;93&g0B!n!)W;iW440G=eTSKkPYGO2s5r{Y zkeGz*as%SG)D>B)ceUnWny4*v|FHOtqZJg5KrUi@e;wrcbt5{pB2hv~bLT>CIN>kQ zUxOSaHS@{FyJ)*hlu0aW?Mu|*9$bm-eDdzEg_FS7I%>E46fZnaVW>}6&b1Ax=?+L$ zq66KEY}#J*QU5-6t{#Sbdik^hkAG*iK)K45PTZk>dzCeHV}<<`P8-H~D!;K+b9-rk ze~TuSgss3jxxZqBNG#GZXmYNR@k-pWL&Vk4)hXklJm|Z@t!cr(Rjo!=$UX4}qA!`( zYkL53a0j&YhLrx}IuOKD%EO^)Mx2&wuOtGeMyy;=G%08maXS6`Qe3zJ>+SC;bqFAa%pQ*wO)h{si;xq# zNr^}i4HIl3Yfs{84hx+Hcuao}UhrStpFYKoOhHN?Cx4!&ggwSHQnB)i2AGbEU!!>* zRcv}NLaz@}g>ODZyz;s)cgN<^6c(dtN=7}74{K#PN`Eq8|759^E{)^p5G98uBBh=Z zr2l9RfBz0{c3vYL3&DE@FDYExJpBVpD*(v$nQOpU4C-+zZDVM(b}^MX(x>GgJ~?Pu zI+29I>6@%v*jLz5!X#99fxmS7r~ zkuDwMHbb(#F9e@HMrUXn4F5otUK|6UIVS1R1x6ypOjUjf+IqP74ZA0GRMBPgzUYc4 ziFnAG#W(BNQ#J9y?z3j2V|v4OVr>d0>TOfGm-SZr{fIbtx+@$0-uC^jRjVZ>OgKO^ zP!YsrM07;;E{$a_eR+QNaOo#3TbMXVnA@V)U_v|4`#=%_pyH#BBAoM(7_H)1qQKpA zWLm-0b!c)q*vzu^$AOZ;fqg3au^Q=$cK}c^O@Ihadc((HnR`_tI`m&fahK1PiF9nB zLyI1-~v-Z$z#9lI2x{B%%NubQo7 ztG3-h7Jr6b`x`X@{S?c`4a4HE4$|9sU^e zUw>=R#E~Gye1u@;HuoRL8IT2_yw?BZXlkLbG)Ercup&AvB5od7!6Whwg#dU&{DYB~ zIc^x%j?Dv~6sFX-NRzs^Y!Yy4iT^rD# z_anx_g0Y6)TwbXZlAd}mMu%>9)?~%1`pPb0Z%Y(~2?^dQLhYK`_qV^u<2N?2m<6mq zz#k;-Ywd33uyVE!VI*Q(@P&?Am$ZF=JFujndZMRYpm~4fKNGH@qW;i%G-Qqa(xbtJ zn{bAbIkk+Ci&j3rLwb+D!5x>J7z&W_X*KNaY#x+``hcLBq-VLmCP@S#Ez4fWws^4e z@^r&>Q;gl9gYo^%b56;*-yZRl^O~p71*XzQ38S`W>gdAlr$vP|BUiC!|As5dR`$6_A`VTmHsB@XHJ6w`rndkDLoHRYKJ*we0>WTe1 z;Z#Z4iI#_XCK@+0D}N&LDEiv6d2(d7dNW@wN^umc3yDA`Nt9N{bU<-Vi<~y}#>Z$^ zhiu`o+O%6u?Zi$65NZT!g@rIfzc35SZTUXmE2h9!K~VOr z#MZPCkszpXs!v=m^>&uK%O%yt!(xIocb4f%@2g?pcOu8h+~NyJtft#32MQTZ` zmvizP2;5fRZ|C8oFzu^O+lDfCm9F6o2&+gxvuX%s^$K}>D?h647vK#TcXX!k2WT4- zE`aZMZOg|4^6&)DA!MlzRwYcktpxj=FtDD6vgsfKLSwzYP$AMU#$(IX~ z(z000kv;vT*OH!w?IB{9=`uk-qox$jy>oC;N%DGShoy=b(yyH1%8-E8oA4y z=)liZ8rM=ae^=SDkZ&|HqJp11Mt&+ehk4^ z0O?66>+k<&14jL;^Z-B(WOx|OD6)17N^jpy`}1OWIer7xz@;>`a}K1QJFAaVvt~*5 zkGkiuWm)h1DDMR`XESlIl1!6`lp*`M-ZdE4r=t^f2rQl^OI;-rB~xrNDaTkYx5Azt zYa1VSq@8~7Fae(pCY1%K6=DUW?<2e>1;eMD6L+`Gv}%(&{7NDc$5x8h44kZ@6@QMa z^z6Kefw<=23u4F4Z&``3H36=ug7WxMv6*uy00-!QDAfsJJZyHg$5@!}oi<7obU?2T zV^cH?w+{0NYlV*$GuHCXcn}jwC$dSXY=it&)RnZG4pP*Q4$1pHcLKhpxkcX`n5g_q zVPRv`-)qseMmf&!siQu$ISTtg@|T$#Ct{N=!X8UB6!*s^MeTNo#*$^T(%nF~4wcja zn{|S1o|-DFKdj2)E92X`5QUAt%3qRRec;4zFVkmA|Bn61*goD71f6U=ZUcsXG$hUs ze4m~miJ_Og-uRKARp2`8wrzO-Eqox^@oQe}(&S0k0(Wryr5!SHCB*)8GArj5_>F$( z{db5#Zv`~7TT<(Rz5F@69vQ1cxnh;ct zkh$#=&7P?}I$p>@z zV0xlJZ(o@PoP|Kmeh7wdUBpy@CYlrA@pwk*oHe_Xw)6v^TAW~_{dRL z3FoPr*j0@nmhf+y%lsWX8zDhHmu`ewa7F1XRkO#OYTe2T0t$1@of?}j?kroj8E*w662<6x{RTY_=u0cC z0@ZA&28swUcgZ`O4(*k^OZB12?8tTeTAf1|w(DZMV9&Dl48PZ*6 zDa6>QtG5xnXpfxf zi&D+%P5aJGK#)<|X`d2%xm9GrxMfvX(n$2^toF`;u3H9(VQ-Q%3$CZ?^B|G_vnJF6 z;DS6m$~E_P*ZR7U$@A@pOrH`xOV!+6c3;uwb0(I$OR0`sQ5!7wU>Wgw%zKD!$k6&* zk>!eA-9FzEE<%<_u|F;=z6@!Jot09pj5}PjcWz#W)*Dm4MOA|?Dj8KBDigqD%1aYp zUW!Fvp4pKV`hrp?TsfboMH!6R(tiAyqm+u;s+fsyNws+&xr5+V$HHh4CrY)`0 zkvM_jGDh3dsJvMcHlW=`9dnmY>VbpLfSKPi%DEoprDlFc9%srFD9lE%rRIb_b!byk zg<*fo#0LYOf5+^rKy0nDP6Ux%?kZo!IE{IMPBy4z*f_y>PJaqL8c3F2+(!A&J5id> zYdl^7)g!f$Co{vAzDl^UCF*yF1_*}*3Ow7LmvR1Y5t>f3%OGhR-}k?v#!cKuc7Y*u z>@USQJO5y+g5vW&rsGz_ z+J*Wjh1j+=-qV!T5|4lyae^;=4V-CNYBjnln3XRjAL<@)Z|W)-(s4?f$|dde#@A$> zZA>w*_R<`xN<+=Vs6HjaA0FpeWi$@dhQgB3*`tq8`xNFFc>^Cj)LH|#M}DEGrc~N< zZ&&VYljBohh=eIqje3gEzjy6s`N8gfJo{K{3+l0I|mFpj2oQn|(?+uD&EMdHeZRd7FbhEa1 zZJud#(c!5PqG52wGsl>32vw-sXl>|if+AH7o}ktAHQKxcz+W+DV{T_6pU4(Y5wVTW zlC8?vFWA+uhkeSwpv^Qb8AJpnudS=Nn-L3BTx|3px|V@KG(UB@otfXGtKB|2zQBh= zrce22ev8@UF{|+hnU46JRin+>mC4R>r@8f#IT9?T-S_oAohzv9mshS|^4kGnzilr+ z&gNI4@NjUu-!}Tf1>@1vKzvx6nfyJ=cjig2f)89Kw~>?1ibeAM{e3inB)M}z@fpU# z&&+whT(Ng<#8yyf7){C7v;pZ2gG9V!N(KsS=H`WCamch_gcs@bVj2}LD`P}(R2HG> z81;7vAR)_@`cHkB=@?DemqZ62m~+nbI+ZU#=~|nOUeb=#})gE$xHoAsTHBomMaFN^;pcl`RD^NkS#)#o_DD)h88>BK{f<2XNC-ITQZ3~ zw2VjutdNr})H91~OVqOJ{@-7iPXMvt-`~x5Wc+NPEfl~bnzZ(b-J7=y%bAb3R2kV# zG{YFssdsBk<;$PdBxOF|dHjR8XRr>9s6*qHxmJA$l7%*QdSS$$6K3<%qPt%ZDOo!R zAfRcE{{UjQMyn3#TI`|gCMTk-=bR?yuDfXO>~vlpQ6oL>A7Q@PtaNH)qSR|R7j2-u z@M+%zliFYrjphNt*}38rJ%r00cUQxhs37s2J3+amf@(fcnoYD{DSA-OBj%lu(bvLMId*jDwdmq|1fd7=qt-hJK}_Ct1^sqDgDvdKztJYNZO4 zUp@0x$@ZSNq7-$Zvz&VSM;~f}yXnRsO5uQt5v77=@BqJU2y6TO2GO(n#4LkMNCv)4 zbiRx`gUUNuP@ZU>))%3{t?ZP+`V?mhddxE=CtX^cerDrXq9R40)qVP;q7=Aii8;XC zr|J`zDdbIL0CA0HV^xdQs0as1B-UH3dQzyQ9H?z1f>G+vpGiTESkM(R(}_6jW3jh! zTNcGayX3~Sj^}mM!otvaCPaoLzuHR~%3tnR*G|J3DylYki(U3j$x4%|I~OjwkwQ~N z`eDMZ3Ay6hFhK(I2sQ?m)^<=b%ZZp9sB4hwO)wTwKokcXmtR3V#}Q#4YNBw-dS$GM zgn!qN2{MDJ=HZ{vEm55(PhyB)-Mrg952H+31(_hMGZ)u`A)$lo+d<~FMepuaP#;fz zceTcjdbvUE^)+O(UV`5r$H;Ze;|oY);D>XO`Xcbx$G{(Oh6UwDJicm_PX(|x@uOB< zp6kDiaN2zc`{{9;UKfuGxs8)^fAd8 z{vMFQWO$tA0%UdpEx1%ul#pk%kDtae0n58RCrpNW+CtjwgC2c6hC>ztjkKMs2k08V z@LvBNmY+9$IIRS`+ds%dk9oQUIz{l zTQn7(LZ4R}P{E9Xdd9$#RNTF!hD9}t7RApHQ+zGmL1~g0&4WqDne0*ydp{D!_GTE? zKffc;q4a<#We~u%s|xilr%TVWE~2$0g*(}+!r7(zZu3uxmc##0Z7J5Aa_&rJviwTR z3o9zgn83Psu*KvJ$IG=J`V;MYX9#*9L_p~dqkQ>+z8&hQChgS#D4!Hm@%Pi{ys%s^ z%6DR)Yz>ne^~3^1shhvkhAfX^C9f%3$5K)EmV)!;9|@(&xvJWk+LdTZ_nuYZ7CMmP%Lc z(A@Ixbmp$?4*Fu`reOF%6N1}-eQT3dqW*AU1IUg=ipzj$e`rxRJxu0Skc`E=^Og`GkWvu`HV@|5uC$Icbp9Rt*xZ-SkYCS<(Fpz zw9V2ReOw~#^d zj|W>-l>&1OG6bi)9bCjBLNb&epV&k~8e0=OyUsDMJ}X`Ms;ad4Oz*FHAvaT`+=uy( zz5b`{@%R?tXB3kgsyJC#ePXay{?0hp71X=aI07*_rYKPoHPF2UJ`-c!Y9B2S(P%Qy zm*(1qZRw{=o5O<4>nc&}p^L8wGnlWQv#^v>I?ST|X&lEA$Ez0o^xyj#*-V=*1LzGW_@kl2Ca|g8i zEaKjiZRV~E)SQ?lXw|s+`tP(tDV1t!bcu4hbUPvt0W?>=s}f$@n*416ZPDD?hNvM0`4Mz=t& z@Kt6LM1b<9o_HO{O)mf`4ywB>EgD1tDm&?*4TfM8t@7 zj$X_FnFB4-&N^R9{B2QCw~ecu*>q*;{^qgCY?iG*($D}NM^e?Pl|D)Aky0B$*ROmf zbw-#J1qaV_5m&WxNp0w~)JeyrIgaMwNZX4v@D06pa?2#Qa+S@+^h}&i z)wj!ZxQVylltbB#8-Zzz`c~kWzZIFrCq)`kFq-qXcZnpyBFXxkYrE$SOvtvjkWDe> z#|=bq$ZXj-vMoRi-P-GMAk%Ayj9YZ2>}$^_1j`~jcc@2AQLTz-q=iy^@l zg&|z;IAGvhyQUD<={jUGP*0pw$^H=mdIm;nQ4XPgJAkKIq7`$@8t||qe|z2P+?ImS zmH5l|V-#(il$r(~0p^cj@>+<5Fn>~5pFOF??u(Zw$zXzt3ra^+&I=sf9r4DUBhZTE}UJs}sjge&GWxqc|+rMu+y77vws8BV|YlSXH$Mm8*X zp1>#8&LC7oJ(uza90LQ1VC7I&oKU$e-Xx%27dBR1R15>fh$`>f`83}B)CBAhV&{wn zJACR#nmuRWRJjQc0JQugz(OUIxAwpJGBAx)e6Nzr*e+K2B>R${maE8ZOJh$asf2(4 zD6-B`bH!rc?gO!|AcmC3J#}vnu8S-4^wo~T{*Z&}Jv`^jZdaLtZt^-!j4N<9WA?Kh zJ)C})9Rc}ZV3vkj%-^^jAAC@&h@j*KcEPtvaCG7|Xoo&^d#B}p&>Nmytw~xM66+@) zr^S>Qd77-n=$ix7*j6;46fw_QH1dCP~olf*dF0eQ=t(rJS8}Ia{Ex zM>_ z>uDnJJh>!IDysY;L0XP|r!iu0aqEmPS0d`&4*I1|ov?|U@(`}8r4r%i*v!nSOZjN)P`uW0 z4Kx01!4WHx^(@iA{$m=DT8gA}wP#p_mRR>dfbkhw%D!_8LOK-8S;L;!34{vhTn^;*!BnFJSLJg;riHf7lMG12#*fcO@t4R1hVU9n#GqQXevlHD?bx0NFOXaGjD03z71gF5*SVKS?s{g)8x zuS}BQMXYW&4{kD}2+-6UZH1_ZZzk8P`3+4&`{eZtrISKa_3D#z-qiAKPd8Jh=U*?R zW%x{&TbK)fw^z4EDBop1w12H0^=!(~@ng%jh1S1G=d zJRE9H#2+p05n)MstIOXHphtLHET8b-`uDnp>RE@QeJo924Pwz4d;ZlLV9P9RH}sHWVel<1yzE7W(Tky)vQ!^*1pn|s#3b@$7^^eO2D(ML^{n$AY8J^ zq6Op}KT-8D_G}53C7-o8(%GWlG1J~kjlVkZ#PnvughEc1reIN-SUh5hG;wJ$#E?qjL?xU2mcaep}X(%?f+6--9 zTT!(VZkIZjXMNeD_(4~$=aJmVjPJaI@@xN>+>t0#h>8pPYbReP-co{fiBtb?3TJL& z;mWHAG8Rkphq20f?#Y_B(7>kyqz$I;=#_VV0f7L$wu;+0$dmmMgv5)%l%yU05`5B- z8o)RA^q}IG){6E0ANbtKMxDTge6kO}!#TvCSeLmlELjHt+*=yo0>+R2WDMW<&eaG8Vb|q)G=1Mzg1%!Z+xik?r-bLg# zGhy6%saBu^hY4R1)vg-B*Ok5%hhkV4`16K;su=^#(4K_v?bRNtVB+BF!Pe zNzYtpkd6*?YBCGWg9x_#kV{Ehjox=a-9~h6NnL{(h`$F5^xDBpqx*wW1?;SK-*dJ2^H`kzbAql`Sv*=uCzx(sq1 z+5Y8Oj~<^;eZ7S%Z(F~XH^L)qKdRBEW%k7l`TusS7Y)*mEqVNE(x zDW7-=OzEu0w+!d@=^>ixS$2~OPK$Vj`jt)|6)W_c&>nL$jFD8yhwe47P?Y!D1o3fs zutKJQ4pG4=gvpE6_7W5nUm*2+DN6VBxMMF6b&kgwM<-<%e5#b7v#o@VLs<90R>cqJ)46fEKwDcxu+38YplzEdS9*{S;5 zK~Hfi;&7)@-g&x_{Zax@20>dehad@dRrA{RwyVmRjivz_Z^Yu)4(VJYKEqobZtQuy zk8hn}_~houe&<4HKf$9m2^+f>E^)wN^}Cvl!pB6r6!JnHU|A(YG3O00v8-x%vZ{2G z5tfYBPn-fO=p7X!gFzhW@p==AUiSLRfsbrC8tjBJeW0jOX=Km&(=_1Uv6SMB`oQ-? zyT1B#gziB>cdY#w{~b^Hb#*dXI6LH$?j>VSjm0nit_FKzp=+YS!riWZey{99TJ%s( zXX_AUeRReVzNuP2Ud!fU%f(BL{Xe3G+|rvGo?P*6_XRco{z%J4^m<>9>Fq%90!&v zoPm#ahGC@_C!V$ZTM`}b=l;?)on6u{dX!5rKj|g#M~YC^mCpYx4fmNDjUH@AHpqXU zlMs_!mY;R*ipd_3%jURJMVe3|4SIlDU0Fu$&0N!lw1`^*-(bDQoiV4vkOjMQ6Z%eE zi>}Du(}O+57APZqy&hi(;Or;D)j>Kcegyof)IX=oxBY~^7UzH|C3)1{mqQZ!+C__c zCVlzMnpKCh{++}wM*?$cHffLF&c~E7C%ywA?%$1zR=f3Pj?nrMWj*h((4>>ue~4nb zzmA++4LBGxA&UssujB?OX79xH7yhG^TvG{tN>8AIKusLm%B1mbC=VY01X&_sbIA3= zIn*?@{mPvX5z$QgruWok7Tt$TPq}?y?i{zIytQ$v3VEI@ZAMra-C4YKEKLZ2mu5Fi zSz`qLvl2NJjrAUVnbe|`G4H@blim0fCF5WuR{3yb}-onKS-c%sucB+kbe zKWW}+>c!CwX9F8|V*PG7&rnMyB>U>7=iUBCgBgOJog5HL&!9WCQF;ai)@3Ks zw@1EBp>)ccRw9Reds*BQipZfv8y*A+lD(&mP*C3y&9At@DRDl@!&S#SHr&Pb*`zP| zMEZmaRrN4^zahJfqLCuB8jJy3v6P+NW$V*lbgEr+7la5;1RawSYl24(9w+A!>@*zy zY#M|rc)c_;DP1;foh%F)+^}>M z$Xv=0Hr%VXe-~SYqWlWr)cVFL$%Ja;FpNJZpb&Yr;u*{xqYKEb{)Q*3;vjV`3wnC@ zR;y@Z1R}cZju~Vd8pNE$Os{-Y&EYF1Qg^9NFzw3T4}s-eB#&=^$SkFf`U}!|O~fXy z**qObJHtAG+^!k5LKu%kzW(H(#d)>i2{wTfAFOsm`TT15MARf>HHG=FJuu#-dpA5S z&g4bTEb`&;;0+&ic>^2|lSiS2jk@xnRNFM!Nq4m*52u-XMX!7%RE~M))*f!ErHOnU z-Fy5kdm@xGCaD=E&U-om-BgS4zoHP}#th-|v&^t1l(q9e#_}iEA1^lm3_)5L)um{( z>~jCyYZ-wD_B7|Q+c);euT~`;Vjs5m$$`eU56Iq9!xcpITt3YJypoC`X-XwboeKIq zWu9fHQEkFzM+hLySfO#>jXi|?``YxUEe);_j2$|oyW*k`9HOu)3SD{o8WN)L5(}*J z`|xbLKogO&%9;yQka8FI#$S03{m2Q=UapQW#cN3vez<=hkbP*PVuO%d95U@tN|M7N z9aAxz!GKZo5!*B@0+{N=1!q#^FE73kiD5cFL)++{9_V+~Z#Pcj>%x56HZcx(ex|UD z`Rb?N4gMOZ+_tNkjwHl~>;8p5%>^{34j~qu*gWqwpbuXK5M7jWYX3E5qS;DKT2{T) zE)&0*V?0^=71;3f@Bz+WXlMM8x^^4VU)ieB`?m2Ms@EY4@t<{fYlW1;xe?qz@c5X zKs0#KE!b6HyU89@6hhA9gXSZ9hJw*;=>je@!aL!eT-lq*G6#d6Z-6TskRezZaPp0^ z$AmC%38;YIQ?Ce==~N*dutKZ{32p49xf8HB6sSF~J+x|(KzFMybfn&^PF2im3aM|& z=QKGDh#!C+!I5RY8Ip;-U%OF*UpPi6B*0{%1G$Mp5Ih@Me4r8$u`l%fI5xYqs_Ua9 z+Ri*%Rd`jW_~P;liD*nMbO+7{>$j4P#-Y5+BP~eoG>iDFPY_!KEV->k-eM})6LKKr z9nqXY{F7G@WVXr9S<#?`A>9{OkemB!dqz3^8j(@KeoRYc9Kh(fJfnx#!x>~fZNLyj0wZEgbi=r@lUN%=Q7!9|xx>F?QS_$31Q;*NQ3JhJlYS}tGZx*Q9l5$~ z6s%1x7JR{zHOkmrRHgETW$hRf>zleuB=$Ip4J2_8z}$=4@{rc_3`VBFnE|7h-|rBE zb?z0y?K^Xd$-S-Zy&*pIa}BUQR@QT!ghCkXsabWH(8R{;fg7{Y;>+ zL%>Dz#-4W--v%@Kr;0xC_@QGD&(T}h#)r3-^EBy+81iEEsNvl-pha{Z6f7Vf#cnLv z$1_xE&fp)0i1Nz+YkmtdziG60$acLxubuWX@AhOLeTj|~TAtCR)@AAig&oZv<=Pb* z`ryzcboJS3wife3Et8o1w+8<}zS{MOl94o8?iDD8jHZ6O10F?z?$~sRC`2>b zwP}kswcldqj1u)KLL@4A`*~Mrfh|pR9v3>5ux`E7*LE1*NaW>Bzwxnyk04-!{+-Yi zegF&H*IuAme6Wpwi#jgFJj1#lO^s=JGKh-#gZ$M%q(jS?56;o^f$_{vfZ6=ty@~rd zf7qZBZx~Ph37RBZqW#8h&eiob?}aOxmU}s+IplyUd(7H5Jf2*+$^pw4s~1Mljg+)# z=+ay&@6r?F5_n1erDbDHHoUh>Go^2f^nwl7!S2DXnsJWq=q#poN^~)q3>>k;qreHI zigZlAPu(@b0@Bjj8yS;svk8u}a~X*w|Bajs;nO7SD3qENI7bgmJlCYi+Co(SNCB~d z_1tIk7rIlp^7nXkn3XE&@|)>D`qHm)P*)!jm9JcJToboU@DW3bdHQ3tki)Sx&z zlT&7}XaEMRHF`qR*<#1%V;xikkCZ274x<|!J9pv}7{&i9@umv4uWJYPa&csH_{=T<6J1~)}^!DTddeALBt z&RcXkOynSDig{HN+K$TXWNyl70zXnzG|i*0oEP9nGaipO4-&!L>b6k=ADW@@^F+z( zoP}Jf#wSct>-i|9(&g0Tw#_iSSsO_(89h=Yao5JRAq_-zyI@A&;nD7<|!atRZ0zvREaag%%$|KDTirUOv$a(+z z#zeYiFEqBu(Po_hF9?SsteuZi)%O7(iW?ums8X>w0OfDnm%d{?e#}&iGOBT*5TR`?mS~b`Y zatd&+ys3Y<**QV*(syAnfaMTSoO>SuKmvbnodlWa39V-z_|0e+}l z|J@q29Z+CyibzJgh6Db1YOYHrE*Q_((WL*#hNs)(rG)=L5TOY*XIb2%<6qPoAJ0q| zZa#hx!PDN5I7~ixM){PFONNOYaV@EAw=@J{5ikerd;%fK2{YbcRWZmL0@#mu?>^tQ4|hvXsCwzu72ng{-uC4U)V4Gm>ZWj=H(@X`c$)inpJYzu>Qf z##T{D2BlIgDSJshFeeag z`O))D{@-=WA+IbGGy^S3@&7l>5T=4nE}wIUO^kEXAc zwJyoHvv}PSG&mdfd9C`^GfiQT%9If}LEU&SyaQAf3)maQvG%H9u${cxevDT3L`?X0 zuQFS?>n|OlbmG_cvW|IBf}w1CLmxot$_O$lVv6}fIXHC__!{weAq|qmEE7w+dYitS z+^XLP7hh8czql)JU2m#c<}K+v3*@2GlC<7!|fIq7aFm$iWp*GZ^1P)70w7Zx59h zrBmMP_0l7C0yc(h=77n|8ei}_71-Pp*q>#chSYz_okoG~h3OVW-*AyOf}rZa z3LShCuj!fK9+avOzFr{kxeaNvZ`JAfHCL1ZooSY$hk152WgUpsbZ;6OmwvByfZrXU zglMmfG6Bq@Gc6+}(4q}p>L4^RCoaR)4uW1gWT_LD0ov5s0QAoR^}#kLYWzoQ1}^&W z|2{+z08Ks>(N8OIRVb76f0QOi^3Zutux8AP2lwBtQ1!hh!~p=hXnpj}_=uLnD0bQ9 z>(FFQpYoO5rX^hB%o+T-wJS5-s;(-5Kl9D6%08$CgEPEYe&lafkZrk%<-U!x@sgS5tQW=G@Xv0F3vhh z(_F=fzK*}0j7DB9=LdV7Fu|wP=e7B;F^%2vpGnvM*=h})-=p&s+NY(PW6K}N5m35( z|1mubeDQ%RKgAH@GV)^+PJrl07&2^C>*C`{<7AgV1TF>X3)d}gX`gVR^_D^T?FP=a zsAR4JI&vo6wKihpu+VNvGPi@gfd?T5O*Eotd}v%$AlXoSaH+ZuYNDX+=J-Trpg?pz zv58y}zYdNQW^lC_Lw>OE&}od(YTVbU#@;tOhrl)M83!8P9hi}NSPmPgUvh0rBpYK= zl0j|^?mu9gOzz+NZh&=ra3}+(p@3z|cw+t+!HWOdSPR3q7w>Qv=IPHI_#vHDP(gzn z6gHKw@WIo0McQ9|pE?Dw=R{j{1+tP`rYq}CrU(>cTl{oZ9bZclEV4x$i28F;sou>B zPB!|em!QLG3YM>)ObG1bL{jnvEK9^Ubys@D*do>bz66EBT%!?NN$Zk_ zfFYRV{N|{IWYE2G)L8JsHM0K41VqKI3qe2nDnqey7}=`V?mG+Zwzi&B=J(u`e_zNBTk&~JXh#NC}EYEWWwVN=Sue|)| zt5(HIg|zJD2ZGVhxRH^P>)><^vl|fW`=X8mv+N)g@S+qM8N#mF?c= zGh1WcPf)C64-xMpuMaQmA%ErXu~_P%CzQ9_;~9X4Rxnrs?q&@Q)WySTdG=?&dQ;3Q zAY_YwX?>Zfu69^kT<q}+qNpMe_UBu^E)4$>|rm* z1fJ&|HIMjf7E*CpBd#{puVfaL^=Go$o!DC!Z5k&YM9ZN&3pjl_ zD}GjyiF@JXTeuH4f(;&twy%4A?P(ynUk7iw;CfV@qK=Y>Bo^6Z%7evJ!>d@NQlu{~ z-~QirM$-YDkT(KGZxW=Y#4DHuY-f+%ytFWw603^qc}EQ&>l5$z^IOd(vFV6=1a@CJDv2J+1t+^DPXX}UTGvDewhi{EvmL;d>` z_NVIC85dL^%w1V>Zn7+yZ*<3k&%=%GCh+w1tN&ki;Qy<^BsUHKsPz8i2y3BS;s1@w zpo!2=*pO%nKdiwVg>Lc+Q!o4&q?!L%-Ff@E`O%32eXcV&G!ot=q1d*y0oHJRn}?4l zS4%THI?($HvB17fNY?cT(PZWVEEGz^{$@kwV{Wpkx~kF?9dsGB;RCGe(J>c}tzG23 z&QfQ^EK#HjiWy29dk>N~-UkydgH2%@%^#D~1hVGq-ztKp1cx!d>Beh(PNkZWAh42+ z2hU;^IzN7k@=4fS`{7Eq@fo@V1Mw$uyrDi21R$9eM{uN^GmN>IaBl_6;l$WCI><^h zOJo)Onqf?}D7Wim)3S$>N?zJGH(AWAnUye{EVr)K{;D4%rV_Ctjf^^OleB4+vs_%o z{&BB$wMThM6qFfni8SFObW<8Z8qpBa8^<4s!PEePWDOKcGNMR>w*9xUJy7^Y^>*q^ z8=f7rSpuL^!1~1A3;FLB7t}tXpP?(FdLIA)m;=f+{7-y>{Y%2wBz|t%3ZL5ev<-k# z2b2ewJWwN(yo5G<6|E{u)hP%ly!!O7Q^D5hn29m*1!lf*EnjAuR+#18<(!Sqju0 z9!xn^fZZr4N)nayL@7izr}m-S7+b)S zjQALmG6D}3?FJn#V%7R^X#uku{)iH09)epNBx8_34h$QunF6I=czy8&k7HQLRA<#) zh3jLlsT(`2CX1v0!wX*`7GfQL1O=ZUHapG++;a0-wveZ)coZXOo(D2Dh0&fR`E3!z zCezqdPG z9hm#4$Pp4Bc7MgZROFABluVnwA}krS<2Kx;SYbZ2QiFS%Udm_Lov9Y({V|kfWJxtrrNnm%S!)BDIpi{ zr%;J_;;(fTKwM4*p_+R)@)+G4`>s9b5k${m*i%z2M|sJ{L1?#MiD3_WiIJW@oWLyOI?gPp*fEs?tSR zOG2G;uk_>%(>Usoh;uVM_I&t!8-B@~+Vs@!3Z7IJ?(N&&!0HrhEi&YU1f_mbdrbk4fFVv&PaqgPn0HBm_f196mfsS z8J?1-XdBGM7}*S#7}`5@^PT1NE(CTna2@g9dU|9TWVL^8LL3fs5VX(^_c-uGyZS>A zL&C(S;qYI{9v+pzjAJLXAy(3acA+z0TYN0p8bqCDjvgMGl~&4j!Aj<7mz5m6XnCKK z+#IQOS7m0DTdzvq?6#6&T}Xt9Y$)i$n+|jArO_%k@jQ)1hC|*Y9|XnFHkiCd8H|IS zHL*;r9boW0MiuBDguJWqD9Sn%-^bJi>T*QAJk9l_`EJt5b0R17h5p&qd zuoxt>wNrN5X3%HW<<9RUJC>hiY;i+S*ouz+AF|GYI}~7B(y{I2#I|kQwr$(CZQHh! z6PqWtZBO2;b=SHx???3R?pwB$9*bM>`jM$X|UYh_B*aa|b{WryB#JI3aUg$n@^Nf)ium z(gP?F7Dpj+yVWXuoi$rwM2Vbx@>AX{mBMv@8`U(}zR!}V3Hyfm%_ysrd{SG}mpGU8 zq14Mu>2H)%&6q9wX(^GC)gLna1B>iuqTl|6y9N=WeC-JUjJ5xTY|@F22Qxc|48PrJ@xQ7O2&HED)4OVQUa3Ak}y? z_eZbNHn~@VL4vo`7yK(5>teLkqfv2QVZQs5g}4_rVhKD&qGLmrsD0xKBPVrw4g7I{ zzVk4?CpW*}-D;2G`=Y_9C4q)ZLDfM8983#MsZ6WYq&Y)Int^D)ybd2f2S7LeQK|an zSxLpj3FqF~GhocL#efc{gLVe)1G}|<?=+J$Qf3( zok-DmvlK!5&YVeo<#fmPKCjyot~_(x%>vi6-}6`Azip%1-^Mz6G7Z4LAZ{UcK+ zhdf&2eNGW&2ZDbB9|5gIP`m>)M;IaC9k_1@L(gNmcr8go$>2{-GxBO+`c_mQHZHi4 zjS~M_Rn|K}%M*k6Bl+=ZZYZPo0XG`@l28}Ts#EGwC?u%1u%TkJ_N$5OA81V5HYMwx8wh)`89s+AYNPu zRogS_8{bG7 zOQ}}h5|tOAK!Rnox|MRRKsFvq0)snY72;=}8Byu<9mWZo+%sZ-a_ zPPQKB8vvnBFk*Q&ScVpD;aA-x>?bu?HKl&YVBpMU%)qNpUc+#!$uIK6&*HgY4^<{< z_|W7mLr`>c%1Zk5cLJaj>Hb5N!k%Kx0Ub&@w`436usg7cqS$tZJ(`6lg8%I-zYlis zCNeQK86RT>)`Q3)r)de6X~!6GX}O!qOq}>Zx;TgB?6}|@QLfJtdRa(BWBm@AbJ&(B7Ou{9!Z zM_rfi>9uFl&i8~isu!sAJc3^85x*c8RG`K$XQGM>de=p!t%3%MhZi^iKd7Jm>ZK(c z%A=-M+jt$AvkxTUyc)9~Ddzj~!Fv{F;fx-#n}g(;WD);T7BrtT6l93}7ifVF0(>#|t}E&B3or)k2P$sZ z$cX4`gbMS|_DF{(kfi0}Z%ZTHBKlS5*gGLU3Qz~%GoW_87+mx4#)^E5+XB%2I<~*Q61k0SxP&PNi5!)fw&b_Zw{4lIeM=gMd_)pR@tesyK zmhRn8+X*B4phSGtvUYF4B}>)j)E}@=1s(IAlm`sKlbn6Ga#1KTbri0X_+}mh(cVG z2Q1U~zY9c_`+BFI3!K%u>EKq4YA^SMeXU;=S548--*KT+k;2SjYt%$crSp6D<#Wc8 z*}z}HVJ?GI_2x)=6Rjs#uV|>x!#>a0ofHh60jWK#U2}-(1W5d~<*INyRD7dfYRLen z1#=5vfsVl{ObDaxZ{O4q*^r6=u)rM#$S}?_WW4wpQo!|W-G<}?Ju}x^j-&9I8YuYC zwC;#Ud?f1WqW;B-5%gK`AE^5k@A+yE>Yt)VS}JO;gJ)Uik$~__=Sq^3xj%7ff(|%~ zN>%uwF>pvHt|*+b`>*0l5(Dy*ty;av?Fq-DtQyH|%uMs? zWGlxn>V464)fGbXXpD?l=FWoDV_0B_TtddG^4g(l+{S%w zr%>80Chh}!r|)#Ok~gA9-KZoLGky{rwkuUiQ*er^X4;ppr)u5o$mnWC(M#Je_fb7r z#Au`KRZ|ge$Cl!{$YRGgBd9vrZq}yYL(E(}A9cU)G1_vk%y|AzjgF=cbQhuio({mr zCQBo`fWA_J{dzSh8v5*BsH(hpC42OIg z#XjE}xln^;MIhHk{RJyX7{>0Sm!hxS(iax(5*`j zZHCALIilnqBwsXPU@G0asN}YmdHn$R)z~ocq2--%8OC_42&ZF;wS06wOIo`arNd_Z za^HfB0X?3wWm_s*{SyCn^YruR$dCvLda^pV3$k)p=K~y%5peV3jcuOigbJGY7d7`m z77d{_+hkqad-}gK4(~7z^7iWl5mz$h)iX zY&||B0D=O{C*!y#z*WD%K4FC9qZK*pk{$LkUSJRL*&+Dnv+c zJVhfU^2Foh+9xl3+U+<8LdK4a1AWrVF&9-IknYR|2-}!){T%Vxm5L1SC9d67f&L`g zlAmcV22lT2q}Eas1Er89`pxf=BsOA-;OwQ>S*OAJ#+VXQ9v?(h0|8DEDc4Rv!<118 zrZdxZ$-K-e>BY*aHWJRu$!3Pa@w!s4lWwx)Zw6l@x|sOQ`nRC@zl$yv_2$TjgnbY{ zMCGx&Pcvffxy1+_ist*8dZ~Rb-i~|u;3q)OH`n@QKMc9|^o4+j0pd#=VwG&J!>X-` zLy}foYS7cY6FVS~hSa19C6X8q*fL>X8r?|#DV%y_23ah5+-!OGe9}l8met?j)sj@k zbKVqe*~^Z>l^Z4=y;FRJGZDhHdCM|KW^BB`Ws6*t+D8cdNFZPFZP8s8K)o z92@*19()X21&U@8P;iEIgYkeEx{s9R`0K=HTaCRkP%R_$s_BV)JC!%s2u3{SWPlqp zdM*seMX+7~s(RlH<=Ni-PfIL7>m|?s*ZE^1kQ@5Hmz>aznp@-pF{J}(oWeXH^y_Hi zk{Hs3Y<5|%-}Ch(BZo?-IxhS$X-M*Pt(!j`(Qy6%+W*?NO;Q~3wp<6hW2>##a~3dg zidvF!dzI!|zG69w65%kIgsE`H9aK7J`l@xW4LcG>M&ee~WoiDP-G1uNm0|Q~OR?4| z!j`}DiZ-)p3#M4)%!rWt@tJ;LKR<$SF2k4aYWs1c8Z3$*tzvLvE&6f|ZsY066xiVb zsTNuT-5rH@y{5TnuuTtEQr5xN(I1)lAd>+aOH5)XgB?DT)SZU z+}g#@&aMvIyf-w}nokd`quWIhdgwoaLJ;|#maZ9&O5hd+?3T8Th;s%%oxY#PPl!52 zq@<39P_{P)&J=WGbcveFPpksHTn~n`eESs?NR!NY>^Ni!L57IzsoJM{BqW7^fQc#G~rM%Gy$zBUJ0CwFu%YU}ZvaV5`Y+gsqppUcp$Hl1p+ZlziyF)5LBQK{p+vID@WzI^fRw6Dk&i9Uk_J--K%?>zXa@20k% z3v^mUg8g+>AsbO-p9JfXG!~bfuYkjZ!k=Q5gYdd@f{YIgdX8`h7nKNxVMdb9w{@-< zTQOh45D6$MVMAOnswh&yv>9pEwNUlX)j|IKEyE_ydn(}rrpM+Cksh*otuH6Ty4O&5 zk9*AOh#ffjY6`0)Sv1WVwKqrA8wmiVJ@Y47)laSNxhO2C0hoT+Q41Iu4Gb)GBbI?ZXoaa$m`3Dg+)6ip^X*e69&*667B~0;JRWd{xBJ z=v+ShY;`rCy?LuT0=E|3GT>fYcyNDfn(?mJFkf?*cI{{|)Og{}WGKEg`XR^UG&Yl5 zalTE{6Ra(w0VF|2xAC6_%ZG#_(0b2P6lh`WBJ_4Szk0n(X1M8{tL{CvZfw$Qti_II z)(R=A>E=W9qti8ZqYT0->SGrOTB6T)vB;JBE^WMgv#YH*T|Wf*&TvRKW>ajUM`v4(l5^>}0eAZ{ z2W5$$wQw3$gx88TPaYBodLVC(4O4ZNjneogiU5tussaA${hLz(6Dp{zpVEAFu$SDw zpK#!jj}06s37}wL#FfdPhGgqq%*n4`US+fN>noUFqWs}}_MT$gd-GP`9K+!o_0b{^!<6Uf_@h|k(R{DQgdVn%=G?X3Z8d4Z^ ziz)`sOHE<}c?3!5%>!JVQH^Xou_bBr_`T1XE&Sod`RDfjMzA49^`vc=UZ3>z&H=15 z%3c5(+Sefx?eC=+3q5I2`ueEth$$z(_67ve45su0%2X>P~LJ+;DF6Jf^e zVOdM1bb~;rH)PtUI)V9ANHchwiIujwg>pNLkV4Mvr4Uew7TP=WO}Y)okVVSn@PYrM z?5Ynsm|tKmOJr5z`-3HDL+vYNF(1o3v^%G%@;=j89{1~QQh@kdP*2XV^^`LZX@JNs zbSl}`rMgFr^e>_z96Y^;d4nW%wX@$Og-wEr00+f=?z5nzooax~1d?0eR)_5koH?oS zC_VVkDo;Wo;zX=r46Fh1hvXC^(KrG7OD0@q%BS*&dp`p`-MAQE5FE_ zYAIhF2_QOY`h%GCoYKikzil~K*nZtl-8j4ViKjU#rldzXU;15*cgE#T`x$e?gMh!V zpmwq^F2!Ul04WK~gA&P3nL=tjKA8Ts8e;A-g z`TPivsqu=EI)A$lxHA>l&U#_Bt=V85yGCqLZ1%t^^HX|*3H-ST2eyGSLFLer0s2Ji zjvWoEu|8!j|E|{%0Ewu~!CXKL(}7;D8Gam=2FN+wYe@64CbQOQj&=O(`S&il*=DKe z@FR2XVzm~@*O|KDA_@r$Rq)eV&4PX7?J*1<;X-bbe~&Rj3zoT%Mr9>NZ{+x>&&2?J zgWPZpD*}KNPRm3t1=Ca;q??~zfyO5P(OD>tTH5&VK=kWk3nr3JilznFr|u~zAF4#S zh*J-DlFJKa$PbG`J6}#)#q7CkwVV3SxdVmZe#5l?O;#ob%q{zG2~yhNRAj@Ra)?;( zG4depGP`gMptn2fjn#MuDirMFffiQ?p!bo{NfHLr!lTz;q?%L(;RpagbdZA+1EyMS zL&~F}oN6S)mF%K4moMb3E}ZtX_&CPCcS6csD_l5mP6L}BQ(h6eOD;-^FVlEJQIT1eL`kRdtPz7P%N${h z8qS7z$kJ}-Dxoves^EsA$~<@Fmxv%~ZLh|m6ka(1pb$mo_m+KkaG<}lD*M-wi?ZBS zq(!mE{m~fRb>h~evX@;|O-4&8$bB0wZ zzNbq<%r75#H?Qh))Zz8Fa_j%p)uT{SYF+>okvvvT+|z&m0E<7L7Xob zx%p2v#983yb|{C;&VmAb@VlwKnVqjkxhI&+$*61UN8Se-Ou4^oR*I*^v+YPHbq)GL zV+~KH%f*(>1b>Pf`@kYd)xPBYt(nc8U`sK*z12#K6W-uH(6Mp|Uu}+0q9`*^^(j## zv|^%On2UGq>Zfq_D`I#npgh6jC}BOPmA6mb1lH)jg6V?q{0%rO>BFD|w4d^uiI^&! z+YT1cV5@+47!;$>{<9TP{=w&O60>$Z}tdF`{*OCIASpS$S5le!A3IIZJ!&Q5X zR<(DL!XLIQ6W9Af0x)*ZGGe{bz^PV!n`N>M?zyd(`xf?KXOVdvn1U*!Q8xa33;fPM zZ_Ozku3k1%BIgF0SIhk+VrbEXQ+N<4JavY?mosV4)LZvh@LACmLPwolru#Nq0v8n* z*^k;w;RmitjMn(?*udh@4RB7RKu4|a#x!9x6l|j<1>$HgH{J*3WIsew5C`Sj=s^G4 zQ2N=yhy&4U+jZs$r@k8u9O;jk7!jYzq_Qy!QjCjIglnCp$mB+k<<{Bp>8%RaCj;w+ z2&v`S^l{h*2_Rq``DKHlZru^X?RqIwnJwuGOO}I4B zz{61f5#DH2$tro<`}-#a_+pr0z?ZQ~cSdX+rXTq)mPUaXG!(eK2An?Ew$yF;(v<+I zfY+eZew^(P>#FAkH-eK+vl5ZueQE%+yEgUYLGb6#5J$GI5a+gJ3hR_aOW+GR8_K&2 z)X@gSBPUUtb2WY(ZzL3^P0Q|F;|zO1J|iT;1)Bmseo{m3t>fmkY#S^fWs-N%aJ zOaMfL4_Oh}S8Wh^SsGPtFql&Dcmf3O7`8Tg#Lk|JCYfMkpDo@W z0b3Cj3xgI{b8JjJC!#D(v7ioq@LBzalq(m?66iD2%Ew>JGag2f$aQxx$Tw8!5{+}b zyOB?%?G>`k`z^^__W&UqQe!_MoMs?tY~Wxc3;8&0;AfAZiS?x4;Y93O$c5^pPpz|! zHx{ift;2x=$D>z?x2#zuPu^rJ@^Y4ePOe;Ib4#)Df3gq{YmV=W$7~*Guq<+Wz6|Id z9%nti1D%9MysK30V`gp)9-M<&HHS*T;ks5cpE3GC&!e;|&O+m`TTV1%*ZX!+i&nVF zTa)93nykTRT9(9Uy=&Om?!cfD^zQ$Ls?wk8668C=2GEKK5=7HOg3ZcRGbhI-ny%jI z(~E#OtEW-%`n1D_%A6KEw@UA9gLijmzPtyRB%w(e;emW#r?k^Zp8Z;kXM!@XNR?TdqP`l|WjyGHjg)yH1}Rs? z6;x^R-_m$u6g9nLOZmZFT*j74+Fwcv3E=SP=3ZrP>ZA-4HKFa!{bfS|F74Pf^+omh z68R-ovVNe&wovx(JK+1sZpK8UkK&wPo{7sQ6KQDJZ?_e4>uBz7Soxx9Yb4Q`E`M&Hg##0KnDOcmly}bT_o4H{0 zWd0@l2(SJQ_iW3nt<(ZLOweiRAgO(#@~FmSVXh4%6;9omn<0^6Kq(DTp|ZodDeFnJ z;LUdUgHVay#NzhCIWrEPFyBCH%|kL4$CCV*bdc|c5bNqJdyLCz=GhF&WgTBEujq6_ z6b)k9|0F9qQr`}`eq+k4-ea9JyiJL{>Z6J_Jx(DvRgP~T<+`AWFq>w_H>lg@&Ol6j zpBywl3)R~ROMOgbORJpHWwwVtJb2h^>vwQW&UI_(ZvxZPFCB{c5*-9wgJ~}#LJrhv z_*9Uw>=tERaOin!!Kw}bzdF2xBk@&qye3*k?-m-_>GqA@>=3f(=J7BZ zaCnfoT2*b%0Fg^IC=lvsdzFPKQYi1XkxZN*N$l7MUl84QBBBLCtV8s(u@e zEAcfwQOfs&VdP`c)6_~6w0mALzbGEu1XkG27a!J)#x$8d6AfjQ<*fWE%};r(3Z5mg zRFjezpiH)ro?BF}xcYM~cEa`0Z9gY#0xmr0eBjT*@VfPG@D(-Zf)C7a7$S=GLtSldv*{bXTSJU8L14Ol0;zk3!sJL5-|BV4`RNq`n;MST*`SG8gE7>#B|kSU|Y8sXAEXBzOQ0 z*$8BRHC%pW2CXu~Qv-2q->OhEtV(t$i`xzh(ud6)#v3(6WlC4#D-WkA$H}B(4Kby? z$uU?)6e{M01~b=nZreBz(s9}ofSC-9f)J^PdXhN-F#{ANf$ms8P#9pxh+$9iqu>tA zA|qo@+XPZF4U+S zdo;9{Ed7tIlVE%Eg}!e6quxE~)u_R7{kr+gK4h4*FM`Md&?p^-mO< z6dat;n4XAcs_fn;iSFkwTdURi*GC!MV3iP*TxZSF`ogngoFMY=4|m^05YY}+vL@#! z)?``4JKZ>&M(JGlOD1O?&rG;0sC3!w#>6Imwaxsi7?o$m`Aiuran-1yas~NJC?aAm zv+n>q2*k`dpl|Y0hecEMOm|vhSV692o|isCIDHp1>p;+WO)w%BCrpR&`FBa2B&1GS@g!6V01t2|wMTyF%%W7l)y5n+a6NY11Q1T(y zF}}&j@Y+->Y#81Ac<%EDf?wDM<_TS-xD-TbQdx7AEjrQ&SH zk~1catLae6dLNy@6@g!%{P7$IaN!$J}Ba4svDT zwWWHOLUqQ|?($iBU_q|nFU6cn_L?4*RpiSZgPNgwR*h(z zC@id<)erfM&He0&w$8TG6awDTrgN;E-f(LkXsxu@%*UO{U z)+8Zmf{~myD%PYb6f_w7fyoxp?Wn))xTl*JFCx?hz0ujw;#s?J1ukyQ(y6xdew{?0 zzp@G(?8^djOacp_0xT)!R$gF&n<09#p&MGxBhM0kSKwWq;O&m0me};g)lz=CE#N)G zp;-y#sb65&AWBt|KcZ&x+OwC@#b#nDB_P}VlLG;=A5(T4v6-5HVHGY`b7UY%Wk_hu ztUhE@0MrBpqwkr9yE0~*vL4!Bb zE#-OX*aKU1*x5!htX66yQd#g&;43dHVxWfwmlPpiC&>n)c)T1i^ou3dZ6XDJ61G3W;BxY> z5Ar4rTg@gK9{h9&kv|*diNwCP+JcW-Vx;g@oNT!Lv@pkvSI$B=-GU4*O6i`sM@d_E zE}$#!6k=(qmkE4#4T^G{6ZT5(9S0;!(X*qlPt-*Y#lm5i@Q=7}c@Kmx+$wNZmoFA@ z7Dq{Fzc9U{Cbz)AqhZ-`mUBY;_T%b|0Uq11Bl1z?toz?uIkySc;_6Swr%H>+&mekh zBQL{QgqeJrv(7r2mcDU^HO>4=y%(!gm zC!f$ocHR4Nq5L#$(wT!#LfS8^1vs z{cP`ngMOMeYA4vO-d#6Gk#WAL?>`^^+PC0x1IweN{*kW>5?SU+U?F_t@zA1@(vKX7 ztN@xnExkWAN+V6YN(QTOdjo5m^+;05<8%pG()}bS+j7tZ?Isa`8^M_o@TqtKr8wU~Kh%v=Fjj?9qwIw(h zifF7Z_{uHGE+0)oSkpQa(!Ru^hMx1r8BLg-tzK4Xm??q}+bv2b$bJN1@^Ouo6^4;^ z9p!4~*whN4DJAQf-uv!VBuv(B6CTJ0+<($O*2@+~~%F z?YKNLH|WgUu5pd`i6ECMf*K{2##9uM`H)>?o}DO^Y_ zPgct+%f8F__hq9B@z2^ViEbt8o<%XPD21Wr@{nY&EycSZe%_YuKw2iRf9!}DvE|7n zi@gxPlTLg{nZ}Jxc-cvudC}fkymK_h{BAdfj%g6FVH@3kNBtaDn{1G_O5CplKfA^s zIYTP_C$-UspZiCP3)%3|lK7Z_okTC`d$eY@VS2MiBP)AJ`N6uRY?3WMX{w^iGUhtV z{H4`FR6mlOB40f?Ty~jMooy9Rn0at$#p2GpErTEMAsx-PC&^?D3v*hOd{F8m%isbk zYg`*9A6`zsE7I}L5)9Th8$5il(Z|_Tei%!2Ed&J!K4w+{Z;IIt# z38SbPjGr9#*&v%-g#vFxo3C-y8#0OvGKCaKa~}V*)#mlS8~U9o04*b+IezY0duT$+J3i*9(5G0XF0S&lq-0|u;k_|V+Cqa#_O}f z02Xs8@H)gYXHe6M)7sN#^?A)pPt+jL2xwS0qrc_JvmVPhP7+8fFS|fcAAiF;1x{NE zoaf?{7r9Cs1QDjZYYhoG#V)>HKKmlHzJ{x7D4U<^D@~Us~vt!@S@E_zz&@t@7t=f;q&n-cdiYp>60zDWMy+^T@*h_ z$|iZH5A`-IXat8A zn4#;-TZxX!jp@nIO{AS7xJLfnf!e#b#qzA;Rlu(_$GBpQ#4dy`pgUpI4$GFnaMmc1 zR=LAtLXTFzl->|{#jf68@d!kqlYXt?ZPj4VF^g&88t?|9f?tMo#|(E-iLQ_sO6E&m zTRk);-3dPm+7|jx>B&+9W~E@)X&p8NBdvwq+FP zuHnkHi#Et;dF->s47s{AybB2wM976${}X;~PRI|@9#*_tqA4c8#zTE zDZ$k13CcZB{ItI7)xeubM#W&1W-0`HhwL}@&Frm4IX^YCfyZU}!Z1$iKe_Z%PXC)J zIRwW_&ehLQpiMR4Hs4f4aE!(dh$kB_hlctZ->FFXJ>^=c07IZnBoi>WonFd)z%&kcmQCU$_%8cq`;%gaWb<@W87(wS-(ZPo# zsdUSoBXg_(&@z$3k9tP07SFqkm)w3SI`#lZa<%hD z@It94%?H+ZZ@-DWID*JjzZ#}l>Z3`e!(cuBNRHGYjN-xU_faO8zW#K9_+EKu!{+;9 z*smqTrQ`y1LG+C>(8SroB7D`unl2M!Lu#;acspcckPf^L3S0-SQL&lc=MHcCvbnpY z7Io>g|1MHUAYd*N&wgdypjPDru7uNXH}qop{bBX2XaSCdu?)g6ewnzRU>`eZJ?yIR za+OxRhP*N%nPYmVUz_4@(=&Kcd)4j^D%^OuA2Vv#r34Tzn-;xn)IOuJ@!tkz5On7OgD~N$zIl%7)y^?&)p(#$S== z+MEDEham`>4$*GqQ81?UnmDz9kBGMAT}IWk%?84Is8H~U=rTn&`ZGomQE(=nBfz1* z5htQIb*jvv3PSXEIJgTNswF~`mc%0ISVMS|3dU%J#Lx-HhwlNXt?xJT9v z!2gMop}WfoZ9aO8gM~6?q_T(uKr%Mk*c86ldRP9OL?VbLW%w3eWzqziz){-gEYyJ% z8hZkLewqVi0Pz?OPH&(jmSbF4q0dfj`IDQ3Bb}j3sM=k{gMTI!IUS3&bJ?v)l}b&< zZPcqY-uQnW(xqKn5VjJ_Z`mc`)Gl0K3D#$L;dON*rGqQ92*GY#S~CQ5izwDtG4~KN z!JAL<0`Sg`#@)mjNbaWs$l=Xu#54C(b=yxInhB|X3^R>bLWEqwAXAzB14a1l%WR4t zf;wvN?QfdR+xR8s{s(FR{1Yk;#D3gH*VypaI>m;GerI;=Z3<+RAr1ggv?A147w3$u z%vE+RK{5ZBzl#oGDXZQ{_tnRdttWQ}Gxfh5XbZ73WosW=y|u;+5I$mZ{;b{LU`GM> zEL`wt=@YOy_Dk@E5eXOnc7hmu&aQ(w&J3PF!3pYH`2582ee1zfG;>DX@U%c;Hog}N z?$89ms2=Ou!?VG>C`M+n#O>B5A$=3)sUI%8IPPvr7cC2rfio-i%t+y{>~ zz`niPq9|;~Cu*vU0EeIdvDYaY>RV(TAKd|ZdI**>UO5a`#9(U^30 z2Np#_yiyE>%#K<~dE7Jhd(_ZB1~l-{!+t%P#&jH!IhATd>)y=9X;-%z+fOOt3jLiT z7-J0bFzwyH3=V(X0Uq zv}8mO3-Y5V1KR!bz%>A90iJhmV;Vk7-Gs1=AtdIl4=BzuHr&xPSq>JjChT>-KR+&n zxe)5|##FD~t6ykHS9p)DB(BO?mC#5^m@6Pu$z%0ptPgeeiQDv`o8UfViqyr7lUHA8 z=&cwwC9@p7{=s^X>lg0@|Ghua&26U@{m|-^!hbWO3Ke{yhGjREtZaC~?5DzfDE`mAQS2ZBRj-!U>Jn^C7fzu8 zOJK7#4!W{d_9>Ktq!poKhu;ogf>~x?>JkTN2~;zWE_o zNhu)>@$w`z*INtbT5ySK^K#=rF~8l{vWq-_&0fTWmCM6J6fXm()1;cAJ5m%UECM{U`xa*rcc#!Yh86A( zu%)!fgTa4XJT$eIvh>f0H)X0`% zleAX{0L$)LAE;N)Sy4SkJ5YI$)7q+53YB;ZoAK__8l^Hlu;`22jnMq9CGREN$>%#s z80x(@b)aPBZ$8hqt%|ACjH=T?N7B3~v9U!^)JN;&kmObtI4FNbMom?lmlm*51&wQz zkpNk-K5hyt3AbX1zDgHmV;an1kX0jC0qSoQ70HN!>Gkg{W!o%+oYudR=m?D8czEj) znFTR{a1nRvpXi{p4Lz1r=0{sX6;~52=5GI^utMwwF#W#T#Q<|J{+mNlTwaKTMf4Pr z8wZzIm*d!BO(0|;2H;p^J#XB~R}R8>YU|@qFehxsnU5ELoY09)l#4Rf25&?27BwDL z1HpF5_Xor5rVg-(3BPVH*UHEpR@RG3A47~zI8vwD4r0>obv)UT=;uR*$2t-#o&dzv z-{|kP_A}YlzC-ZfJ995>c0WKL`)dy({O=D-v7IC-h!br)Z4h8>oy^_)yPI^rUW&YSNn$RG086VMk3;S@@h|Z{jQ1J)yK<{)4odgw0gSXT zy>7$1S^xfw6VS_WgGfFgxUME2WW42R)D_Ef$$qaR{h5Hb#mKTYhkN~iO2^s)4%+b} zHZ8yjd*|O1nZjgZff8JP+^U*9-JRkl44r$U{o+hF)`_-t)X&jVmA6CJX^oQpTP%gR zf(_eK8lZHo5*@LwGeox|Zrg}Rh}RycHeI~a?avDsY=oFJVge-npJPnQT%}lx2PzM2gp({Q zI4+oZ&H)2RM2iLuWz>L^Cpc?vL*{{NvYY(?+u7dO%A{Kl(_H{8;!!qg)G}x$+`1Cs z3l$xX_ifP=W=Sc0{qgDSVf!HA)r@5LfQ$zswhI2W{Q+pMx;~}ua?nEYqwHGjp6pd~ z=i|aObs}(=4)}K>%it@5g!U19}h{i}5TM<%uRQG>vI8rvrqcQc~7I zlIS-``v?J~V02kKCop7I$o&#+Nn^#-%0*pVP@zTrbY@SL*ADx?lzf)}10u{01|5hs zEr$iS-7OBd+XD3ST{3t;$GpvcyW*041{|ASSxhMM5-juuj){9FGrW{h-;Q;C0SsQf z%Dh*MSaQ9YSM*C=y0)m>l(7@PR!Tkq|7D72!GmPyFJG~oX-?G`=h>Qte<~MOF#5If z-nOA}lPX2EOPvmt<#tAG8?lNaxQwa{OqT^i?*kICdIgH z^mqggZF+&X?cW#Jn-KDwNj?NcC?X%8+tu!G)WdV-uf_8$xN@N6w)Y=8-S+vuhkBJJ zn2yQ$qkaMTn*)V%;nN{L<8g0CAuZB$s6pCIuTzIe>AR&jQ(DR86d>$>c-ms?_7!jG zP3|k-bc$JiMqQx%wIUQ9=9T$yD#JL>_wALR;=0@42z_o8+EShx#1m9C!+%`Jn z$Dxm#5DAWChY4*kCxeLr5dUrhuPuWbk>5K!5acg+)-~BLow-;%vP-H0Dzm`Deh0QO8L3 zp(}@1jZWK6&Ug5qdj!-U2nZnU7uA6m5y-s#e^DK{pB}NIuVWV1e6(Uu0(%=e#m%#- zE3H*vQHTup9?~`~o{Tt+3f39qd?Wcq#%jh56r#W;UrAtgj5rVyD&|qrzW|&Y#P_;H z@7r#(9O?^;Kj3|$XF4-~DA=XS>1ZFfI`ct1EclFOt;9|bl#GT(64ufgCTqBoAT&}o zC7wXd^HNt)KgsqXPLKpLeKo=`-<9OS7V`r0SE&-Q(q6OxnEH1h4A@An7idX?jx2^; zo2qTbH(uvLTe0`4OPjFovPS5D;8-)Els7Qz$*v~&oo0-D)2?f)*Mle9oECSMZjQ+u#sCc$agEH1?x zab{R!f-Vnl$iZP-a`Ioe`=(1wmuF%2j>t9i)9oGkwOo~(9Z*li=B2z`zCi>>)niQK zijsw>3!A4r9hgYBKJAVo3a=lSLWL+>H$B?O6S&|(FQExiKXvJvr_yqmies1_rzJI0}%OKFpxePcAnKUMA)2$+a$a>d+sn4bCyR=GKM; ze*Z967XmAlb8sTcRu@huaKAKW{Z#k)uRMM5A8gZ#Mjs3i4LdT z)y;6{E>WK|qqf+CZXZ{`Hvca!_1vZlBDnGx{CNB@-^>Y99@E z54YV|E}f`YI&o~QwEq<1y3yVXJT+>sGHg0m0ELf#toT$^p6Tv~w4mr#bQEY%w+n^W z7`utb>sl@c&@C>alcx?}z`zm^R`=uCq+VO&4=7Nor-EZVIa9#wS$VKK;t6PleR(}G z`2-wAs<8qY@RL;Gxt-_b=rmHPflFG<(-0-!GdXj5 z9cQsve#tW-V@h1581>qFYuoO8fw5xG2sda{1~8at2f@eTYk^cz!cA5q}(fi>sijKk?=wl(_KT?-Xpa9=6O5oD1q`r9{c*XSsg>fZedt zRZ?1Z!`BT;2vgQ?kBmX`D%rYc)UMQE_W{a)SW&^4I{;HvRmPN$PjGLrzNQ-t`Ju%= zIbYUp^vRBd(QpZ;d=+&%o|AP7(Gfd6gvPRAoaVX+ix~aDhLI!$huHdl6UfZIk9B6% zGfJlAb-xfv{%`@O98%AQR;e9o8P_;6A&6=e0XRz~0#V;Ygo8QNX4nLahFOh=N1`r) ze1c~|&Ur0PkWqqfKy)VF=*t}DT27~TW>NQ9+`di%Lo|SGVt$~`o5dGQ2S$1kxGQgo zC>F*weO)?U!dT$#8-3vAQ{5WpkyMi4;qd+n4}N*eg20*ytVG#})CUZTW*42wz=+#) zD}Mi-uoB}G138XU(Ki zP!g(L_(}?vG4h|f;Fhje0=x=kWVRu6m{x)t&}ywaydKDx zMB}Knu0P9VdOv)i_kLOn-#Cat6zKJB>}B$+-D-%;kzEr6?L}LlQFln1C%CiOH&vo) z9;-WquaL`krkDn4vA!l-&d7awbv+r5A9k(TN1t}aBV=*#^e;1gNF!t5DmedAJSm)e z$7N`eKM>Z7%6epo_R^ACZq2fuhDpW#XW|&uB$j-a~S@7{^_NO?v*+ zY_4=p5itDRaxvYRUUEAHy6AdYkBv;5T|1SscKbP9p$yk?!SfkD+=&+Zn^Cm>F(>qn zd^Kr5-)5_CgU+TAd&T9Ks1|=E0vjJazCI%)iY$J}y}WeH<1jpW(yG943Xbn6IE~ElzrZtgBX3@7w%f?)!6i z9@xdRrmLLmtFywAz$e4Uq5Kv%`6I-NnEzy{1Ax9G(>fA=ZOPq#nSLGR$h0#hn9F() z=XmUn`fQTSucfHW;_Mq8mt5l%lY317cL@kH?hc5a_h zLWS5+%wcne9_2x}X{Q8&R1RCs1Fw9{vn$qSF=}E>lg{ThLJEw37i_0X8ZWm6pW?@l z*!oDpv_b!B7+=Djhz%!m0Vi>$keLH}XUf?&?ZDwwqsjZ3K6*QsEKT-$0sj2ShBx}E+=UdB2jF!ZUV60=hiySQ{^8O_5uLwS+0rKT|45;_xT`Mi zQBr`gLta*=Q${}_OsBz)q$Q*X0O(wD_H#K zdZZLVFNF&>9G}bX?Izdu7^w55SfO9zI`eL7aCq@Q=4?7Gp#3g8k&lzbz&glIO?8Bf zu(nD*wUgS>oox|5*bGPz#DA@%CfSUg{@j;Sq&dFJ3F4n z4q{0=y38xUfo^#b)vu`b5&EQtX?+dxd%U?s`^8x(BDL&jKr_yQ&A5_MYTfz9gh znfv!I#@ex}nBQi+IP(n-GVg{4Ja@6mMv0;!e!`{T7ttYtUs16<8$b;45^4~Sn-~|W zNN)uXKbYLPd3K|}*maS4+MSy=f!Omi+4^%GpR~%d6XM5Coh~{nao2}^@G(aYT5ryH z1Ah9ivfI7jC?x?NjiZY_-jO)YB*XAvT1EN%hmz1+^_K?LT*Dc$~!#SGB8?Lm<)@V&H?QOe({#{mpn{F{yl+$iSt`>t)Moska*`Z7Hu!jM{C{f!ANuVKjG@nl0Jn% z*b?v25Sh&lctsA;TSQ?#ndl@N36*X^QDKD!fT7b5>$}uz( z)iqXP&e0*+1~{*pWBo27b(-nTtLa#ETCmd=Too~-%e+xd=P2i5^8WrM7Ee>TK0*0; z%6#Vi#mH@u_JP1F1E9Li(i_lcS#zY8sIS?5>Bo)PCW_2WjvQPz{1?Z(>r!nAHy>Tc zAuJ8rC8lPWhi_2vz7o9mE~Pa}mrm<9n-w6uaUxvJ)(hG5AuFK9^J7_Hjx4qh6{%I4 zV_ai?ZHR32{<^Qq4J%7a)zYj+`1$SylFN8&{8>DsX)%eDoeU-Hc%1Nj(OpTo`KIhk zonz8>f9dnP+H8@taiEj1TolzYEE4OJ<~YuERfpiPa#T6TuYYQ;LmOeE(7IPh!Ksvv zMMBSb0ilaEt%`TfL9699xY2Z}_zr%o)RdaBxZJV%)#sul|WO zJpVf8PhePjp~Pi@I3N=8$753q1dQiGF0r%?i#%`OEB~Co_07yPRc}DVQ;dcC6#E*mFh{1qYtoZ~kaByDQ z{fD-3!iw;L1g|;0Jzp$XN3O|eKe<`B5=sOWtngy+o@1XqXiV>P%@ml35)2i21tId9 zdL3%W@L|CV-3YdKgWfSST<}l3YnY;52^L~Frot_oXB_%l`mE7U^iPgypxtHQ z#2ub>!G$hpX_Kr&f{+oxhxs&Ww&|(lJaeW1H{swuU7!%}IeunUL9})&mAE4C{t@SG z`Cx)#*ONUbx8Xm`*%=-^!iA8-&y?=ZXh5RzsTE%+sv(}IXMrpL%`?!eA+i|AMZ5oR zRZWt3Z-bNPp@@g0jykCx%K^pCm-HiGb;8!+T!ro5dib`|Q8(5tFTF(60J|Szqxg6a zVW*~S^BPdjhaJHRn*OXZHjDna1b~Fj{7$0RFPWW*6n6QAkM*Rm$eFwRRNDbRiV6R| z2!qhk{HMmJKnXd`eWa*d$A1rLFaW`Pxc^O3IEW9Dvu^B}hBVi(iq?bqUZ?HrHuVKS z*mcjFVEtrJ1BULuC{!KTm|*d05d(Q;RC;Gh`I`y61D-Lb z(8Oe(j{nq2o~x3hHmon$X{2U?2G1p!T|-E>+U zv=67f%0$_R721S0?5P>#cGN#|{p<6?9ASmTbx;spBd$$i!9~?Je(vA7!68VAZmtn@ z`g^w++fs93DfZX3q&;M@ISeX_9DxJd)D-$2-1+NylZ`v*9P%0ppKy(u@-1QlL$tv0 zBqnya4HIFj&m@0xxol}3?f5>J=v|HkYWGd7rpe*_t9fS1InTMf+!Q5MIbF@!{`{t6 zIrQgnhl^YRVK>`BTJ2&z_K|5n>K`;dR1Y@suD5yb939ZOUy}IqCs~c&sG}=@h}}>`%q4OtUNj@m5Br z=*W6T4nY055yqp$0ZfX%>@TS0gifl_BD#1`w!4uKHzkMeM|ky&2#JJ50RmjY&wGaw#Q7%B{q!`B&<1a;6uUx_tXC(|s*c8raB5PS-O2-4@ z$4?oZ$K4ubZ)**1PEseSGEDhxYnPC>^e zfVqlFi!45;gz`(OaXR3&jovjk%2E54@3;t<9Ir$ZnQB4WP*iS=WT4%Gfvxx4UeKtM zVc8%{eDf2cfBME(;C)Q)dsHVy-V&;FO7KT+e!l83Zrc@w^hMgTdLT$!vaYEVwT6mi z=dpHqDYn*ZguAX&7c1bwu2s73lVuQa7B_M0xHB8;EPPku0e_cEc;l1{54xM*N2)g4 zZ`7(2MBjjqf?JC%b){5-2Pq~o$<=g}!-#<&9xJ6jyh56lo&4uNI|pEU)8mDslPf+s z)<#UaAJ|IwK)>yrZC1#V3LioC7_n=cu~IMRke0t8X$h9tyxE<4O9PaP)`#fr0|Ynq zAl&t4uRvW+sqG7NcbIbYkt3RX&QyFQRN{0Y3;)~%+m8k=VSQ>@4;n!IZ8p5kcf`#h?V%8PNdmmm#-TQQej1=|Y*0>@Eo01@F%tcIw1#BBg*$L>&{hNO=b5X% zu;T{C5rC$I?4dqgV8he(RGbWCBJr*WEb91v5VfecDkY%j^41FtaMP)VT-lb1^j~s` zs!fwd#klU=8{UuYmf75cD!Z=nr!I9aZ6P{DB>vK(h>Rpn$zA3^1&}lDrKIpf)ro~a zkH`!>0V`!kxOxn*XvZ~=iG@cvG(MX}>d(ZF()D^;_UP>urC>ixkSZ>ybY~h{E8~;= zCUPo;j*!FPIfoiDf%*;mEc$ag4YHQfFnHzYZMv*NQwHB>?ZE!4&H*ckBr6P_5H=ED zboo?`)2ho65C{p6xGziWWKMsV4rPVPRmnN3-M%qdfF9>PO7Imvi{tpiWb3gu2Nqm` zu&U32+nwT)I>68`=cY)KiIt12YiDQ++J+-JZWwh^hSJio{!z#f#Yl8@9&WAiSE4rh zGdnO1{nTRyzTH@ii8Xe zfG&mG-Mdwmr-x*LG55E!4{~uzy5YPz{rrWU`L?S0M7=@+pxA?jO;C&A*oV}fDQlNT zYD%(x$7=`sA5s_NnQ(|L1xfjki zypXlUA}6-7C?to0CYXi3u`pXhh)F(ra`VJ=lN&K)nA{q1`^-_+Mk;;|&czF_4N3lo zF(}z;Y538w>tHrRQqHCybdxnK9O8y~pwo}Q#aIpu!acK#OnAe2EW!Z!F8rHR;ADOb z^KD_u!|t~Jz5#LIu!H)}_NOcif$3jZ<~z))=HmBcT|keWMp0FeNKh&6WBtKf=F|$z z?%Wi>s}3;sIu#17GFMDp)|uih8+G;keCZmN?LOI?E(}4^`lnW;WC=o5m4vl?(z?st zCVCDzt|F5VA*kL>Mmk~!`6|;oL9w<;0eR`CHiLM5Xnb*AA)!N`T|({3S$At})k`RC zCfcV!y^;yu*~BD&$R6?KXjJ$aAoA0yf+4i;gGJSli{PUDh{$oCDDpJC)k^D_r$uBT z!c%vNW%XkzRx!#Y_(uYrcVC~_#0wjS#LYL>3-n{P7ra~dycY4?I+RFAl=|2r@6j>4 zX#p~x4kkUggRe(de7kButA?%6}a768ZIu0SEi?NTvoOP}0 zfVgs5SgkQF{D2in`F*#5iOdP&Y%fak&}sY3`0tJd;r!4KX)X^^ngHHXyS!{7n^C6n zdAC3+DsPDs8wI4ZW)7aM*G%S7-HCGP5v(UG-)>vU{#D` z^?33M3z&t*L*&4&X=0DO{Vopf#VvQg@c$YP6;C0Xq|C&n6g1j{UQlRl-@=g*A;Kg< z0SiRGcB)H+6j@PQS^-&^e-C(?>QlyTXeDk?Jy)*o{6wm>0Dd6$Ll?;5tfW?pTFDR+ z)L5Bu6lUq%muxYKJD+$`2oe0UhpV0&YaXRXqyNgAiO3SR+TCbZLGXMp%`dyE`MK{0 z0MJR#lsY;^;Clql3^s)q_UoUjYzrgqer>U$XT#n(h-0N_zWWcr)L~e7cifV+9!F7gCys1d}5_dgMKb{(?L8VY^f~)M8j)JUva|!j~S!w6c>XV^r%)F&P7H3i5wG1$lIeEx3+99x)N(!e=Ln?Kb zC87&BbjC0kdlbkN9fWB(wlz>P{#KK(`cw(_6h$u;qyLlMq2KLN4n8!J=Q7%nL%63$ zF8*iuauTovV9o!VyJUd*^#9F6c%0%r+UU5{mJofM7-EGHca-=4L&vI;2rTGaePs;$ z%&(nDBxj@0%_Fz26KYPQp+DOJ7^kg1D*%An|4ea%W^Q+H0Cs0hk$p=BcTRt<@&_p~ z<<7d|gSOvQFEFfg0eUYL_kItLzR|H?YkX;XiYG5Nf?OkGB{1K>Iv*-j${8g=LZ>t=b&JF`3^G!hsu53ET2b zw}FhsMN8&Uv+E%}f^Flv^U#ed>zh%saZSw{^)F55=&R>p>5H!MPf4O;j0IJl!bp-M zQKyH0n?ZTLDVOK5N~a2UybyGnN@Qku+MSr+pe4Wt=9Nh96D0Pd($PIp8zRS}NK=|v z%R~@=i*}n^N%D^e6II`nSriB!ZlnJV|&j6SA zq|<})b6wYNh$0Usc9)7se>lu&U5Q4=qNTBqUsh;Y+ahK9nlJd#P3|aEw4#7_0E z-MpfYC+g7oGs`qxD&0NizWyxiGujMKq*dF-yC5DRXjUEpoH(`&<70wu2#9a;8R?g; z5ggUx5&wWEjp?iWa^e_-Y6-VqMapd(Vw9kjt&7q?N+edM6hGcYFp_1=nq!Q_P&&cF zeP~(+8phuCVXxgI69I&rL7X4ITFQWq^RhJmNhztG za<9t$DugIC=fAtdMbum+$Q-5O*Ui%dUf6DSGicn~-S0p)I3pZVjuiJmcLfkr&4Qnd z+-}Z0wzt16BOUxg&yMsNS^$))HtaJOX$^BJA-S;X#o(esUo&K&A*OM--v>UgQ8>k- zaF=TU#jc)*M~d|ho@d6qdV-J?kGxY?04f8NhPJFP>#Y{q#m?jo6hrr?=7Aa-?ndyR z=7mp?U-}r-A`nm)oFRdSFB8dhExhsgldjyf4Ur$63`G)?WbOH!Q-UN)|26&J)-4uI zHQN`2us)NB%QuEklY~5V6;fnsYik`I16#%iNylM`A*X^#V8}G8d<}Y9aAz$F7&UU@ z0$`*|$1wx{`&zB3VW_Om%!HI^OS2F|>0;u-Utohar&`-+cFwf)^$!K@jlP3G-fB!qwlun2~2s(yLKfL&cI+0F#(b z_4Z|WSaQkuJ;;IjOPrfSBeX8EQ=p&)lDRW;vL{N{3`UWyrGB_p;XqfZR=Bcqf2{I@ z<%3}(VhWcf2nOo}#O2okHFiHGrQC4e=j{wQhcs@`_>?pQ7|k+IcnzyOwI?KxS_Zu_kF z^N(PDbTqF)joQG4;>2+{!5ZIXvuhYcP#6PkFsy04{=SL4G0PujIPNdCKCY>XJmEaV zSKm*Ixi)Rhvz-%MEH6K9t5CFg^iRT3L0?tRWMdOr(aubGPp;>Q&w+MnV8-XK@#;kX zAPySbp%VPt3B^^=3X}U;9vmDNEo&!4QGu^$wUI&+eQ{y{%{F4cZmi#1Y<$V_4S z6C>+0Ukf0I^e?mde=%DC0IvYl2LJ$s7{P3o|M$Be_6_}xjv)jTy$}Gnxh+{Ec)s)z;84@KYjJ@FIwaMel@QF-c!}aV_{#p=K}gCFn;TE6FAfmuj>o~0qK59d{qnvbQM$drSH--p+0Y6t(KV1#6Y#$2LVx(A^kv16(>+WA}2NP>2{Qgfd z^sz%5enM*z(AsEN{7AV)1pv^e;*NwbW*~gGvc1^2?C&I9-m$*i1ivzbyIaBA0KT&&dhV4@?{H& zQ}*XP*d6rl*UgV_+96g+wuk0ui&q<;)n?alSZ^1qKwMf1SjTo-$mKR=&b?+qp_pNd zOid}{cEx76G4+(R!L-sx!}e{in`M9$CLdzG?KNSy#xhYUdlp47b%E?MoowtcLi@Il z9Rh`AzuOXN=&_jAt1t!VcA$S}kCIJY{0cyyVH?6-p*6zCXH zhKT`g3WK%W#Vku~#t5sh;^s+C9-K@y-pZu@zQ5RE(YyVlq*0%F{iVp;V(Mc`#lwOv ztp-ZH>Ldm-fWlMQdv4xnts#CFxizoN(dVft7u7n+&$|hFIcxoJfFd|ng4gjpSN2PM zW#-_gB;aB*wM=@6(a*rcYc{PbUOoRbbaDE_3BE&c?F&eL;j}0RL1_s02%a7e6*yZB z8uuSZ4QJ?`)wriWIpu{m+64@j{6<2Uqdn6ye*Dop*ZyI0)1s96#aui+Qk6%5CL6c= z!BtAFGpAtgAm66h%X^B!%)~M?HSePl4yG4msAa_*_^~g&y4^Y$pdnpx4j)rwzwRs< z^Q^T7v8YIG3jtD`pB8|8c?8S>>K1^|HamP%Wzzw%ut$?7gavf4js6H)VF6}Vd}^$4 zDr&Xij5hsaBuj8Gdd(LQ?lH6u>|r(>?ek{aaE*$Z^16xR9oji!-EmMUdG~1e1sKZg zH*)_NIiotDsZMIhdIXA#7CN_G`1P;(4)r0TcJK=Ay_Jpskgh=gfL&KT-WWqd^tOe3G*!9=`Ybv_jhH{p0!$YD%JaHYW+F*8-hP-)HTt*2)q=$PTu%>Fl;5*#Uz1bYAYGL9Z52(*!58&JV zBJv41hF9TBpM#pha7G`9ipM0ng*e*Ni+V|d4RX#51`ytdTpj^I#i}9*t0`D_qhUQ^ zq1(9EK2j2t(H`{#*h@DmVkk@-rP>yZ47Yc&K+Qrb0vJzJgiNRS76LzO)T340vWfn0 zDuz(RHRKo9=h6{1E+1m`q2K&eoV&{4*VW+&$KK^3k8GFIR-m~FpJZ`8!6m46B3yrk z(@RP(L$%EBL#14;F*kUjK;PeP%Dn|3Lk|n*N}Pdr#iubCu?5oFHQZctIlZ`%>yD^A z70}+Z5{YL-A~P(eYFUjcWmnX{q+67*Ch}zk)Ys7>8TMF2C!~GN)2igjh!Z$br3R2) z#lk`2gS#H^9}~yy1ehT48m0DaQM9d%ehJ$;Kz(7R*w!06p0SV)Ma1suuGzB6n4mJI zS4><*lsQ*V=GnqIWbJhWMN9?mgt99?6|IR1+_K@(EvHb(%_PwuX5=uz*4OUIceP`a z(PRNa97-KZKE^*8npoJ=`=o1f0vLxkRU!Dyf<1Nm8?-Zq=8>;0DRHJCi`$YEr$W_x zuBiL^JMiScv6b|cczd0pI`a2;CgDRmJGKq~mhne#-7O}-;2%nhu&)#vO*&E*Pyl}S z!wAQg_k4NR3%!D~ttsAEk1p8vv%lEceSUOf$c7$h;6SG>TRpfZmDLDsjRhtt^E_Bi3^PJ>M61oi0xv1Z{Cv_bjl>j&3;5+);wR~2a0IdrR2q@IAF$2F zftW}x9rf~YTpLczfjhc?H$ObaY*=_0e!}ca(!ItV+kiWU+Cdz3sox0w->`Ln{FTcZ zNP|7n+MA&295$~-24Ltf`tj+j!ND!(Q-h{H$f&=B1;|ZG3!Mdq>35n|sXbxk!e3bD z?vWit@U^QWA}pFg0D#b+9+h_CJNH11h2a=g$ee7V6n%&uoLxTS<}##53IbN*!YUjs z5CSK5&zdK-#~IJ+7gvKs{RwC##+>UE>Ka*v&ut%PL@@P^5!j&Jx!50u**6O5 zDkeynvuUoC`&SKMbWRHxO<({AiKXxn5lg*#j^h~nnnLCY&Loq<6N6L1ft@D|Z%_JN zCHWqPqj;jHaG4SRB%{?g6op%cqwT8_(0qSK+m92j-%a;s=Fv$he7=S0EJz_LuBf-v z9hh)w55~a)60MFPREc%>&H!TF&RFu6Z+OtJa^7~|zo5a`)Jo8?LJXW}hG_ltVC zN6u2X_}7RKRqFFIj~o~Tovr^Uyebh#zPwi5)O{y*CWGQ98gVF;X;Q@^@&@DhU|}8) zVBtpZ$wn!vX)4D*i>AA;F7GArFnM11pNbi8?9^ZL*jPj@Cq#o;dj?aVWgq4XnJ0A_ zh|;<|v81kog{`|$^-eqD&kpNaj9csLsIwZk7P$9zHh`Y@*PAJ`u=MyQ4} zzT}p^^~I594nf3-UVhlt*<&I*>_axw5Zn92RDIU8PgLk zxUMf65I&V6j}40X?H-5)8Dc`&hwy>W#0xcTYqv+@(pv&V(B_&MVvr#UFp;_CI+E{x z3uP%B`}BRIKO9k%9$2`bVW~#mjrm*}xxbKa!w_4w#6G7i8M-!JPU@u>J@+<6()?cl z6g@R?k_^Gwzjd0FZh?FM&hGtipp-w5#`&PmbPZqVSfq|7rfs19ufI0Tj%yI|kN$CL zpUL@R(OTMDLUDx@xj9Ef#_J_(T<(&Tz_7lvw)qdjJGh9lM#@`yK%ifhlbg)<*PUp_gI zPd&C!KVyk{FU|Rbn*=k1jV;9KUv{=LeOHkw=%OgbxyksbUEcJ+SxlkPeaekaMKSk ze(Z#r2F@_otAK}rTyCRwfPwk{wTqRAFkOnuy+(GqO)t=QWA_d#jZs9HniQDTeY1jP9J<0241ryl^FpNOSO^kn zMT__F7JxtgsTT~>&cHV9vONCiR(!W!a~Nh;Kkn)bs1xbi|C#P*{Zz{eVyh^?D^JL_ zmC8vZ$Bo%AnZFFpA7+R*&^n`Enz+Gh&G4B*!#M3}^XBgP%1bkRmQ=uz{LJgc8;xA* zOer)I)xsk?qs-0M_AgX$}W zEHa(Mb>k!v81dYywKGlmja|aJuT~MQIHqT8CD7^(7^a&=G2X+svl)>`8X^@2gAM!Q z=dOsj%yU>%9}AOmkVY#-Z@gy{|v8{CV?8mio zea|XpryaZ!rB}UH*-TMwH_4CQlWM)vE$f?RbCP;w*!LaO^BvJLZee=V9_ znvancyxmm@*<%X^faqr^D7*bH^Hgq$wi{e_2>hlK;NFv6h)($neeo!tjt-~oV@ILc zS)-0imWksma!<$CVRPbAyo{DDx7n%n3P^5vuA{&)Qa$OD2nPE>t6c*5B)m33T14P# z>SMGVZzzxtQoYl0x(`X2LVNwyp}F{iBg5ECx!PnOdDE4a#r5W!*VT~>3CO1T1=crf ziZ@BM5yZ=x$)MWLstYG{hR8u5&w+wUjy8VG~wj+u_;8P~>{(z^wIB0a3$3l7DMPa57euzQ2 zuv9VMjMDhCuduTj(u(^}+_5m{lN@&H#-N_k&D-y=4W{IAG~M#**ZB32IQn`a zPQ75`QhL)!?#o}>Qt=MJ-y?=ackN@JXLU_o8ia&qoAu4qGtSlaZ`hV^6{#m@UW(%g zO}cm+dVim@hz~~%K=_$!_JXKNuC9{(@x*K&@@t*csAP4u*8^%%Ej1sH+%w(Y9+~u# z0(zlMbM)RGvhyY8o6IU~>qP@I6TVU#gMN1AxZle$Wg0(f=SX>hO7@_?-#6CTOV9Ku z&82jH{u}w)uf87a`XuxT-8^#xrWBxk05f$9KtB^pKRB=4L7%gY-}bj+?%dHp}V2288ygP4R-?DUN}tMLp9hSz<@Z z1N)CNlo30#FmXK*#oTbB;T377fUMr9`UkW{k+gL5di$?)uYZaxd;`UGTHp6xgz+!bPxZ z{bM!=TCK5Mt?f(-$EsWVYV$EH{Uwf~q*5PdADeyTZ@Z(AHCr9s(#GN(6BW7?Z!k54Wkny|M z#B4=|*0UlddyBRksaDs)r$Q5@u+t!q$_%HKaZcB_eC@Y5s^{3kmmuABeX`Yd=! zE_nnk!|kPT`Y8t8;m~{C=)&9ZTOhazxbq&@z$0mtiHtK${-*P7FKNGqtUz~F*Inm2pRa3`<5)hUNUh*SS zsvj(G1?wg=sb$Qh-Y@1LGrlwHKs)AW4CH8!^O+4(99BTBG|ZJU)%&_Wn)eJ-c1{Zc zUHqXif$2Mwc#Cl={|Pp41_ja_xz=I*zgv*9AoOCOuQ8PSh)%uT^<_LN1T_-BQU4;; zc&txQC?#@m1Fk)5dUxl)rEaQ*M)V-k?pOb@64vh?6X7mE2T{+*h);fgi@j1nwCRz4 z-f>_0X#0A|NnH&X!0&T(!Y&OU&)Md04Wu^Vtg5D@o%}$;n5tXbu| z+iBGs`p?s4zvA@j?r*+Ks8(U++VT5jQz+JhRM5cH4pLGW*ag>&_T9{6pi{UMOH>oW z!sK+g^zm===NhPa4u6aTd-@7Kisa?nK&XK{mDowkN$utbd324NyYzWA`-@!kHNJDu zi0W#?ylLVrPZsmMQ|ZHXBx|?XT~0Hd<#;oTv9{_mG+z$oE~9}nX@CEk+qovk8jAku%0C+HAbsW#c78C`;B!hHgBBDS0CcXXeZN?z|kyF`i4k94sDo1Xbp zPs7App|xe7>9FH#4s*77)ZMq>t+^lmw2 zYET_|qy%DoT2-$TK>KAvt6qoQksH+sk-zdhq~M>so39^l!is)@_k->NKEKNEce(|_ z^BjNi*sP>{tc`678J8D#QqWk(Z2J1O!{wE1j6Tm(Kp1|p;Zg_|o^XG!_ZeE&3Z{+2 zi9r0;#a0P+@QnGa_GTAfsFFl85@uT!FDNj2V!CGkkWpRgIBz95;8(0Q(9wzJAZ9R- z?uECdU0%w}Vn}>iQ?8$4B`E|a0@!m!*tI-(QPKoIK z=h$r?5Y#d)N&#KrYYw>v=P`Pw6K`y+j?@sS<=qL9P@$ii`i<6us5B+A!-fpL;Ei7m z?Ap-P1Jt#x#6;93so!b4md)r#xh}HpBw;xjEW_qen;{k3FhnnA>09Ynb^3Ax}PQ2nedwe9ejmn|g-X3un!L54(|Q z>negWy~R<=u*kUR-qLEe9sW7M@r)(uh?)lQkW+U40UBo z*OXYRZ<4KOqX6E_qSBQ3ZFQV1B?my;jorD@+aF9jIEl9Md2ITJsd3sf30GH*2*lj) ze&H#K-fc23*QP5%Pn;iXibe;T2&num8MI(aVtcG(US$<>-jgtq)s;%O`aIY}Q0HJh zcrE~Fg$eo+?ix&m#GXdd@2fiU3M`?5la2WuRQj+YtGPDPWfJ0qy_hrv^o)DPwR#`6 zt3#DdGEPXCXyi-uQQ1u!KjO(^t^fp>b@>hRUrJ<1i z=UK?2Rr@h-&#RmjLk+yO$YD_#BSoPbeKuL|4P4ViOZTA8r!|xoU&TaQr}pMOsuTy2 zTya;i)8Kn=bL-auFv9fy- zzhFLy7%m`ZbKX)6#IJz$%I0W*CZ(c+Hz$Z3%hx*tgXGB~3iD00rl_PBv?*r}3 zpr>D7I`(Ytz|M|1t@ZLrIc`tuZGeu)_&fYIMDq{fio&TG=(84KDKUBV-J~z^zIeX4uZ>d}b0Irrm7YWq0Li^jE!lH7ikC$*l zy3T2e5UBJ9J-_ohybb^)+Kb>-%o};A47InMFy$schL@62{JCk|$-OEvgsL^Mdz#=D zcLCftTIX0csU@G4e0;{e()LZ3w9A$UrpL*5CR_Lbv*-9zX`)=TU5Y+s@n1emD}M}xzlzOtAT3z5y8yU78C+uIt_+mMIsW*e`l z!z=Sxv0!iYS>n=I6-$?`4B^|ENB|T! zr2r-=o4W0sc$h9{D%e^o;NZ-}$V1srbs?zv_UCI0sqAD__;fnR`bMr*>U%PUNNk}{ z)iS#105I|WB}nAND({lk1VM?k6Pxn0T$pLrt5=wM>+Ccs)wva6WRm_6rL%J zcm9_F0kwW>N^w7ogwU){q@@s^6!29aV8nuvl8aeDdG>uO3N0+Iyw>%gZr!qW4OHkh zyioiXM0~YD1 zB&R(rUL?vE&4NYugNhAc?H$yBuR(5q5Vf>Y(!@$FBF_Ut&F9c^R%n(F7UF%P{t1x! znlku+p$wux>hf%d7%U!}$(BeU^fbTPoS;5%cwn|L;8oz5WKYIC;l!343qbYm1WVaX zp~P>NLBfvYw!6)kN3ZEChpt(Ny7)VxbVlRnXoq0(|jMT`mEC@OD_+_GcsjAd2fSYfB z<_{yZ=$Td&aM}JiWVYM1Aq59y`h(}Y7eCrC)bPi0Z7OwHeD)5=r3M<>>TiVGS%F?} zOqaEesoh7D!cy?ZSlx7<{9|S>o;5nSCXi)qZMFkCYa6}+HtJ)cI0>9bZ%vY)IYPy? z!BJT~Y43{hm~_5TMk>IEML>K%MvdIdyx@(H?k%ePZMqXf?F8^!@r%)Yj0m4%FDfV* zlE#1LF$V7_>p$;`pJ2Af|3`P6`VMpwHi~dgaQqKh=h!3)&?V`%ZQHhO+qP}nx9!`u zZQHhO+uXY`GZF9Z{Dk^Yr%qHpnb|;~6~_tyWlE?ZxzY_}g zsCx+WHC9YMJ&nE0PYr+HXjxhLwr;BnlK+L$2`Bq5e;i`K4m;MA1Ok{DBINs5eX=NSS02D014VHxdz$T%8G5B7u47-YwTl1UFg}6?# zLe%N>i`1$eqTueVgN1*|6}HzFbf_jlzjzCQ{}tr0Z5-j^lk~a`mIiyaUXL#%Ug-tZ zm_{7Y47SgH(iJBj4^L?Y_!T@7aUEhLlI{jyoGZfls0K1%E~`$0B|EjO448JFmDfs4 zvk-_Ue4#WSF(vY#0yfJh7%|h9rais1j}Ye#-H_Bj8=CYC%U-<`ct-cchb@Vn5lbL9 zw#AF&3{N9|x#*D54W?12D(f{}sqlK-=;fA}6UFYGgoBw%d5cQrz~v9E?tXeI*#=bR;f{ zB&91Vn*I}y5q8h1<9Tp9Tgp#5kja*FYbIq;t7^f!w%l_)_!qMP0!nRwRFJs*zOhh!DD9E$Rr^ zzzxk!kC8DJA-7|y?iCJAOPA)%q*2NZ;?Q-gF@;PUEPa6%YrHagrK3lJjE=f@<*~UY zoaU~=N4U@9CN0rw1mL)$gNmosH z=I=)*PBTY^?8h@JET8-|MoGn;XN$CnGk~IgC5_$FFj^642}IKkQnq%)_F3d|>E zpg`9`hgSgRjLMm4D14+p^OA2`A8?@z1Un%;VT)$&P={t%T*xynd$=b6f@1L}Wr-La zH?eDdOy?fD&K7MjD8`SCci=amn8s|N4fH{SlN{KZ2FVBEZAn2&XZ3Q~2d|F!`ykN; z(CSdFwuGR`z>)UoC)}$XO=Xi~arUG5+fsHvoAo4*w@p*ND;dsP;~A2T8o38T zzfmB|$1cEQ#;Nj%6uD{Sd$Q1`v7avmE3GYwz*H35$j(9_9aZ=L;u)jDCMP?t} zZ*kE}DsXvhat@;>gGfMp>Lj`p@CGRa3lpWH#^yDW7j5Mf`vI4xVPQLj7GsDEm%pyg@h+wss9P_yL?$qlB@0G?Rq8K9rS7X6CbH3iw* zkah*R0^!crR5|#*=ajpd`0rbsh@=$_ts?5o#9(V3|J+vSSlL%+nm5r`BW1b;>v25L z*2DrDBVjx?zIGHN;VBUUVFXb=_ ze4C66-#6*K^Gbo%uNruYCa_>*(P24U=q4qlg)wNgRmo;iMFQE;{Bh3ycV;L@a}5@M z_?<6-Xd)9(D{ebQR7eBP!{}Z81~rPDe_{V0Y~85)_K%EGaEa5Z!YP!{hWMdtcFL9T zd}uX)L8zbEG`0tT#0|COf-((|A@2nIs( z`H|tM0z-g}$GJmqLrd9Ov|0(6HAPx$Qt$hQa z`?9^JALk)G{Z%8AxJg1Lmsq^=zX9$~u8JXEFI$+1gxwd&k$s-ZUJ+lAtL%woLIx4tUgXvA!kfw8t%q7$aMDEXRg+F7!6EDk4`g0|l8Z1`G26!LA z;LZ$kt^sra3safA*SzZ{vwwxt$7-@>0vfoVRy;CkUji)IvJa3Uo?i5GvF>CaSn5t2 zxg2X2%E60_PI@33>M*<#owT&1+eGTIB)Sd~B8!mZ_ zW+@j(+MOL6ewpILe+a~>QTEWZIy|M7!P^J}ercRMFr|0%f?2=PBF5Id5fm=i$bBElmWJ3Ga3X8gPac zDqo1~@BEEGrJz%j#&+Z$pKjbveL3t4Peio*{dxnTvINHNDtlHmz;2s=AGZ4U6@!BF zf(GpjSMyj1NEYk4yr*uQTcg=9{5ryTmi>P1R?Br+p*a(Gwt=n8NHwuDZQwk__!-N< z9?O?^FtJgkrc)X1#J(u@l{{x|F@P3QQJIy<&+zeALfXH`hN*i!zq^O9Khh0x-mK9Q z6W7=<;kv`c&_phQ5z+n~x;a;K~QvRj(L4Fz(3Vp*~hbCmV20mz3*|o!I%%+y=H~eq6 zH8lK)q0qPL<#47!SKI&|VWANLQAXyKRh(@*0TP3x2&~IH`y$=5PibtZt`*uEWkQry zxj7tt5oJ-eV@7z2Gv>Jck0NW1G2OMUDNrT0>nJ^G`8AKz;d;{9=0bXgm?K~vzfSmw zxqjLdX~>tC1GaBY-S-Zfp4~7qtoDwGD?;0tE@7&Q2?!w=BY-yX0rk@rGml zVcuVzTB?iRM!)7#VGSCBux^p7mgy=s#F}~gf>q366(OiR01zZO$-jhv{@XQ2uqY8F zVufYF;BNb&;y^`bE{m4zUw_sD$k_g@P zPl^3}!rWV8*A4-bZmeqhswIplx&g&2AQgkR(hk z$*Q=V6Z+4>31O$(h*C)q^HWovDjP|0p4w!m|^kd}BLfEVs*c_1km#b82bZiHAS2YpXGEn5HxuFo*kK6tY&yyIVN6@%lw?Xn)^* zQ?O=6zdd%fQaibsAS<_o8wqMSOz4O#TpIz~3mci-H~!|mHR_7i-p-6w8lkzwt8t}sj_*l-VhK&X; z?KC`GJEPBr%?8kk6Xj<)x|w__SnJkKxMS&adqkL%P7N!R$uko9L%ktSdAWP=k-$xN zKfP4qK%M_qPOC*(4AGe^P59>b$_^Axkh_pnEBa?L45oDDCF5TW~c1|efh$|70 zp%^&M1G(-Ev|;-sYFt^(y(mGf*1t%GfH+p(*Ap$TvY7*0DRS{EfuGT)F914;_Fg}o zGLpU&N+TXlS#zmZo+f}Ql`Y{~NGS-WM?@ZO2zGosQ5GT}l!Z;eWgF$qRAhEphF_*j zK2w0zk(nB{Zw8MPPx!I-0#+Q!YgCN*y|^S`d-;W}Ww!cMl zv8D$7m5l~QF(xyEP#=9E$D=CRi1-roXy{Q^l8tHEO|YA6w=?xyyvs;V0AM;%yhTeT zB2AZ^$!UI=n()aXi83z}E5|Axwc$dUwYGsRiL;c1Xn23}6@L({hfJr>5=o|TcW#LT zck5Q%5S^AVqgt^v4)R^hvaX(miJ@`nk8Cr=A$9i@$!17V|Cmow5{hE=1EqL9K^He& zVpM)6a8lsR*N?PYQj?^NX7=ZWKBT&&0b~K+ixb)wpvPzA@9)Fr0HAG5Jzlbj8q&o# zEjnE8YdXpo`85^{<=>) zl#u|6RM*#WsL~C0((hBeX@68N;i2wS&9Ql>UmG%Tq77lgvvB(m3$z-xRd)KX7v&H@ z_5V!)nH0=T{ogzbd;Bpk4km`IOsqo}MfsO^hO?r2u-^Zf?eL(BU ztw_mYi2)p)`o^e2$vli1FfSfdgX@W#ioepeHLV}agj>bw!H}^3+42Phy{9!G&F^n& z_>d?50K7>;8F9;!q9(!6k|anZY^ojWno{2Rhy0%-Lu+@c13Le*jz=ab zwy;AlL5a$~v;Y7`n0#zW`C=!Q9S{uHt^{bBoS5V*V8x2TRd+Pe{V^V;cF{9;+zW=T z9=;g{Kn9!64{*bZ3yL@KS)sfm0-DMcJvMFo&V+9lO%J^}B#CvKwVWNrc`Yw+Ld~D9 zf?_lnUq6C1N8Nm&PUh)9)*BMpDYL^&a(YlM1iBWA*%pV2fXF8E2ZtX3P_vH?N)1&D z!sAFU0n{bq7It&kVV1*A&_`dIMt||^sXcq@4DL)nC)GXtngWXVjK0UE9x@#!ru;47 zvfT^6SU11>=PI){&6iMHw11h$W~2I#xnb+YSy^a~6~+7Dk{w2#$W%W{lfk{ICsqGK zDQqXnx#r}UOoo8^Z)Ygt)b}wZ|NasyN}=pcVI;SI9u8G)QpDpL2@4I_Yj95IX8jcP zeR_NmU)5?x*L_BZ^QLlHid^IJ?trPIeR+|Zo{x;2q@$xe_<%zG+xK)z)EI!m%TnI* zvUlT0?obh+tY($#sGyxBg z@M2n~k`!wbTOEfZYzL$NESR1;^S>lsR_8gEAsTvkRTs3DNr((box^Ty$f$X!t_j>s z@8bpE6sES?)c%2msr8wFw5ZHA`P!nN;$w-B43~zfL0axP=T+W$;dR?dvZY|B00xHFF;-pgYq*0@X& zR0s4;PVGut*dU|oEm_L4F|Oz-jn@36h55#~|3WLu)FEYpg>un!3l@IqE#~sK6yhtj zu2#-8CQPsjJ36gHAE0OYTaNv!HG`7iO!Pc{N0Q5Xm{9myo7_eveQ(G;YOcm2FHoo2 z1PHY;k^?8$?gZkUlTo-w%;#^!-)UY*AjpFdrTg}Bsk=rH5o%V`CY_$Qs?nr8#w~$QXO3;cUb)`!p6d6qXY!gH)R)rgiR* zY0^3(IY1Fepc@?6V=x{qaq%8<0~z-=TG*;#7pyk8xSOdj39*?6sA~{ZSzZ zdCN=`N&@=ZI?Vqr<6gTSpn7flw;@^605vEBM-V)XQL0)#zI7Jikg?9z#Xxcd{W=ha z4m=s(&LbgwIcMPd>#?jk+^oQ`t@HHY5RRp*8_7A{AY zUoiE(OVq0Dy|S z<*HU1%fU-?%#pa44B3K80F6|>T#u*HM{mwX%V@zby7HG6EyTB460RKvV=0~1=9pz@ zkV^OoMv5XTQ9RE~>gqLogF9OX0Mg`Qi^iuJ1{wsT#WsygFTCV}Ss5{0CTKqjXtZ`F zHH~A|yX4(Sq4$1QL!(_*wJy%?FQ0->Cla2}Mmg?F>LR2JLF$A;zC<{!Y^kh5 z923TXsQ8I-;aO5K;6W0^5rPIP`(z_YMPHoHH~g;=B9JorAqvM&p;Ch*sqr%|IT(v%!M@0qq3zk zGIysuvCOZfTwg;&!Gb*0{-R(-$COBfj@mSw*~gu!g1;gi(I5Mo*;mx^Xl_DClW@=q z2Gd=ddJ2A}y-HA&6C+3@!8Ue$8M0$AVvvHb#kxb9gCM!Py~Tqejo#TDfWnXlpG5~m zz)fl;5p~Pon3Isj=_!`jGMneY^|G~QK7&PBoWZ?s9x9pP5kgQ#YI^cpI2K$k{%GA% zpC874aL@itT@BHh@(&BYn8xcQGghA4L_ZW2-C^rgA$HEH84FV>SKm*U0^L3aj8o;Z zeCUyJFs&T)m8I=BVm??$pvlcqhM^v5DvgUmx6EwLOiSjnsFt!*%p^gDtlKEmHa-1MT`VQbDxv^`)9d;H}}YpaO1oLBGRbhP??Cc@oKju z!b{zU+jhW92aY0a<#t4W+W8K7A1XgZ9A6|v|jF=(T0x? zcw%M?xd1T}aXDmscO|&W{9)gU4_CxWso6etY}@j6Sz|x&_7a1|=jBWGmkpYlgO4`w z7RHIy+y&( zdkyXM6X#Lwl*SyV-e=G`zgT?K8TQ#$@6^5&cnw+yzpKgyq?<=yvBgsGp3p$C>x8%f z5PAI-2Q@E}rhD0;QBoQ9sJ$3A8W%?w5bC(H>{>tLjFco71?ePRsV(BNnH?aE;;A8X-^VNi4{ zD-Kr7g7j*AH$|IRM1omG3(B4s38JJ4-Pl<(vWc$f?x_)Rnh2{NXfej)5>}Nz z>LQY7U)}b`BlOV7x*h>(6d@H^Bu4qz<^*O|-H$+jWP!ou4w#o__#dGaROidS@84i7 z0nBavf5;bP=H|#a|Cs>%h=!;x^-p1am;k^&Tuqs(lUHReBE<=KFJXM~8d&Q-SK+c; z2U~;>X}ukRPN@CRTydd}daq~z`fsj4j@Li(!!%L0nJ@3N+N&=?jG#m#aYzAuw?4KV z8EiEgTx$lsbq)(5Ai&vY9*+FtQ?kAOk#5o-2$>p=U3tfWH(f56@M6Oia7d4mYKmE^ z)`HcIvCHb)9Pe^bAh%CNmG8A+XXyU88j`My({Z17X~r_MtWB*hw4kB^vNqSnewIu! z9ndCw+_hzAA4oDmNIJZEprfcUiYZu{;MA$6IY*}{q8T(TfFD}SWnl+Lfh%@3y@;(D znLD55>gPtec932%ba2h7tfzQUp@^QYJmi}_N5uWW^N_%Cj%xPEciZY;Fua9{!>kh* zbdB#6i%okO)W?=Y!t6|ZxE57b=m-%a=~L(wTYYt{~lepPs%}b}shnNPqH6MvMOD1i}tZy6aigHBj48_0F-hJP7J;a7EuWTQASF z6nbr3B7#=UAGd*v)ol-=)y8y3spAJ6l*CvP`eA-CEb3G)lr@fG*faB@s3yaS_|0$i zm+g)juBr9Bez!<5tl=UY?_mYh3lrU<1>i1%e@D_;rXJ`^O`Z0dd2lx$G zM(xm$@xb(m%lEp2&M$GS4e`X4owj8daCOVV+OwK;hBbTi5CDtF=PG9`+}3ggPpQaM zqA3e`Hmmrph%?Yc>SI{;)wON^2(Jv^=x{63tzF_?Yv2ywXhg zcpYLY$t%p^Rw!K&D|L0iGQn5`!R!Wky+_W_2G)M|ieWSo2E#eIteuxH4WKc%Yf=@6 zYoMwUQGX?PODr7(a#PW!(W!$5IgC^*NR<9=3mt#_XSLgd)m9u81$!qkh?Bk1nxzFv zw7~s%!h}o~`O0#5rO7BM33PZ8r;Ngakz|rWow<;afmlZgnQ=l>l69T(wK5u_rjgFC zY0?=#vG3_-0SKVvMtU#OT#I~*v}V*G`Jnn0?M4D-;@->>j8uZkace_ME%9YM6Dok4 z*HFSsoMvMfVNI+Ol2Sd(i+Y=7n$XFS)+*EIGj+75I`e^1n)BWAazrk#Ua1vU;5!#u z*1c|1si5PK{di(N14o5bE{?|tc>Ud-82x@ld(6c8Ws*5|!)i04BjqqqVe#hhiw%C^7)!WaMwCnKw zX6tQ6(DembMqCRF;9xYw0$DzaQl>growB|qzayLHW6b#YWUU`o`Z{R=g$Vk74Y}7* zMX}f-YYe!Nz6-E^XO;AD3%z-V@(8!+4cW1F|XY;`GDvEh~Tq< zIil33&tzh`5HYzkR2YOKgChsnuH=3h?tf3GaTr}B_PdJzb+?2jpE)3X`~tB?Z`-7} zeEQaGSf~puFkEM`%t|23_QuH8s1>qQ*%eR&^#j5qVc9hv^UKEg+y-XHgJRHnaQQ_! z`^p~w3(SV&_#mOV8<58;+IddV6}L?$#|NQdk8D;i;*I}Tdmbmh=F$J@YyrWhba?HP zXhCuwjHtq-V~(fj-%zmLr8Ry1nEsv{snWRL^f+eseFbJPbF+EN zxV{beG4!dc>;!LF81^59My{i3y*{Pyiv5Y2hiL3|3umrrj&Xp^5YDowT&0P?GT#vo zq!Ljo)r==zav)IDok*QpibN$Q_}=$7C?vEXqG!VIsl~Q{jh@*%*-W(q4e}eYi>t!A z*sxW0ql1y@Mrw%LFrb+vrKp}bk@3EzuSu9Ey&H~5bLuALLU129d~VzQl9doZCh*L} zizRe=qV@1+IRNyq%X5q7#}&`qnzkf)euJa+M}#NJXJF@mnT3OWp4%&su%&W>0#E2n z^f6L0%K1@h8f|9?5*j`v9>1VC?A*E|{<+nCSn>k2)NHiShBr`VT3j23bC79dSP_G6 zZ#{HgH*`l@L(;-6i$JwuTav<#$oTtKfzK?^vz-hKI0HPYnp!h#gnUHfu3u`EPqg?m zbqg}Ob=V+TQ5L26qogrN7wb_4@CW!~U2t*XYvC@&f!h#I5gOT^&{aio_QPV9HJ`@B z4o7*MKeeDARj39-ImU&^wZ}#&3>+uKLfuGaAxp>zszr2@li-{dxH^+yamRdIr(n@k zG(!Un32vs$w>+{Crlmw&Xrbpj6Y$~T4s;#c9gLeRggADQinV20T-&g#i?X}Mp`r}- z*k$`T-beiMfCnajpu}Ixc+WCA8rehqmm!Rwbgfju?QIo;8)EtDR)nrGsE0l1d@#%D z;Nzy0x$bVyxXQk^WHQwjL1+Y)HCTrz?ZE(gN|G}r)S+&cz(WiI^)NtO?f}Rb{!)@R zdFuKj7p@w&E;RWET?3cKHhg1pkeTWwA5?b_Mv3| z5GxnQ?iCldkHiqHZ^RW6_$T*j#(sF)(FYsryOuQVFEl@{H+|rt* ztPQHNUj{^xvv_O3{t8Ns=Sx9_k-ge8uEl`?fCE7iZXOHlK5+i z(*gMi)Ej%0nuIIN_8gMPtZ((YwcXlFd;Mhj{_uKe+eS0KpaZ$8oCt;IFJuOzy4X)5 zVcA>g3sG9Ga<+M6oBQXNiMgvNRY9)5#}T6^dco`1(+IsujPWA0Ll-n(21{eFdn$x4 z6i9Un81;36*}@V?K$%mA`EI-~_}ks+-)WJNRADMs3iLD|+?!F&i@wn1-}AB5LfRc| z2i;=t(K>ETJEDAx6d|7)UJ`v`>rw=^Gltrog7IFtfci+-9t6~cN^eT=PJKYp6F1=- zkh9H-QifXEu3%EM}%4r17Vije}NxWdMT=pv8~kc*hi!qIw+5yrgrDKmEL-zWiHk)!2|W-$%>(?b%1`k ziv4ZSL&5Fg_*rp9Op0VO$KGU}Vk!=5Zp4Bj{ZpEvRtp{;MEKgk_OOUjIU4P2RpEV1 zP4QMMqemGTANaa*jhpN$_4J;RnG=3`@Cr^9lsqya=I9jQ?!Fg5)}+lqkIanvQ3i}b4By6BjG(&bdQRLTehiH zVUn$(SXllWABJ_G(0fc;jnrUnFjlf2x7I~mO+CkzeLFLG;{g`gq0aRn@noHfmL$5u z50-j92A*VY-JCCH8e3sTIXIw65B#Lvd2>0Juc2;dcCghWN(bR)1OG0eJbr76FaM7r zy39iELj2gIE;;S3RfM>lc!;Y8o?@6PNWmfrIT4$TAY-JS#+8Fn&&|9>?X7gw5Mj{h zm5xRtTQ0)U;(AEBeZ`qxL>pqIRM$x5cKK9>IgM$nf&iySO(|Hx^9tW@ApjTQL!eBa z9AnYm;I=3= zN%#g=^^>MYWgeL4fC4D2VDjJWlI|37S6}~U`}UchxOafj&vGKer63k1!nkx7O|_cU z@ISqRbYdl?uc^OHOsebX^{UN(x*kXG8O2OVQ?!auhgPG#LGMlM$HX`N1Y?sbQibrX zNDdgN{lr&lAx?vs>y9EZ3{!4N`>S_wSEw9?*i&0Kr6N-51&?0L1s*;ma_?=xQ{ft* z?u!5;R$BxB?mPY6&rTC6UJtms@ICu^ol)T(hpjjhp!;cXy)*?;oT zsV7a&{okus2qcIPKezFcXC#QD18n|R^5{2N>%s?_iJ)~Zij9|*{P*ZdFG(afFP(W; zMGzYGZ)G^#@rxMyv&Ll3_-$&MH8X~0O`2o0iFOBY=Z)~e*lU#artdD4A2mwL{fJ?_ zbeN}@miEY=xs#Tg7&qJs?}WvZZvlQf_n;b5msQx> z(}!9L2hwbp`#s(Ca4&Z|MLHr$TgK@tK|satU~3%97hZb?>OQHM1~K<4U^d;%{d8qH zCgZ?Cq3#LCiK2{#r0}JR$oFK%Q=t%CU0JE6*^8#PGys;1*wK{59CI*@G#htz3H-0Y zHsR8p#ncL;nRbp^)a2CS8x~{DCEwSi^D6)h8M~W?b@fU%E0JX}+^~t=phF<_Y+)pn z5*MtT98F2@)EDqL(rWY(|Kc`i*rP#AKwYtD=SY%j=J@*|`#;}qN9va5Vm~}K=_&4O z$L<2dr?Hku1m~MiHKoNj)b=a5GBLY52se#|%PR*y!Ml5`TmaMWL5RPgAU!c|o?h3v z%zO*4Sd)=yD}(F2pPorjNF+vy7%U}r4E`PAAY6-xV!%*GGr&t&%2>vFQxU{Ue(D&7J_i(G> zv(#?Vs-YxSDPih z$GQJ?*GWNi1_rAP{di8h0$%(f+>78Gnj&{GDY(jW@N7Gx7q{TzZT1Jx!uxx7ra7w5 zd%Z@UQyb<_xVDs1A-ys=0$^n^`U@QALb+t>=D(y)=$9jL=~qDy;Ek{LMQ)uWO|_iu z&+}=%;wN83vAByB$%N4PVjwXrbPTPPVQpQ-Mf*)pcSJ*;67N5Pbh5Ud!`S*R85XGfs`=1+US{X{q{KL^SB@e4en(1DB3B(d(OF(z{fKO#Kdj08hJ4V8`36jB{?N9%zzqSJo# z&c9ykWIz(gD|0<`mfvF>P_vnXuFIcZUk(-BeV5&+@KW z)7o1 zx4qwD0L!d;11Sh+rkxj2lEn}hkZlS+y?UAe1QOw7fOx|6y6-E^og2hL$Z*}?&AnkEA2G*)e%*MFHbVZBSC;GEH|qZm|6*zG zY}20gBz`m6>(N|`6je%hO=HFITUIz@`cDX-#Sis~%9Ry{(-nvM`(ZU?*1>)S(f6jw z*UWLASzO2l5{kdgXHD5KA|rn^DS+)A9z1+Oco`Gx(c>YK$I0=2SZMB>B+G!HxgUku z4x2poJ@tW7`)oCE4S+iFg|p>g>5K4F$R|~oHE7`M4r#uUX-Jc4bAM&etyZ=wT+;LH zK4q88_eu$_M}MSy(Ri6}#{QHcK#dyrYZ5+nYHt&dZH$CuaFV}_jG}zH+WVG_k6Xb| zGe^zaR|4)ofnGGk;x&y;vY1DDj!*p>c~#`f<9}5ViQY*A8oP=oMN_d!#2nSr z3j7>ADev_PTK{Q5U};ZjEr~$sn)BelqK*XK<5xZ5a{+Jm()JL3A;aq5X0&UgrzL;} zP*Hhd_%*JtN#gMXiRWTfYi8&w#G_snywtl}W~|@oW7eJEb$szUUWLcx~6s!IfT9;cj*tjUQJ6EED3?llL4t6 zTo%fd6)jCmV2bZWbL0pj+;QarSoy`yNwKBK(Dz7};)k`!qJK|uKi7JE(_KoF1^0s| zMnutpzoMgTd-lP^LnjFc?=XN8o_u=mP6}g*yG}#nUrZ*a{^x6zq>60+F$lf2?|PQp zqF{VTuiF`sU-z&tny_wv-`&VAO-7xA^J6f5tyeBX+IM$_kK7?`Q4v&@aNiFTGtyZu zzouZ=K7gcuo_Np+!Q74i&9OicqMfmd2=&3Bq~|@6RFOgu`7zZ$jjC#l*8>1kJjec( zl2Y|w??uF-03gpuqU5NV+@)V zOI}d(WS!&pr|KPlvI9>dcoZ+HcSd;1hYdogf@XZ^(4bmpVcOD=#@sKrD5ydoQ(vHY z1%uI$<0K`Mh4T!C;0-{Qa=pOnKSLtxFVJpT-;MZu6;pnp`~kr+YKQu91`o+4zu3iEr9i|C-!l^xTjXm(dRRdo)8icTAP#FQhM3Wzgz^X>X?;#P z>&SaOS?BFh&CAQ|-BJv^sT^#E6ctK~LY!2+{`b3^bPFLaDbXBw<4))=sqn75gi!&G ztlmsuh+;lf`ea76PxL2Y_`~+jGN=|E5WD%7gMt|%w$Af<{(nqz58}tL9r=^3AfwIw zW#g%YxLw0nq&iXe`0149VWUzylWPCiH}T=$=UCCgrnM6g^XrSGQM9@1-onu%D&0GD zt0Eq(qq@dJ3wbOoSCrbgYOjyb`@Pjae@LxB&8(syzR<+weAkgJ@4M)gIH7m){s$dIfp>E3u>m zd4UX>5mC=5o$%UD;V^CqUau8z*w3hWf;rI+yGRof_A*JAivl}%HK|cfUU%|YH)h$K zN~J3bNjua*+5LI`AcOh)UCcoRfmqWxV z=5++frqGp|-_c@4ObdbJ3UJ=-<5!i!I4<>g@jp&c!f1O6X>d-Ed3j|~6mFQp>}l`N z1MZo`2N))?6`td$52BZe!65KdEm83cc@R`T*y;qu@^>*t_w3iv(gV~J2)zWW{RoR$ zXHA6C^!yEXieL+NpV@nfG_*fZbeBE@*GO~SLf1$svL+5r5V;(#a!vJd=xX(;y*aW& zE9HHrr<7G+L#$`=RrSJ$V(CujI&;_bQh9T|jo8Z$ z@_OjIjz3+aS1qx5ghyre(qryG_}wGGmD7`V`zD?6-<8(hvSnOr4_r;ilpY}fg0phE zuDprG0M=|b`kQh>2A%7qcX2}nEL&ZtIRdl$)h5WRg9?wJj*@|~7 zeJBMy_F|zeh%3a8 zNQKy3ujgq4+K@R4-o9wD3h7{bt9YQolcJc12*NMFj47mjirqGMX!pWG3ryAqn8Ois zhYXQ(`00A{zhKO12W3HrL0H|ZzWB+UYy0EY$C>(|DA-1nQf;#*73%`{bwR-~NnT&R znESH~qKqq@RH8#sSLq*+8$sQ3#b}Hjvrcb>DMy5M0q{BOipu(kmO?JE^7@3xEs<%U z&=a?w9bU5csLlWW0B1-HZzPMS$@@3WlL2$z{}bc*pI#a(+%g?e1Rz%g^dbP^K?GA7 zh;MqHPo?nO7dK5Yz)2^-*MUEFW+gJPu|a>~+eQ08TFlz$u+*9yKMzdfMZek=*FUKc z$U|~ywA3|I{lFpwIdtJV*THpJ!jNGKa`voF_wnkGcZiBV=2Qt`12kuVC3%53_nNca zEmy@hm#WQW)_HfriJI^bY+m!aI2(!@l~*SMc@DH^-n~<<5{p7R^CaDiKk<-%rIG2) zU|j(s0P-5y94X52p6Cz%_`pq%Dyj<`*%gNRgSAwl#zAMarpvvzb)Di_;0z0fWWjft>6Af2XHEjyrtInth&IRK!# zg^?=kluH_hV+QqQ;#}QDopHgsP^t#(}>2SIy(Q6&jS6N2$ILpjYK7_3sLEw=vjk|P1ly4LtrZxbvitMyAzf|g z(U9QOsUSx4j89wgRG--nWAVHVO}jy9z-@|vO82U>1e=BX_s-dYjIJp~B%!K3?T8j` za4YwjrO}4y5LJ$ctz$r6l&+g)v;VuUK@(^82bA4s9v5h3%R-MhDZ9AybQP|}21DL% zduT~0{uph=Q4eTJl^;>v^ry>!juJpz46#M@1qtT?AXR)Wz2cGTH;ik7cg5(DO$|uq zksr0|m!GWYNB&rWdG_8NR0LHzg!f7yDHWt!E~0cp{R5Kr@fQhF5i;@+Cd4D;b5MB2 ziAkYo=Lpu(gEgPKHL>HMF@W(%nL01rGE^#s8<{8~+U(b~Y)yuCkmB^F;nw!)endo+ zo%(U8ygv;dfC55e645%R2@$HN+Fph6t(x;i-F$L_Bg8F~btqtpN>&m9F32wS$c zlRjJ9q=_=k3%?B+VfX?ot{su}>#A_FMJYl&E>se!Lg^wy?M9;!DbNA*wU{MszdAJj zopIC%glI%RUz1OKAw+++Xq7zmHWf1;oG-^_;1Nl)-C0|s#6y#-szzR{3X__YX~$Mc z?}PKx17YEqZsx*_eb`IX`^KWF7k&H8I?TJj_*uhx zFAkgDCQlPQYo=qh$X3%$)gk<$>a$76+B!R3G^o``ZNz%XcCL$Q5f}@Z5hKvgh>XPf z@c_HpK0M_@Km#{++;z5GcR?W)_c3})<&q!vQ_FpgHu>lnur(N^xisWyI!(n`h@np) zNhKI~rVnr%yG(!hN9a&K*3LC|k&Y~{2h|hU%57E>PA>NBzK|CZrLaf+?~f0wDhT(V z4?M?NQiJ0zlMc zKe;tyZ!eJ7kBZD2oG;NcYnSo>p;MUe8tMwXrUt?(E(KJs*CeR;X(1bfJ>Ds!DV@a` zCAx&yl$+0h=e`>V!tHcKs9@oJpg;M52=oQFYq2hg9p~9q>8BL+WvfA5;kL0`@Xnns zzXwJEjXDP=8#n7CFe3wvJ6`dH%2h8FZiK?4!+HtrFgj*S3X^t$u3HTv#G)GJqf9CK z9`$KnL$S|b?9wHtSw~z#S!R;Nr?-D#a{tCM&h5h1zPPUh>yQgzJ5sCubT5U4y_$bc z<@8{mEdHqVB3UDOH3MIDr=1cUuxEn+xV-OA1vJ>`C!pw09@^CZA?uvFG>f)n`=xE$ zwkmDgwr$(2v?^`ewv9^Lww-yZ-Mb%lJLeaym$^opGx~^#Nj0Phay&dCSY92VqL?ZR zt=e!|QFVr6uzsSzS_)h*;#(iU)M%f1RG7HM_1xdU43TdN^WUCNKQXJ($-2VM`+WJ3 z>j#`=Yb+&T0YFHm%s;2r$tP?Ma^XG@q7=8K1)hYQ)&=IXS2bw^Dbq@#@t~yp=K#i4 z<*XNpv93rLlmJ%*M3)sMLIttX)VT>=Auq2(hI@iYVfNc)vEy6?tMql)>6Z?JoLt)C z3;VTuY#|A}<*{G|j0h~E+9ko&<;@{NA1|?ma6*pZADl}`W{&DEa0dA1P)(7mO>d0d zr0caA@9A!hTmEk@Sacy}mKgAW z5+ukK)hCikJp1_Mvp?1{Yvy?KpMDFsdj*}M&e85Phm)y4=)1XAtp*K*Aa}qt@}7%Q zrrQO7=xRd|v1=!k_{L4F+_|4M3|2syAqDtmjgN_XMQWg`J1{?BGlro>cXe1H5jF?J znDWmeRtCMEzn_zarZ)Xh*CB`pZB=HW30=G?5V=}_!@Q-g!|KbM^ihSjL-i* z;fl2q6OG9utMMD0lGo~i6qs!yYfDM%ie>I0%M@7f-zR1}%3hobPMIZb?(8diwQ32e z!pfRkPPs%&ru~d^+&^mQgI*2jn6^zfiWg|Hh_TmP1M;zKE57p3wsg4sUN{$<{Bc(& zruOT6lnG#MOVSW2m8tA~!>_JvB^japvHzv_WSD15GDF8 zH`-WZ)uh#lOYPbEpJ4?60Zs*U{SyV?KLj&(|JN$TITqKj0{|zHHRwozY)hZhzA-<~ zr?a2^JDhl~xp);gglfUO*%wS342O4s8dbK!&n!xqd5x58ksQ#HgWKxqEq&h*-z07j zyq`9RI);!WCGo9zrUZg?^I0fzUzorSMtAS~`}Bu#ZXz#C@vjwlvSL@P5p>mdO4fc; z+jyJ|KVYU@T-j&*Svj%J0LCMOw|@6uznEyP=#Ss#bgXg%oi7$`v_UU)lm@30doS8q1MuWkV#+bY8e3JQNaI*q7=-zRXK~O*>;yZa`zL+hmS5O;U?e@}mTCk`Z ze1UgJ)+&#eU}N6?$-QT%HG77z;B%{eHRrA&Vt~so%aaa3w=cGiz;rJU%M@~kIW=Xz zVh&W01DeV+xXv4SS~3}Bi6cj7!k{TZh2;kljV9J3?bMZY=CBd$tGQ`5{TPWCYC-@> z!v(?tTL8iT_$D%5xk-$ky-3useBftK4t{7TeTP@qpJ=5y5Dh|4KD$)OG=r{+40qUm z%SbCV1Pi1NVe5(FhOY5^INiK!ht94^aC3G#y@EK8u^>R-#Dn(D6d40$)X6p+Jbt_n z?L#&%At4}X-zd9#>%v;a(e4)tP*IT6F3bkk1Jzji$;ox;veRNOpiSYuLrgP89 z?e;K!WDc_wG6RBCA^=Wk99{(V1S12)AVF2xH44k+A$a=M48=Tg@|+IyE;tQ_mkic43gXu`BCA<~^LhuvKhVu9Pjp zuAFl)CYE1N=lw@T9u)m-lgE8O)s)D7J7=u)B!A@6YI1C&Fy5E!clefoY8m4I1fN4& ziI`VxoqJ1bN^vX^n|6<2J?5?wdHCy6S#-brx_0wAgQ&r+r-#V`;XQxzAn#F-a1N5e z7XuDv;wr$ijZBsc|E{@2ct4scw&vcu#6mAt0r^gvUw#Uy5Q@ zj?!e_>9!UJkxf%a8Ad;us!&9+FU~#YW|`=!dFcIjk9#{}VjVg3_n={l@SV#S!Q2%7 z!7MHlP-Mxwp9{omI&Z=ZLwgW&d7r3_N2plP+{*Sl?`;=H@W33SQ>W?Q_(j{b!>cqL z;d}KTy$*ebpKmngdri``lv3o`em)~)x~ohL@6c<-7YlLGz z!OfpYai(#xKPEfJJO%gcTTIJ^1+)1wSmG9UGa+uRzb3g&BFU6A6 ziucfck-z@>#M$y>kM1z;p;m4(&&CfuS}y0WzOeyL$MyvBuIiJtw(OoyGI}>@ei4_h zM4_*mmjzKT)Xwc>cr?C8sZmzPbx*l5nc2TAPX=9AW@|?m`O%PEFO%JaFIlu@d z8bio$JoY+MZ$cNWgE4lzosK-%3ujFy zZ;+wQu?Bx!*mk4J8KU7{)gLwmqqG3D0T-DwV4r)AkJrz#e?@#0&)4xlnQw&oyuM;l zm}9x{pWX`wD42+`*X4`&^+|)6rqLk@E{8o+N`(_bD&V*5elp#!LDnxA-R$i8GOoLi z`$HJWZ)m5>X{3=zmS8uJ+vO0gQa9Y}FX$4LYc)w;U5P0PCbyd!J_S|t?U~V~R;K3R z8c=2%Vx?mwj~QemjMKNgi?iReYFggdXf%IDXW9a02NFl;`f&zbur?VW|MjYgl^yLP zhcK5g;HikC3=XMMXHrc(cA*E5T?&=XK31xO**FISx2Um_UENput;v#mLQYngH8kv~ zcU});l3cpR076FylN>i%AN=;I^dKC_!f9Khb$&#DW9ygNTFN>5># zmA$7OIbP`O1Q_m%s5wSM%x}2jHQSAaBYMu^wcGr$?JgI2M3w~o9ZvWzgi}`zE{}%W znd=bLH0k|ROS-ca?qpwEI%*jZ8Vces{lvI5mUyVT&a>5UNO=sF9y|ABm>eBN4tE+a zVW%inLJ@l|-`1W2-~W9!(AaGJG4NtHlKQaeK+RqvZguLPCegG8JOD!Fy#?4nT~S9X z9%RK$)s#RT@Jy%_lj>i?Td~=_Op(tvEyCYqg`TEdR0tMS>|fo@6Vu&c`Qe~wbGVua z2*9sTdu%}RA2q1Pa(J&<;472b!4yRFWuLszxJ}x*7+7=ojjtD>#e(v7@!(G-!=U_` z1*>wrF8>m-76l4=n5I*Q@I?LuPeRs@X-4NTXR;H8)jz|O^3ll`K=V`6(onv@QlD^) z=E1*E!!JhqYvdF|9kPi&_BR8k;OJ1t7VgB6k_a=`V{BkAlGWeb5d(H_`Ksa$g{^L0 z+cS*5Rc2Gf*AHjrjvV#&&z%mk|{NEPD)#Tj*VSs)W@X_ zM9Y{GRk}+H0M?miIs;Q@KZHhoe!dCeR}1KlS2I+zf;utu}eH82RlxE1EF> zd~@OYXP#395nKIgN_HI*61^L4rM2O)G(J~0lvPASjO^QuJ*x)B6*7OjrXz<_atj3g zvPi2Aj?82q7(^gewx3x0bKFkF?J1Whr{kNi2?6lg!-P37?!O(;(|fU< zT#>_O_v>88B^!HH>5`RMz6CTNzJ>*yEEEyNJ|Kpn75zamUC}doC+{Jkx@K!quwoV2Elq1DToj)e|JHzWqJ_dV*4k zx3n7?B;(!?iYjG@z>@NTDth#oUG?izg?Kj~Kw>Aw`yXVhYbr6SJ{& zs9Mcc6y8d0f8QLDn`Db~UCk=2>b>Bm!8A>ud$WCmj6fr%kz~->{aE$it_tW}t?RQF z>d2^|YeQC2B|HA3UV!${pd){}O{G^PgJeZIRlJO(x_OqYfm!G9*Col321P@d()x}Cx26RtD6cYWkmr)3oC#yFcYf}og(!Y)y;iN9w?eaCd!)H|`7ehS(oUtKcF2MlP(+OYIldm2CRzwdPW{5pj zzP_MjIvG%c3voT7vIQ!Mc^^7ht){5Z#!eW&S7blrRophYog=74V{G_o0y|oT*`fNw zLj@ryJTs4B1kZ|f)#vndJiWkB+D3veo3xp(0z?Vz>0QB`r9H=r8!^kaKmre}nm5VU z?j0Wgl*;9fgIL~G#iKX@mc_U)PPE+|`#ryuIcpWrzPTd;l=dZoM;;uxw`53L>`*%V z?e#0FtKE4Bz^nMQ*vnhSse~K$eRkSr2$*vLK$@$k*jzjOxyNkyf^$#5Y|Wl|P66AQ55+X@aULN)^afMhvm2!V23Coo7O zq>rjBkUBOSa3)hM)b<of;ssAmx;qP@)8+L#TR;$$UHM>nG~)P8X>*#KFQfFk>PBi?!nZ9Pj7atkhumMD4{lrfN|`n_eD-NEBM@kd6q=Gt4hkmMhiQf91+lkpK`KKWjih(vc#_%Upu$(K7^hF6R zI)fjVDZ(bg{71z9FrJQO6M@mSjAEuz?dCVv#pXKmO?P)iEq{P<4|G2s;*mG6OoSz1 zxp0Le+l59t>)45ipvgMsiUxAs;5cFoGz6{T02lDKhCgLcWJ1=O-R3*^e^#-QK_2>A zRbq&z(eCFRisXsZ*m>j%A38BHlY*l5^~!1;U2Q;py*Sv@f6~X%)I!BGl^Xg+fSM!W zJ2gwXdkLj$`xVTNPF_pOYuDbe7nCKNi$>LF< zUe#y;9>t8wrm$Yo=Mw=LF4@A){W3khcUc)fNm%Amc2;8TETHK~C{2BTdpb=qm1JMs zz2T4nR=p%=2nsOaZqM`yNz~)GOU+Xw+SnRbL^EFBXFxVK?-MAZWemZF?BR^Z*VHIN zZ|t)p_{cgvGPNV!h%Ep64gdp*@qC!S_3qBNc{nGQuu4o%p4R9q2mjD71zaWc6_mBh zpl;9U(M3l@+AVwXha};kVBOjlmmAonH6K1Y|H68-GXmxsQG;Wj^Lr`YlEN3t_?^Tb zi%TvVMd0Po+8C#et+s-ZkMd|QT+p%T^;Lm0t)#Q{*2k`ChGBt%h+~OpINGrdYWAZ_ z5TyIh>4wmMA1Dmum}m)L<=9{=$Y)pCJaE}t8sFK#j-&nU_d=Rh%(sIAoY%Bf(H_HZ z!;Dr3ZB@TCRewkV%GrX1?6lrYRH-3MPA;m&z%CP+Jt%oO%&R?M;Wi?Jh2HT42{=fd zr7|66d}m38i$sv9aVY(I>B!E9rFH-P2Rqqe4ZyoJ7!0~bZ<;Q52QmMH?vAwBfBVGg5O45>4kf9;|r+^3p^dMro2C1TX{G zzl?MhPI;spOzOC1*^AkRP_85Dz;VD=NpqA=odUyWnRWFZL9C-S1naTIG$^yOrxHs& zS>S3TcgBH=NkZ$dB@0|Bm!69+-C74O3%gv%*B0bE^#vGQ+amd>V{kbGGg`6JRA{ut zZ+w^ytM3e(a^e<`EPS^7IzgFXrN2h1sywPCf-T*u*&^KV=U4R}vGW5~6oX~W=2?

v|D>|{{W0izX$1KBQBP)uJGl`aV|etAAe?-1*+z@of<7nXy-B+)%-NspfY z!eoNTAwq3^PmU{J&jB+=4>qfb!->zWzsZ%uyhr1!OQ}0;(bE!6vv2z)3$_(e)_LCZ z+b(hah5eY971%<04lYe^&7ww40d2BL*3aTyW zc!hg&!{Ncxm1$Cof4FM6)}(VYAJ5Hv@Lnsc4Zag5vO#3!KT>BpID#I00P6fdG&2a4 z!~5UJoI%Q94NCwnNnW7zGI@^^h^Z2d!n|~b7$B=B^=!Bvs$adl{)rAJ3J8J?o2e^k z4FKIiBi4cE?L&EC=uZ)U%h9+v;*N=wnbxDT*Vyif2A;`=!H+IG4NX zYPFV$mXAC)?FS_$#H_pQ8D_%QDJq&cI;PXSmz(X^QB#JFd|i+21HXCailMsi17(z8 zL*TVO$Hm^>VeP7jk?YenE19q@qIpXOs7G@zSZ+Hr=VD^K%nmFB6oc*V5FnWTIRhky$f_!Y&Wnr21IgkmYL$vnm4LgW@q4_w1P^F7=aGfQGETo|Kzy| zld<-uYUIUx|4vq-(cw!rUiZ8+Fbs^`)1npH&9)|i5%b%gql6@PB7I!@s?Vm2q<1%s zf~F~VGZxSeY)E`2RyX7&G-f$xBB>@AY)Ik%h0t~Q6u^>U5YA}&434B!mHR7@W*dRD z{)`{%_uDkHvqsxLt)WF@cRqbhgh6bv*sjr#fwswpDkS7G3ZMr*7>HDANXON0H3QwO1*c(fGeU z432`w0QHT7d~dHFhS5x|FATmbAz4|EsV~fqe|Qh2oa~MPXh4~aPS3HZ)lMH+7x`() zoukS(!-MvI*)*j_i2@d7&7hxik$0Q38~%Wyr6MW*T(e-~kwn#+Ix*(81NtG*l*jt< zaByTB54To9a`i`LgyP^}$bV8ZZv{V1W!cfPMaUGKTD7Zsk0O@hITP7kFz;;EiucM^ zp}SI!#ZVA6e!sLJ=dg=pzD|l0Kf#GM0K2w=W8 z6Bmt?jbd;YXg(g&SFr3h#q4h<*0>O?6YnvVm&0B-b7ZTXa>F)DQRk_Ngl<&wD08`l zqpFQn$|GUUXDa%@DI}(C0UC>=Q<`<`_E&4BgEh%~d0ynv{@GZ%k}!J@2hyVXX_6~! zOl(R{9~l$H8JB@GFLjN{akkiF_<(1-qn5qB0n?h%Cf+i+UngtsL`KH0$0fx1P(4!nRr%ZQ)&nf0XFCh79h=Yz5LBnHfTfG$ zB7^^oG91ex*neY81t^FAzX`J}f(Tj)`}J2pN#$!3)tGq05iEchfp8he|2D|16(%O( zd&zUhv&K>72RVR#xdiR=JED)Qx*yQBy{^%=;$qaW7k6fY??nQCgJ!2ZGBt& z4Hf*Iu)EM-1V6Yh3VlCwJma5Nk^jo64u9md;k9nv)V;7;>NF2)x;)ReEC?h?DSkcuoFd(18d$0$_$xcBHz!L`FMq5SLMrW9kR{-ZG_aGf19yVuN_ zecDYhX0$Q^pg_)KIcK5jGDUx$``{OIGnVjXac?;WAfoILwsOFq`*p#~yGd~3zo=x` zL1k9y`AtPs14nOyU~tqzg+y%uy04LeMWSn2x!mp7;LCU!OK}_hV*KPtZ`Ga~=%v|) zi)t|ww3Vy0y)B$TF+WcRj+_1a3(<}PC==MC4r1LuIl!D8y+{^QA?>`_~Zm!g` z{>PbLcBM@cYR9<$uK*%f|8rlev{}7xxUk46RXaUBh`Ud{~UwL;TG^Iv#a(@5v(!9g$K5CRPj(9Sze&q zv#HXaj{3rMNBgpIvu%wTi@g}ZeGE2K;B@#&HW;H%OA!e$ztfL=<&?VVr4=0Yijv8ras zOr z$Hd}|yNmYqC+w_tp6L+$&}GpsYFtJfmLyfY6;Nt~3%@Kdz_V;7z$TdPknz7NIX_$! zChi$N)!&{)gcZ7wlxc+$tZ?_eU~x;Z4D}XcX9%B}c93{egL0CFx`uHl4)kgGX65A) zw(s50&ZBODHEpIeAq!UnDAf|w2mwF7Mht6i>D4IHYxy(K;gdr_X_%m#K@^8YPcUO5 z0Ag_T_CM$s!F{!@O^nkoQ>6FgHFPNyf2!6N4vpUq3u_c+%kP~}Nm?W{8v>j5&{`q? z>J`e1sBpkV#Q$fmU^Ia60|0Pmf*GX$3k4tM8vPc8j4s<d-UV>W!Wbyu zU*$tDtP!35aUPZwv5&|}8Gb}?yc~f#t5W=KGtY^EqwSdrY(z=n^*-g8kW32g%Zi)I zN$;U|e!E6*@aEqwM=i-bY)B=0FsxX7>EHP!VA?McR8EoM$#;qX^-v%dizujak!N*C z4uiHgLt+Oc)2%iSrG_s8dTRUc`R8_2^CEhv09|b4cut%f$8YX?QtQTp`n}ZqG6W9c zN^&=62`p|Lw~T5fodl%d(0c%MXT}xUg*f8RGv6mDa`|>!u^8?A8o8pjf`s954X&5Q z4G!P-t$A_aQnIflQv?~PYkv*W&h%#^U_qnfO1RLmS|jq~8e}ibC0-F|(XIqK(b{3h zjVWhT=xE2uOcp#IN@RJ2>gyP)l8Wm+(@&C^48uTZ5Xmq6N2nxz&=@LZ|q6UVG*`i<*v^7iP8$r{8?Lo~Rq zG=ft0L8(QT8Jv!S=FjeOw08o|4`r>K7o2yn@Pi>?6LayBe-XNnv=BOoPC=iic{C42 zK=Pgr7+=j~{>67p!Am_K>Sqnh-?-y5N`>#=RF@j^KY$34BKg?B+pLZV(Cwl{Q|sE# zK=k1rTXlo`IIioqQS7&-h^Qu?Ofj#&>GSuC7ttBYXPzwc29xnocR;pxQg^Eq5jI4= z$MSS21Zr2-hw6bOpGZ|Y0<|B4 zvm{7YLKAiUX-2}I>6I$?ml?BX{S=tF4|ibtWai`zJ5T3`bQ4B%!vEx4Z3Q{DpL8K- znIQNyF}m}7-q)IATG@%E?R;N|h2?B>g)lWNm=_1K2C7<)1pA9c=%5#PxNXQ&J<*%0 zg;1J|{Uv}i9O<5#@u7((SU2HfToGT^CWPjxEr6UQ0t|Jf3bM?vbJ-!9oaX_96M{bm zIqr6-nWX&M>di9$zNiV`_z)p@Jo-%@R2A~|OXr8=AXR$c@2)b#)1mnHM`dg%H`CzY z!ug^7x}M%4wk*X9Hm0t~j}fY8a4o(cz0Xb%KIAU#lBU!CEZ7qTHWM=>P0lTZLzPbZ z4v<$jlC7Stot==37$t!CGnSM3ya+R!-Xk9F=uEOZx1cfW(;~XN0fWWkJF#UhWc|<{ zVR+f|?DNGFsS^AUoX-SaIe7-8-7KzRLp0DI=f(VOO@%Y?F^acX3ncwov35p75B*%^O5^Q6+I+bc=b<=~OMt`RXydXjZeYsJLPMiHc@8$~FT^3! z&7kOWd!&*sZZAmy%yD6Hih21OZQ^io|#<>^2GP?oXCtrr40Fx=1y^)#`-!*j~ms z#Y+H)rqET9b20CKzM?D0<ZP|5sw;s#-HH>1o{;2HYEmN3UQ~f+2eOS@nHWx!A=}ltJJ?fYl3=?A`M4 zXvs1ig<`g?9|Ckmoh@c=0aAYAfXb8zoLVvY&gA~-ueGx92u3-d5r;(J;S>R+=jP~s ziux@*^KaBB-xo!MU@B!DuY>kL^O7*#pNfwSK!HhsrM_aMiGg*QZKB=X6`_4u=iG0B z&Ymyf4F!{t*{2zKyO(JnC=Tl~6$@sWY*%XuU2NbYHWhX{DZ#;}ky?4mq@SOk0}Gc= z^O=wIt6|SMCGpUF4{?ouR~5`I33wyz$53wEM&nARCFLoMyD8EGmXjEjaZ&mJ&SRxK z-J1<^m-3)JW;Nzx|MDgC)QwQpHa#yBQfbY`F)x%WtY%KKlZrEIhy!3<$|=M{3s^iyUGFYV^IPp9vm-v!kPz|_P(t<6?5BV{)@|tru<8VQ-XT$&>fZ5 zT5vv|sWvvhYYdYz1od^}z#j9voAu0RR|P&=FO~W*ZMqH%m=JYCNIuSzDCwV<6r1Rf z%{jSwry!(8pUf-Msm(x{?u7m zfOYzBe7chOLk@&T8*gMnV`&23=j}Vi$P6CWDDc!AIhe(^RsaY;U1oW>_^((s8ZDB_ zYa@Yhi-{fEVoc4T<}kWtFPPW&2|oIts;QD;0+kMt_eX)iD1CdB3+s5}ztKB% z_REDD_Ipb8^nv5sL8r8M*Sby9Lhsn4a(?yoM(HlK#SQo+=^ z4=2*D{_1*>)i)$z=SH=uKfJ_O=zp&=%thB{JwE>RCgdw2`+4*9LG)htql=z3CQvc~ zpcAcg|736xTODcVg&6$qioa^ufkD;$3lGVu;kTjCKONnG!Qa=7O4FrCnu*9*5qZU( zimXc6cC&%>bKlc5ew^d(H5$zahNR4tHp$RAe`45168Vj~BcYWY>FpoCxzhs>Eu^v` zQf*b}I?6%92-r-KUrMS7&8yP_OhZm5)X+CyPqqxSzY=W1a8A#IgE zT4Uq4&a>)_h#%K*xoUi9eCM(|riE&ru$M_Rgoyd9J-MiVb6p@_D+N8Q_M3?zXpHZ8 zt<{ecW#+hh>)6$M`jd6TT|Ru{4v9^RLD0u6a1-e6YqPq&X2Z-YuNw3LOqFT<0MwHi z9u{*kl2oM#Dv^TYxcpo2d4KhO*RsP>zx?N5-Jn#OOs-%8W`BMq^ah%qavx&6yAChb ze>@&^BdsY`#p*$xtbU5HxZk;Hp(O;>zAj)VtDw=XxpcU3gCrt%q0DhP2!tHcf6bc_ zcE^lME}4*yIe~sfriTWV8_7V*k$3f<^b5oVo67KQ0JN-KMXOqVUy(v7M^ z9y^csy4?(lE8KSDO4*&gP348<$=*r~p$iG9>nnC^u5UtS1K3q^J zJL=e9ODlYm9D%T6E;jpjBHtp!cHx4cOfpzhDZR>vRn_3&`E*l7Ke%5u`QPT|X-WC! zaRZFWjXaonCiAtKNDt>|1Cwy$-`{kGv;7UPnw6OALy`j{7FWqx`ep^9)@#$9ljBD_ z&#Otx8=Y>(&I`Qc=%raoFvXRi-kMJ-ICc>f-JSe$0oBkZ-apZnGsx2e>`X%&dk1Z& zwl9~%^0p?(jgc=O!!R`_sSM3djwZ-Y~j9UI++b>4s z_$N+Kz`a2|&$;P4QunWf>JP7XsAB5JKGiii3b2I>Es=F;it&}>SsCu&5Sd>pZs+yj zH)6gvv{j<C|iVd&5vA>?;Nr~Y{MO@MUB%iTHD^^>2Gx=jx@#$3*K@c3g26v+Fk zOB+6{U?7#s@EqjV@Z|i-_=(c9xX{~G&wC58%L7uB(~UWF>2qsucQErsqjP|hDv*uo%8$FD{rP4r z<~>xHxK$MV6Uig^KiR-9TwJzt|XVH-_#|7$)V|=*p4d7t$O5~<5%KP6;47p62vr@bMdxyWjgnjAWBJHLAmljb1M+Z`g9N9G zZ{-AsZ5BC6P3{mhO2MUnjVI$6?arq Jb`Hqu66{t&Y1UTc;${fb&pP2W7?dFf2J znB7QX#7Tw|VW1jhY=4dXe3mrB+DB9l!O+ z^zNY-F9AtJcXKc|BwA(fgt-SqRAlJ3(jA=QvArrxfzZLkwVmp*iq9nnQA(;@`Gurb z*#=*l4D5Z}V|0XVdzYaRo?ovKIbxinsXJ4ftL(3%TrV5@V6Uc+5MaAWY@08gkX^=wVzW(R()_0 zk*q*k-U~#B4843&N3=#NZSK-TLXk?yE8=}7X^YuB0!UkFl&>6G{` z;u)F5QG^9VW4{d?ep5z$6;<ZTTv6VMeW(rMkjq~vgM-PK@eV~7{l9FSk~r!k$koSaTE>dxz*&(<`0 zRaex*BZHvbvCE_$FJ0h} zzG!VIB1}{P=@j`qV1A^qaVSc;fU5b~sDO1I8WVdo^0X(sixVHDR|9sgCW9lPO|N-( z%e@ck81}H2jh_OeRnHNLul#HE`(Nv53QDd?Wz#UbIt~P(M7~7cq9R)pWXf)j_JH*r z&JzyPb@y7Kyg6k60lnE+nQus0!B6_(%WM6V;N5J;Xpnvo1%JM7A-#3a) zzrlN30NGBrU#&!Y1$Y4aJ=EgU_%Hh0bGb9vKj}KI*hLL>Ia{lqAv2Ow=gX8WXUk5G z{S64Wt@#x&WKr;mEsA{*bPtNcSrb*w)sYEH5$j+YZ{5cz|WDy)DQ z1;q2HeCPTVwkhswW}YBjWiGa+>n0Lc25b5O77PRdcA1anuO=Q|PieKK#X$%x8V1=^ zO0mHT&1?wh#VhW|~5S*b}t8rx>VfoKA!0-f`oytf()YGmdAS@s-gq}y_TI+H^F zc4oaiKt42lOe^~i6EAoK2MaT-0t~9VN%cgr?doy zEKtGi`o-;?)T_RYVx+;V@y%CtV>ta8y!ARKb~8vi?AjKTXcqr4vKk%N8Lnq*-yJfO zY6Npxy)WLHfyy~^>QEgiSc3n^6#7`UF!Kh6Xeye{MU>i}O-G2A6&mQ5=#)18)cY^_ zhpxmMlQy6@y7*W4NlxL-{q;g|VxN#O0v_>8sP+z7IyDIKYFAb5{>w^`8}<_2IELQS zOE2i~=xF(PiU*>O(l z`DydNUkWfE**}(_HczDECyA=lS5>&^@&;qt#09Ir<--`g&fsqbL9H2QTs5PrB1j*Sx(xvm0(j|t(-LXKMJe2xm^OpN4nzV-p2N!YwLZmf_{Cgw&~y{5N}MG`Nk z74O<*<55@*oaOa*OBg@KSLvQ2l-}cqLkip`KMZ}=V6#HG>Hg$VkUup-#hi3C zvfm^u0VkNPYB<4;ti+yd{6eM$KZeQw(fz}*W8x$#n`0_svU?@dgOVsG)z1B*|MYF( zMvYqGQpLxJ1QM|^P8-Bd#W*Oy6j#q8?Si=g)W#p9l`pdPiOWBGee5QnalX_+J^>m! z-di;n(!f(dT1{~cjD~38i~0D^^7a3cbhWC&rvIJ$1)v<`|3-;g|02%~jg_5uNP5t+ z1Eo7}U;!b=K)JO;W7r0D+gY{GAnyvxfjEdr^?BZ7J`GDHugOZuQ~*@9nu5s#8cp0s zH%&ce-@JdN7-tK6EMmAVRps|wT919#!;$}!LQF(4IOG_FownL#_W6%D{ z0D$$L27=+Vn;tO)hSXR3OA@8f`?6cONVtjAj^iWT5|hqtuU-X`j-~3Ii3~dAgb+XV z5?DSv(vegf>YQHtZ_}5b@SH{z*doNuDsXib{Fw53Ym^7Msw`U}QJUSSw7CQh_w;d2 z4+Kc9WXq&Q)AW2k#uzS9Htau1Ktyuo6-hgzS}$Ge*SIdA9{hP^oL7^OB9gU@gLNI% zsqs;AmqH-#=*jx+w#X+|Ua`et$MqukQ4{3VDjjlF)Hfn?PZXhn9LlRM4SN)+^z5!E z6vwfP&lS*KuI=yjasuYi$vf@Nkzy)QTuD36S=|xDb{guKR0O<2!1A*LIDs-9S8F}MF#TD*?B~$ z`qWOvtJOLdHxbTQGQ8q|5q=uC2l1?cpaOlU8pV=rI=SJBFSWK%snJPL1rLUq0O^ zor|79Qw^!3#`_nE@$X=xpsfi40I-yT85aK`Su8)_<*5L`FST5xIk5NXyh80E-~B;x zN|qkEk%6ScLCQOOE2NB4G{^#-A2Bunpv8SDGA*JSpGU-nEu)bZf1AGr2>uZ*iV|JGbI$!2kN-HF8q|-2|pe9$|_Iq zLQO#q|I#1w;J0JErYWxzVum2YC}kT_Qt@yVYRTDiM4jtWowA~)cn7my?;ZPh@HMHOr|Ht>@(*;=gcVyR3b|Jyg4J)UI~MTk*uPG@bJNjUbd(i#R<@~ya)Eo@kRbEbHSe?Z z+-L0Ej`As0Mav|KgP(-w@3l}>sACa&VH;pdem$ThCl8bzfX}LPq|`zG{u7mK zSsv975-`NGSKe5BbI8;|fh_J;hjV>5!Hi#doFQ}m6dfPtl0jc}tX+>eN;Xo=oHp8z z8GI}0svOgK0M0Ge1g!luq?rAqlj%pO^&}+IfO4{6g%6FfE*i@vJR2-C2cFoH0}c_M z(R{_oHneiQF%#4t#bD)LpFfb)#s+AYuN~gTy+_D$F+~;!?C@i)P2B@Lq5n5t>gEtcg>Ub z+1caYnbKHxtkul8X7u-uC!?02H@l&ys?0pay5l2^Ed@(u@aj~&GO%9!L{rj%nCi6i zb7awR#Nn_U3&5&!`^Bc6nqC@oN>_sI7hj`<)!vGysM57ag9E~!R$qx7_;ZpQ7&??m z>6PJDSpps3aK5u?k2A2cY}br%TwRv7Q~B`KB9vNB zMcF$XZSGyRwSw0xyOlC_buKVJRz{igze0$xsKRnAmHA2&aa47N!tbavx zsjQwRaUU?`rwEW9*(LopL47#|*$TQ5ah0t$CS*p@MNWC>39>0O`g3uOjVpg(!MLR& z)Wcnw9G-AF`hK7cxvX1}Oi~*M_K~xPu9<|)40B9P48!rXGcEcRyGyM;fdgdxOCJl$ zQ{YwLjcYW&d!QMC$u=t%d7fJ8H)z8gEG2SNX!1cQLP=B(F!^3DM**D7dYgE^Iz`#+(&6y?hnl~RRf!hGfzYC8_ZJnhl#d& zzs%DU{-?dK@XKm@_TCTm(A^~^A>Gm~NJ>gccT0$f0@96wpaK#qB8>=0hYA?9G)T7~ zf+&i_JLoy@d+zVv_Yb(A&)FY_HM7>NnOWa8YqQth56>3Y;_MadSS8LpgE_B4^2^nh zk~ZOdeC{vYEF0DgM`n%8$dRYB0nQv9VSe|XbC^zu)W>J0TupmOpwg!6KGOPCNjKZ$ zEAQ%nIz>Ba!Tsng?wyD?SO({v z9fe#|?_rL{;p1_t>h;sAvQje|iYZ(@IA3O#iXZjd5-5JIeJ!(%hTPyyD^CWoeg2pc z{wXslT*Zi)Mwk9f<%V091P9N>H3?Z=ceoA7MdP!W*{a&sQrhwRfCK5Y(zZ_b zFq=i;Ofr>c>+##rVYThrvFO0pvMW&82XJ84=+`-9Wv;1PUeHgg(Rp7iBb7W{Y0#kY z);fx=Ui#UVeC&q+Orv~_dtb%c-}y{Eo40W=8}aZ((|s@rkTRoPDz{e_8_(}9s5ZSX zBdtAsus$2{(L%AXdp1c$q~eY72fOZof~z4sp>B7YR>`a=3(wjXEih*Ds{YvcCgtVp z`GM(u#2uM8mZl2FgHEfJTl_wrH5{)Bs2K#?yK1gHeY+j1?rGs!D-n8h>fSK2uNWK@ zxI>OHqOP861<%o8@-dSC|8nRUlqMM*u@-H zF7UyXa6Ox2F!nnQNzyetk?bWuC#(*)E$+^cz#(_V(;v-lYx4^wcCHBgy!W1sEs!XE*0_8K+3i6L}SSf=K?E4hr zLNeZMQl8qBJ6Il;%Ku6=$mjQ(z%6Mke1^Z%O|b>nBsSE>xK8M5X>76RN5^;SCWyJ} z%Xa4+;S6Pj^}_rkmXiJh*)^|#{_u~?{LXsHpNXUy*&10t-B{#`j}Y%Qbdr1<_YIBx zpg2Q*zD9|WvB|)V?y9hv(!*=31?!(Ile+LS%@@B_38!8kDo*xEYgMY3oeW>2GuJd8 z^|lWZa3oNVpO*}mHB|CEG@cYXtQlA$eYBuGLXGjJY4(~R-y=>B=B#pka{sC+8$B^| zv-QHG10T9lY62&;XGf_!i~O0`x&6ac9Iiz64$@tNRWv6f#`nMxo)3H`R{v z*W$o$MfY^+N2e{N@w$gEid`Zm8e>VFe3U40da^=fVEyhg237(VZ&&M%;_K2})LL|l zn#G64fuFTOMHs;vl&;F2;WA7#wHgneD3&Fy(L|Xj(_abI#hLMh537VOxY60E?aw%t z$Iy~XMw+-8-I!xsEu!FE9Uh<9-I7#|Cr*#@dAm5c-f6jOre)chzT3oKcQt<{eS&U$ z>B+7yrR23)UyD0IWpdzlXb;;dn{L)7(U>oZ*c`YerTbhdPouO)q6PIEN_P-N%t>Kov{qU zR@%vP^9*VG%&N$agY(63`Ad%z9Mu_pi0kbwf^!W6+M}fetuoAH4<%W0>I2pzXXJ+- zs1fUC3GZbgb2?&l+4+y@iLOpHAn48Uym*4G zJu}>M&l_3!dPvSlk(5Re#^~-gdt|E8T(!Oy6*f98NHwfIfx;&6oTL3F!9#!kl&C-B zN3W4)wfJgT)yRBLWz1DQ;TVMkMuyjSrvpx1S1&}BmEmmfyw={n$fps1kA99Qu?BU& z8?kv8m0l3uQUC1zPs81fP{A>>_fiebEV@LsoQ_d{sq5YnpmO zUdU>9Z=&i zBc)t^Ol8}?-traf&u6a2_B4&K8g{(MxJ5H3YqzW^(T%$Ou*{4a)xszj?Qumx6eq&H zm5nn=_Qlz+)Z|Ju<~?yz^ePgSK=| zh)Y`5hh0I+>L&srT>DuI?$*B=b*FsBlWVLrUEWB!Klm^mTs!w8n}EY6@R1#{%}`xr z$;6R%bg0bYz5v>2!&EIv0W%(kP+Uq6cwh>5!_kpc%Cw^WZPgwX`%Ia z^f@`!=;}8Gis?4(H;FymlB?LVYVOz9G;ZXcGhp$$c^f^Zx-otEL%5{bmi>!`gO)|c zC?3^rnUFejww}*+FBGnh>2dKM?%<@GzR?b459+aPjZ6`_Sc)f-_k)na{Cj}jg#ejA zj6Axdsg$h(=^zI6Vkg6b@^is^Ozs^kUk#emx%YJijEsWtMTuB^?Z?>dj4T@URKt7t znHWgT<7{G5zq^jFRqqapid-MJy>~S|LO+~2t@RyN@YPddmC0;5colwo`6_iui}Ifr zUobqsR)wCNVjWz1S$16{)7pRDT!GuenI)`0qIsf(X#2$%u_CA4u2OD^gqNG;>a=}9 znoV4&LplbY~E>`9JU8gJIurx2Z^t^n{a5A0K>UM8~EZ^O74Z4Npe~ zZ9p1B&#J+!NQ2VrqoY>uc^&qMck&|QZ!9~W1QZ0w2{gHOI4;$7ig?w(PsPsq^)#~2 zU&4&jS!(l%oQw7XOU(%X=$_|;Rkyjr4@AstxyBmKqU6Mz65ebpY_f|?N&A9q5`DSP5^=rj z8@qmAkxfvp`vZsFZ%HLW{l+|{E_PS%Zu4m9kqq#@)QZghHBaF1gSr< z4KE2ylV@G;xH&lxFjjmPW0{5bw*P#_r3ZrAwbFbXj|2MTI0djj8MD>n%~Iexs`F|g4muXL*QNnDc*<+^TJmuOVV7D?JW+_*}1TPfb!7dEIPe1su?B3Vr=wTcWRd3;A)s)N9L2x^I$6#oA=u zC>xKneCj(|(eQSbpx5b8raR8HhUcg6PDegIwk4+EoM-PuNj~^QioTOfeYoafr|P0pXBns zD*QQr@eJ98YGMu!#qvw1`Xgv=heVudujYSjWF-82@BCBUz>5+a+J;%qj#U19=v#;M zBjkSD9**^`6V0SMfwiYS4sWxKtxWwj->7ehqasYU2r8%WzuYaIrZg`8*!St;<@Z)- z?KL~6XxH1zh|~v(O{OciagX-36{H2OX_7a~%Ih24(+U|$BJxS7!05g0d$TNFCQs(& zVrpIfjTl5PI@FAu-{-o`2wc!wnT;u3d^~IRs55oL z&vK1drlxCcNGdz?Qg^zxpK@{4>A}IJOG?TTb(qnlM?C3Th~{UG159QF(R@_7tAp&t zOyL$=ad0HsNamC@D0lAL({2-&DhW&Lc?cv@jE$H&%_Jjli>* zn+uz&I`!!nf*~N@(b6-~T8bm1DetKALJ4cu`OuQK;Ctvjjm<@XrO4fe{! z_V=}RmIwdB4DQC=31hyEAUJeNnI(VSjDznOI=LAqPE=m)mr41PjC`r9AB8)*5v9XP z{7{;o?A3M8`}(==lvfH;=9ukr*Gr6zM1ze2BK9m&A|%pqb8M|{U>_N%-WGIT%!}bC z$zY{M?;e~J4iBa+$PRmYb=r+}YF_7K<-&zkt;_lF2&lU5n+!Ia{4ccunomJre`pQJ z34RfsYH%&x`n=1M`I>hM4^bL%{osH9Wm4+RMumc4*>b0}!rcW${L3j5)m7xFR#r$>P%*S@)*;K;kt{(49eqdq0Iz&MVGaKlIFstF8WWM(o}5{;v&zUPD-+e!`C#*iwt5d76IP&kFXjE zM~5Y&iuzH`)4c~=??w{i#&IvcOED_DqkxIIl&FAi8kHV!e=J{o`8ex-68b*t4TV~1 z?C0-T+DiNxx)mQebHv;g@A|SxFBe;qW|i@kb?103@R=x@eWLKIM61Wo?`8R;1>O9{ ztR$OJEWN=?k~S?72`#UpYcw{drKj;Od!&~~-}%yZt0iDr)I|E;4|Hcu!mch(yJhs5 z3AV-wuhW6HG6#E=UB^p$e8ni03(9BgoX4;XS~{2c8sa+aScMrh=Rb1Hava?%E-K<` zIwI?}xf7&qj~!Oc?l!A=)3c(ut*ehivHQ^8+dIud(1HF=Ds$4Dw&F+mhb!D+T3?0G z5igQ+!w~veGii;oJ6K7wYm;p9h8BTi-VZOQ`KZ9{* zqBM#i;1QZv@=o0qg4+%-$p%lA?RD8hJl zReL2LJ$|oNuO&;gYsdA#I5hhUA~{9Ybe?G8+}X zPx=JvbFaVi<-TFF<3VlWIq~(;P17ggWla&eip%yRj9Te6_iP5@Sr2}`t@c@48j_fk zQq^i{H@VOx-RU44FHOA@EK$oyBjz#L<@=G3K-<^>!|Q`);Q4e(^%tIZS+(k0>?B+b zS*Q4z?qW4)Wxh9Gk4Sf%S-PVl?`}i0-*zjt>~O6*&z-1yG@H08*>m6*$sulmQ_#(a zqhH?E56oO9V~Vxr#WAB*W;2MAe1cYw>209f;MWv2*}QM&b!0I&!qq9`8&oG5X+1HP}Mhx8P-#tj;uL`^zyTQbF%I1wO zN2p5|p|5rVk!FK3@d{e$&g1gwpf2`j2UJPBiyU)A8yN+0a(B*A;bcg}&m>6F<=x#= z7css@aaRBPs2pqLtbq*C$Ahz{SUF1cik+2314^PDg18;YN>p4Auu!iy$~CTDR{0rt z{ZXyA8RdDyU5EV+59?!cn<^swX^m4oC0zy>9yK>MS5&2NouvEo)we&)G79X(PDa!P z|7b?jY5vj;=()n|RIeUIT-C2xC-pw2m7BK3Vv$-;O$a4TiQmOW9(qfwo3ed0Y5uzG zKpKtg1M1BkDV0@`32Ga?+}xJx_(x(Y^idkC9#l8^B`%6cg}%SCa#1-~{?pc@X{{0} z;my;T(;4cunr9?3>y5HSz89GVmyTgwDTr=_m($;-Kffo1q>wrmSJHcEqo}d)oXzx_ z@Y)u6IBe_J_}^u#u#$M-hP|}RVXH_R

m7mc5zpMr&XzqewDTFFoe)fG~JYqWK%E zr^;FE7v8PSLTnm|c{>qiBMa<|{{24g(s4=iH=o~mOmj+K&#a2iBoZ*$1yS(^Egui-@XKSU*GDq*h09HRsWF);v6;gCe4NB~vq8y?lAu`I)1$JHnP4 z=vy71-;aY!jQC7xDM}Q7=ys@{|D9ZJd*Pe*MN8?& z8)pNnmKnM5bPvuX#BQEK=UR)|b1qULg$ezyq%lbBapv@N>-~0c?qrZM3r2}WXnu?q z8#Dft@fh!(MdHl;r^e6RoP#uQMu#7()7Xfr{{7F4$UArziLy}2dHdgXUm=sPq|;ek zkRwiqj}xP+a*B0zYp3@O%Ou;xb=3@?O&0Lf1$*b?xZ(yaHxpdzrR)ekvWv5@uDP(P z*=k%_V8MfGkiP#2tzx%{w&Z`On~I(zH#&|x6s?L6;l zyPFvCCPaG0YisA9m&hb9H_OLSA6dBOn8g|7+~8|kK60a+@0ECO_wWMyQO>&{Wv@G| znC+${CDjJw)f88g6p9|AYSvv^@C=4J#R8csghs+OKN}afI%b_h5L&s_@bO@7@KaQ2PMWQ5Yv8L8vo2|M%2Cv~KKw}&naD^{*d$2j{MQu{P!hlaQO z^%P7I7k>)H4)EHca@PM`u`IboDZV$?))(F7e~0h0OZimoXSJ0vwpIyUu#uXhVo2aF z;u}YHf$A;hglY>#oZr`A)V}6wy4rrym9B-ptq?_}yX;awe3`z4_Y|BRdZDz%qKrOA z`S{LzL#t0SHlo6nb~hL@FpQK&z9c-0WX8)n9pc`7zS2lwi(HU%N)T;Y9iN>gEr3OL z@fp`y1vlZ5BK1qPPWk zjTfkgZ#M1TPG{Td&fAMch%ohBRk{^7x3x$@uFJH^?1aQT(=h93QS$S?iz&2lfsfi* z;Dxi*fd*Eh@%j7Kgno|oQi~C9@4gm(_E!11s+}!Ir~&&IX$4QKjHe9N3w%<9xVbJ~ z?Ob(}>=@B~VYCj42ueS(A8R#^Nda?(@&dJww*KB7Q>^k%p}qOlx6Y`)uW=6Q5^lm% z^mL`n%|BN-_*eCgk8(&6)T`a7)E&ekx<;4w^!?h<*v=TQw>|}Zo!^XW2JPOo9> ztOls4@eQ(FW83R8OYHl0tc;zwt~}c%!9{;=!2XK0~F{CVpoPRZ?IG6G#EeHw7$iLtegATNgS(EX5DYCl_DX#Iaz3NU9mN2 zyz+tf;_KbJ$_7%AA@}qz;otROHcXe3>YaK?!Y5N(pD5;*SC7LX(`Q~HCxxFndK=c+X;RLUT8Av-NO@~iPVnN`79AePXcKPmT;V(# zm$z`;3oLgj)!%OpCnF#oTG{o96u-T;G^IJx|K|P1&|G`n-gA=jmuUQrs;}g|TR}T} zWRj-`yQ7+icjB#i=2<6cTw}_caXJ;bH|O-e6Gk$wFp9YA^5lKv!D*=zCLJ4ka-URb z+wF0 zdHpAiFe`80)z!!Y#JfW9wN3URpA@k9wJ}ylUa5{W~w=NjUj4SpJ5nT*BYW-=CIe>8{;VnUC&d zlMm`D4Y|&1r?yMFI~+=(DsEv8c!d$W6kJ0OU zAWpL?_UhGl(`!8{6?}-}`nB4vMi2V~3Q0mT^RLPHVpQM9%AUN9d-jMsAjCBM(AR7Ba+v&(lS0W0CjP4kMpB5HB_GPZp!+QU0&*D_3H~{!w9bp8QtAtT zr~pwG7VY%52w3lwq@Ld1R}cj8@Vw&U0Odap%vA&tm_^_W0YCrm_%8xf|A(yj|1|$6 z4g)^eAnosK>kf^U{_ekhLO}ob_{$pj{m{HgxOZ`$KykR-vX3d#WyIi5r4 zouMop54(XO_?h%1O-_Dcwrxky<)IK9m$j=NReXm(ew^5#wDb4fAvu(U_d?0%8I7yFx^W)$3@$dQJ&pP<`{P+il|E=do+>`SeB=i54e8xG6_aA?s|Hl2_ zJp6;p-*}wB^iQ1r#phpqPV(XZmmmLm9{4Zoj2o`2?SE&~pA!YxK_33W^Y@9P^AC?* z4SLu9(mSbw>+%F}7}$#-+#LwQK!zYJTL=>L96?S~Ajm0V1ffU6PDu!O0@$tHK@c)y z1Ub8dAk0+=LL-kLRNoLpHyzqx=SC9@I^bJ02rl)RK(`p`VEc5w6gFQFFikAziy#Oe zKa>lwL9zk;Sp+ds2ES&|?f~0~Y6MZd1#j@NgErWfkd`Be!e^*|1+)w_2J$+TWk57= z{cnySobbq+DiHQgFcu2Xm-z(pRj|(pby5hz8-gIzV3Q;q+MmMCXdFT4yg)}BVg#N8 zHdB-!6T?^ua}k7#4cb(|w-1mKjDHSFc<@M)g20=75riE!Wu&m@At(g>ZUhko+vHC0 zRZ~$QSAy+*D4QWR7$4DH1Q7{^b|{HqoP=)>gsB$l1%byn+55n_VNQssK^}l|5bVJ? zNx=^h#7=M>u&jX+#*GdFop=}zU`qnn5YhpK0iNKGSOWCh!6)EPodf+@AXZld!Gk(@ zWhR1l0TKeTKoFr}=r<3#&!7)r&i@|tAzoq~s0Sjh0Q+w6jI$GH8}i~F)OUft0#Fj* zg%3K(5EJAI9yW}Z7wTVvKLqT5g!lWw_y_`khx|b6BgmO6V2=uPTcO?vL3j+IKlmkp zSnvTy7U)O_`G&p${_-&LZJ`fh}m@dETwg=GtC3Zo3>0es`OKpW&P8WZ{+gRQ5)!?i zvB2|z4$KuP#DI2$eyuS~;KDH^WEojHp1)dq~1J>kWAfrKsImPh?ISuqrfee1J0ShV$XqN?k6(}3p51`xz zT?QxzVBKkhegen@AOoh?G%*1iZ1Y0-XVTZh;IjWAg$5PZkbxAMmga zv7s-S1eCo%_rO;L-~sc24Y6Q#0hz*F0FNdH-#>sLM+pIUEWjNF^(g2I^Ms(RfdC7P z`%qqlSmB +General · NetworkDynamics

diff --git a/previews/PR184/initialization/index.html b/previews/PR184/initialization/index.html new file mode 100644 index 00000000..f3328c5e --- /dev/null +++ b/previews/PR184/initialization/index.html @@ -0,0 +1,40 @@ + +Initialization · NetworkDynamics

Initialization

Initialization of the system describes the process of finding valid initial conditions, mostly a fixpoint of the system. We distinguish between two types of initialization: full system initialziation and component initialization.

Full-System Initialization

Full system initialization describs the process of finding a fixpoint/steady state of th entire system.

To do so, you can use find_fixpoint, which creates a SteadyStateProblem of the whole network and tries do solve it.

Component-wise Initialization

In contrast to full-system initialization the goal of component-wise initialization is to find a valid initial condition for a single component first, given a network coupling.

This can be usefull in cases, where there are nontrivial internal dynamics and states within a single vertex or edge. The idea of component-wise initialisation is to find internal states which match a given "network coupling" (fixed inputs and outputs).

Lets consider the following example of a Swing-equation generator model.

using NetworkDynamics, ModelingToolkit
+using ModelingToolkit: t_nounits as t, D_nounits as Dt
+
+@mtkmodel Swing begin
+    @variables begin
+        u_r(t)=1, [description="bus d-voltage", output=true]
+        u_i(t)=0.1, [description="bus q-voltage", output=true]
+        i_r(t)=1, [description="bus d-current (flowing into bus)", input=true]
+        i_i(t)=0.1, [description="bus d-current (flowing into bus)", input=true]
+        ω(t), [guess=0.0, description="Rotor frequency"]
+        θ(t), [guess=0.0, description="Rotor angle"]
+        Pel(t), [guess=1, description="Electrical Power injected into the grid"]
+    end
+    @parameters begin
+        M=0.005, [description="Inertia"]
+        D=0.1, [description="Damping"]
+        V=sqrt(u_r^2 + u_i^2), [description="Voltage magnitude"]
+        ω_ref=0, [description="Reference frequency"]
+        Pm, [guess=0.1,description="Mechanical Power"]
+    end
+    @equations begin
+        Dt(θ) ~ ω - ω_ref
+        Dt(ω) ~ 1/M * (Pm - D*ω - Pel)
+        Pel ~ u_r*i_r + u_i*i_i
+        u_r ~ V*cos(θ)
+        u_i ~ V*sin(θ)
+    end
+end
+sys = Swing(name=:swing)
+vf = VertexModel(sys, [:i_r, :i_i], [:u_r, :u_i])
VertexModel :swing NoFeedForward()
+ ├─ 2 inputs:  [i_r=1, i_i=0.1]
+ ├─ 2 states:  [θ≈0, ω≈0]
+ ├─ 2 outputs: [u_r=1, u_i=0.1]
+ └─ 5 params:  [M=0.005, Pm≈0.1, V=1.005, D=0.1, ω_ref=0]

You can see in the provided metadata, that we've set default values for the node outputs u_r, u_i, the node inputs i_r, i_i and most parameters. For some states and parameters, we've onlye provided a guess rather than a default. Variables which only have guesses are considered "tunable" for the initialization algorithm.

In order to initialize the remaining variables we use initialize_component!, which is a mutating function which tries to solve the nonlinear initialization problem and store the found values for the "free" variables as init metadata.

initialize_component!(vf; verbose=true)
[ Info: Initialization problem is overconstrained (3 vars for 4 equations). Create NonlinearLeastSquaresProblem for [:θ, :ω, :Pm].
+[ Info: Initialization successful with residual 2.2204742383278642e-14
VertexModel :swing NoFeedForward()
+ ├─ 2 inputs:  [i_r=1, i_i=0.1]
+ ├─ 2 states:  [θ=0.099669, ω=3.4499e-23]
+ ├─ 2 outputs: [u_r=1, u_i=0.1]
+ └─ 5 params:  [M=0.005, Pm=1.01, V=1.005, D=0.1, ω_ref=0]

Which lead to a successfull initialization of states and as well as parameter :Pm. To retrieve the residual you can use init_residual.

As a quick test we can ensure that the angle indeed matches the voltag angel:

get_init(vf, :θ) ≈ atan(get_default(vf, :u_i), get_default(vf, :u_r))
true
diff --git a/previews/PR184/mathematical_model/index.html b/previews/PR184/mathematical_model/index.html new file mode 100644 index 00000000..9dff0d75 --- /dev/null +++ b/previews/PR184/mathematical_model/index.html @@ -0,0 +1,48 @@ + +Mathematical Model · NetworkDynamics

Mathematical Model

The basic mathematical model of NetworkDynamics.jl splits up the system it two parts: vertex and edge components.

The main goal of NetworkDynamics.jl is, to express the overall network dynamics as a Differential-Algebraic-Equation (DAE)

\[M\,\frac{\mathrm{d}}{\mathrm{d}t}u = f^{\mathrm{nw}}(u, p, t)\]

where M is a (possibly singular) mass matrix, $u$ is the internal state vector of the system, $p$ are the parameters and $t$ is the time. To make this compatible with the solvers for OrdinaryDiffEq.jl, the created Network object is a callable object

nw(du, u, p, t) # mutates du

with stored mass matrix information to build an ODEProblem based on the Network.

Instead of defining $f^{\mathrm{nw}}$ by hand, ND.jl helps you to build it automatically based on a list of decentralized nodal and edge dynamics, so-called VertexModel and EdgeModel objects. Each component model $\mathrm c$ is modeled as general input-output-system

\[\begin{aligned} +M_{\mathrm c}\,\frac{\mathrm{d}}{\mathrm{d}t}x_{\mathrm c} &= f^{\mathrm c}(x^{\mathrm c}, i_{\mathrm c}, p_{\mathrm c}, t)\\ +y^{\mathrm c} &= g^{\mathrm c}(x^\mathrm{c}, i_{\mathrm c}, p_{\mathrm c}, t) +\end{aligned}\]

where $M_{\mathrm{c}}$ is the component mass matrix, $x^{\mathrm c}$ are the component states, $i^{\mathrm c}$ are the inputs of the component and $y^{\mathrm c}$ is the output of the component. It is possible to have $\mathrm{dim}(x^{\mathrm{c}}) = 0$ and thus no internal states.

In the network context, the output of the edges are flow variables. The outputs of vertices are potential variables. In interconnection, the flow on the edges depends on the potentials at both ends as inputs. The potentials of the nodes depend on the incoming flows from all connected edges as an input. (Here, flow and potentials are meant in a conceptional and not necessarily physical way.)

Vertex Models

Specifically, a (single-layer) vertex model has one input, and one output. The input is an aggregation/reduction over all incident edge outputs,

\[i^{\mathrm v} = \mathop{\mathrm{agg}}\limits_k^{\text{incident}} y^{\mathrm e}_k \qquad\text{often}\qquad +i^{\mathrm v} = \sum_k^{\text{incident}} y^{\mathrm e}_k\]

The full vertex model

\[\begin{aligned} +M^{\mathrm v}\,\frac{\mathrm{d}}{\mathrm{d}t}x^{\mathrm v} &= f^{\mathrm v}(u^{\mathrm v}, i^{\mathrm v}, p^{\mathrm v}, t)\\ +y^{\mathrm v} &= g^{\mathrm v}(u^{\mathrm v}, i^{\mathrm v}, p^{\mathrm v}, t) +\end{aligned}\]

corresponds to the Julia functions

function fᵥ(dxᵥ, xᵥ, e_aggr, pᵥ, t)
+    # mutate dxᵥ
+    nothing
+end
+function gᵥ(yᵥ, xᵥ, e_aggr, pᵥ, t)
+    # mutate yᵥ
+    nothing
+end
+vertf = VertexModel(; f=fᵥ, g=gᵥ, mass_matrix=Mᵥ, ...)

Edge Models

In contrast to vertex models, edge models in general have two inputs and two outputs, both for source and destination end of the edge. We commonly use src and dst to describe the source and destination end of an edge respectively.

On the directionality of edges

Mathematically, in a system defined on an undirected graph there is no difference between the edge $(1,2)$ and $(2,1)$, the edge has no direction. However, from an implementation point of view we always need to have some kind of ordering for function arguments, state order and so on. For undirected graphs, Graphs.jl chooses the direction of an edge v1->v2 such that v1 < v2.

The inputs of the edge are just the outputs of the two nodes at both ends. The output is split into two: the dst output goes to the input of the vertex at the destination end, the src output goes to the input of the vertex at the src end.

The full model of an edge

\[\begin{aligned} +M^{\mathrm e}\,\frac{\mathrm{d}}{\mathrm{d}t}x^{\mathrm e} &= f^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t)\\ +y^{\mathrm e}_{\mathrm{dst}} &= g_\mathrm{dst}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t)\\ +y^{\mathrm e}_{\mathrm{src}} &= g_\mathrm{src}^{\mathrm e}(u^{\mathrm e}, y^{\mathrm v}_{\mathrm{src}}, y^{\mathrm v}_{\mathrm{dst}}, p^{\mathrm e}, t) +\end{aligned}\]

corresponds to the Julia functions

function fₑ(dxₑ, xₑ, v_src, v_dst, pₑ, t)
+    # mutate dxᵥ
+    nothing
+end
+function gₑ(y_src, y_dst, xᵥ, v_src, v_dst, pₑ, t)
+    # mutate y_src and y_dst
+    nothing
+end
+vertf = EdgeModel(; f=fₑ, g=gₑ, mass_matrix=Mₑ, ...)

The sign convention for both outputs of an edge must be identical, typically, a positive flow represents a flow into the connected vertex. This is important, because the vertex only receives the flows, it does not know whether the flow was produce by the source or destination end of an edge.

          y_src     y_dst 
+  V_src o───←─────────→───o V_dst
+

Single Sided Edge Outputs

Often, edge outputs will possess some symmetry which makes it more convenient to define "single sided" edge output functions

function g_single(y, xᵥ, v_src, v_dst, pₑ, t)
+    # mutate y
+    nothing
+end

There are multiple wrappers available to automaticially convert them into double-sided edge output functions:

  • Directed(g_single) builds a double-sided function which only couples to the destination side.
  • Symmetric(g_single) builds a double-sided function in which both ends receive y.
  • AntiSymmetric(g_single) builds a double-sided function where the destination receives y and the source receives -y.
  • Fiducial(g_single_src, g_singl_dst) builds a double-sided edge output function based on two single sided functions.

Feed Forward Behavior

The most general version of the component models can contain direct feed forwards from the input, i.e. the edge output might depend directly on the connected vertices or the vertex output might depend directly on the aggregated edge input.

Whenever possible, you should define output functions without feed forwards, i.e.

gᵥ_noff(yᵥ, xᵥ, pᵥ, t)
+gₑ_noff([y_src,] y_dst, xᵥ, pₑ, t)

instead of the more general

gᵥ(yᵥ, xᵥ, e_aggr, pᵥ, t)
+gₑ([y_src], y_dst, xᵥ, v_src, v_dst, pₑ, t)

NetworkDynamics cannot couple two components with feed forward to each other. It is always possible to transform feed forward behavior to an internal state x with mass matrix entry zero to circumvent this problem. This transformation can be performed automatically by using ff_to_constraint.

Feed Forward Vertices

As of 11/2024, vertices with feed forward are not supported at all. Use ff_to_constraint to transform them into vertex model without FF.

Concretely, NetworkDynamics distinguishes between 4 types of feed forward behaviors of g functions based on the FeedForwardType trait. The different types the signature of provided function g. Based on the signatures avaialable, ND.jl will try to find the correct type automaticially. Using the ff keyword in the constructors, the user can enforce a specific type.

PureFeedForward()

g!(outs...,          ins...,       p, t) # abstractly
+g!(out_dst,          v_src, v_dst, p, t) # single-sided edge
+g!(out_src, out_dst, v_src, v_dst, p, t) # double-sided edge
+g!(v_out,            e_aggr,       p, t) # single layer vertex

FeedForward()

g!(outs...,          x, ins...,       p, t) # abstractly
+g!(out_dst,          x, v_src, v_dst, p, t) # single-sided edge
+g!(out_src, out_dst, x, v_src, v_dst, p, t) # double-sided edge
+g!(v_out,            x, e_aggr,       p, t) # single layer vertex

NoFeedForward()

g!(outs...,          x, p, t) # abstractly
+g!(out_dst,          x, p, t) # single-sided edge
+g!(out_src, out_dst, x, p, t) # double-sided edge
+g!(v_out,            x, p, t) # single layer vertex

PureStateMap()

g!(outs...,          x) # abstractly
+g!(out_dst,          x) # single-sided edge
+g!(out_src, out_dst, x) # double-sided edge
+g!(v_out,            x) # single layer vertex
diff --git a/previews/PR184/metadata/index.html b/previews/PR184/metadata/index.html new file mode 100644 index 00000000..53bd327e --- /dev/null +++ b/previews/PR184/metadata/index.html @@ -0,0 +1,2 @@ + +Metadata · NetworkDynamics

Metadata

Component model such as VertexModel and EdgeModel can store metadata. We distinguish between two kinds of metadata: component metadata and symbol metadata.

Component Metadata

Component metadata is a Dict{Symbol,Any} attached to each component to store various information. Use metadata to retrieve the full dict.

To access the data, you can use the methods has_metadata, get_metadata and set_metadata! (see Component Metadata API).

Special metadata:

  • :init_residual: after Component-wise Initialization, this field stores the residual vector of the nonlinear problem.
  • :graphelement: optional field to specialize the graphelement for each component (vidx) for vertices, (;src,dst) named tuple of either vertex names or vertex indices for edges. Has special accessors has_/get_/set_graphelement.

Symbol Metadata

Each component stores symbol metadata. The symbol metadata is a Dict{Symbol, Dict{Symbol, Any}} which stores a metadate dict per symbol. Symbols are everything that appears in sym, psym, obssym and insym.

To access the data, you can use the methods has_metadata, get_metadata and set_metadata! (see Per Symbol Metadata API).

Special cases for symbol metadata are:

  • default: Stores default values for states/parameters. In initialization, those are considered fixed.
  • guess: Stores a guess for a state/parameter which needs to solved during initialization ("free" variables).
  • bounds: Store bounds for variables/parameters
  • init: Stores the solution of the "free" variables during initialization.

Fore those, there are special functions has_*, get_* and set_*!. See Per Symbol Metadata API.

Those are closely aligned to the metadata use in ModelingToolkit. They are automatically copied from the ODESystem if you use MTK models to create NetworkDynamics models.

diff --git a/previews/PR184/mtk_integration/6aeb76f8.png b/previews/PR184/mtk_integration/6aeb76f8.png new file mode 100644 index 0000000000000000000000000000000000000000..194b97fca7cfdb6e3af1509bc3845b26d249b036 GIT binary patch literal 48818 zcmdqJ^|6xmygLpS ze8PjLkp+KUcqc9*h&aLg7gw1Qgg{UtLPNT=u zyHuY)|CVITnXB^*VA_c(+X#32Uco*WlbAQMjF||+j9a+~7xN1u^#dOc=5Gd{|HuCp z%dt5p$)DJjs&*;?xf+v_fr%ftsjxAtC;ovm8N0w@KOkpek>6+F=jGKoZ)Grmg-CUC zcgH61{`5%>jgR2F`Z}xs_iwFeNn!$mcpG|@fou4uPxzSeTz!%Mm%j}L*f!MIQ@zDTqt~rdC2VM)f+f?WE@r<+&hQI2dhPP zCi?pG@SZG%jOyx>Jk7?0#KeItm9X$|nBXk}rAmh_nDs)rI_7D;{RKAsZ%Ij`=8a^N zlap{Q-P%Z{%E=xi*!^d;tiYo4%@e1sK1Ji0)%NH;Y4oFw;;Lpy@nU0lj zaXikqSym>P?@jATl}>D?*xBBWVb<>+Ewi*;9=4vW_4xex^P&?K=BcDEyiBi|Ja8L-{HiFui-(vd$t$(4`& zSt^|5{qNX2H#av&M^y>thl>nn3Y-tN`}CM?&_}J|OasywN%m5tAyj>WKDDy_DJCrX z{Pk-pvvQ%H^j>CUq{@pIFNB4K1q1}@`u_vzg^ymhl$Z|g)9GMS%HFV+ATsnGvWX@> z_bWe&8=r`Xi1w}MatF5iz=snZn{w9A=j2A%1pHMb#r~3k!?vePz~2!lT8AHl2cz zW!A_x(T`uwA!gVu1Y(+Kk*w&-xYqkfg-C9mEIC1}=Jm@AGocmY=BcSmQw6Q8j%&%x z@><18nKlG@gG)kT*Fu$zzljrM4;ry(_=wC9hW)tjucsB3{+t-`y(uk*A7sU0!ug1f zE+hZBzJ8ilX<3;(Dtc*Y$)KHf+Ecz=Ox{;GF;6**fPerjjnD6Q=vQN#CiLP7_vCf2GD^h2j;2v>|ADPvR| zs%*3^PW-57*e8Q5hW0_u_&72uIJPS;YqEOEpooNbdduZD(}Fem$3?Qhaa452#aAln zy7;WvQ76@a@~JZJbbw& z^S}GPFpY;rH$s(P5~)-*sjBMG7Y$p8w)n9yaW^ycrAKcDt_DHe*9V_TTK!y?-yY=usxMM;GmEmkA?T4 z->!(~vMF0M|J-#Hfnkgy8tc1!+OhG((D}E5g6`cfL`Bn_`rqYgX=!=Au(PxK5c(gY zR5k5KsA>LgsH_kyA6fv<9h7S z^CuO-lGI@rlh)H3S|nC&XsSbavj+^CFP6Ec3lJj^eTLX>og*XY+}yw5r$Ra!>gyi{ znQ+>!jQ&bK#}}ksG-N5(S{8QPLh}?fqwL-+R}gzn{TE$E_}AWj@v8Z$G^e2CT9Ui8 zGT)Z}vm+6#pQwwIKF;adEnl=&_G8>k!e-LGC6Up!YyXE#N=|1&pPA%dJ4{} z)<}_${i=y!n^uQImlmu~L?$ySx{b63xrfz%zA zg-g~51hX*Ahs}7{>TuVbVDHxlJW{vLmX^iplcUvO8d;ZviuTYJf)To=pkFV66{sO=A$Cxzp#~KhXUW9kO&@}zd9eIt6BRDeh z&W#(rur^xGr7`gCrl6H>Av+OLQc@a427PPOjpAZrNNVcU^2O{b=YxLHw_-^~KLe)H zzXSyheI?gRdc^7o?`J?i<4O7LWMeKMDGD?8sg2gZjkcMs&&cs30`EC4 zDnQ{JIsKs@K^1x6IdUXi6n20aK zFy-4>d(0%4Hl7w=+cYBk(?$E8se6K&@q41YtH>f>N5+c&H3XvbGmbk#Rm~=EPtc)e zt?<3y+B4fAsof7LJCMMS0(qcGPZhf%5d;pHP%Gt4K(ct|%O-)D{)N@P+ zvemY@3-a?BR7)w5fq{WBF)=L8@r8wjka|H{lLN;V@3o8CQ!qu)^J#zrN7J(wZU>m!k0e@Vx8&cO%8dOuFq{7QbJ3 zOe<$?cZpCqA8idhfBsyaCetKKqxv|2_ZUA=zvr9v^0535F?G9159`H#eddVz`g$)f zF9V16uTM3Xhl?C4dG6gyCUW~5dvZ9JAmsZIkD|(cV|Fo>_$C3)IcACTf0^2w^`=apktnY&mBiJmBSOLgZhdF`I!pFe*> zs(Ag@v019Xu+K#MgYd82KH)2PU`+9^3atERQp(n;GP}_V)HA;|_-K zZ<5R}2dmX65Uvf{d268$lJn7!@|%!P@|z6izNMm~vff%qub8?25yVIEM9JuY(DKBq zWsjPHlY@$lWkOD34z!)E_%HftZM7oqggSxCWL3k33_?U)LYd`U)p|1>vOE5{C#>}9 z9oANJS{4>a(lw5L2T3t9F{Qi=&v!nssjRx>a@A$pk8NstdcuA#`r}Ix%|`#Njg6L; z7L~krLM(1((+z(2gG2>aDtE>?oUG-?EeLzCQP&a7S0SiycId7?i#-xi-9E0bU|hWU z;C=Dt&Yzy{94YaWar(o9!oRrd@3x2$X6%gt6en}MCp1WI$L-N#pLpx~C+5JEN8zuyfnXBgBM+mdTu# zs*m>#lQ-Ni5t0=1ss87N?@B1z&SdP{Hf+wYSYoM^!gx8SkTf;6tCOv}8kK~a2t7VR z9@X7CkBtapbKEv67|QI@3uRDKrn<^eadLb>rR@3~KKo5dhFC&%>pfTscIQ0gO=iB0jB{W(v=M>GrG zG5V%2C3d}N#9wvGI&W$~W+t2A+8#gt==^zv*$Xi-ne~Q0U5RMxMVn+3__3XE-qDS9 zE(XE3wzmHI^=n-hkMvotR?`;{PRh4$`}_OFMne{VI^%c79djZ_vhmMYpQY0c3jw8Cdx>`c% zIc=6+ySTWRnf-M=cb?q-cOZmRMZ5XF3`Hn=K9RCB($X40)L*UKQFn4WociILvG>OF z%I)ra?G~^{y8mh=B3WkItYQa5~JMOH!fBzolF#$51ZVbRg zy#gISH2Od@fLkFR_3qsi%;N--HV|xXZf>?3nrC}Z6C{#VWu&XsnEVu{D5LZx)M-vm z6+hldqw(X^f8Pjmwq@RWJV82txczwjaG&pos@vUd}Xw3 zUD3?emN>A^6Hh9FIZZ$}T5@ML(sbCUc>T!G${anWuAs1exY41wG78xW-~t@w&L>AZ z&1+x2Tt|j1)6oMmK za=r|dYJqnUlM{(`JomgN&y(?+4?OeK)YRn^g)C)xdqKs-u8Q3$Uu|ve8Ar)j9yLL5 zkJ((A$MmbCWlRqrrmi=pcIh1-?^G*hn?V}o=H_;j113ISGT}lW2^ifRlb*ZZ$vOlY$w|bfSuu&B*R}Zw^oxu*|X1(NO|w z;ZZP~nd!E~0G|DsFb$s<5cwMY?hxO+X}$Y*lEtt;>D#w))X5RJcPZ{IIS*XS_Ai%A z6f0)|W)jU|ZP1^ov_-L0sNWN8djxKH3p~JKT6edM_7ls)-8FJ@@);>-c&S*cVSnb( z@1`Kf?WMF&PUIX`dZ033sTm4c<=u1&8=*{$jIhM7At5s}Gh3a{@wS$Rdd9}M@88#f za^TXXOQw}u{c-#sgagQzOM7SAA{#&5)+|zns0l8=8`KHxBnK3vErMljZ7oD&zekGK zdA;d@P?B~_C^#5Xu(0+h_5z2k1`IE3T zn^%;Uma3s`($dmEKSxT@02L#`=0fLPCCiKG?pxi(LVf-8B~}4p-2t%p?+4R+~kSwk;WM-QK3E$gzY?#POI<3EnIC(a=CkNYkQHVV6g} zdg7s}}#>ay4S7t>%xncv@6BvV;5 z#wZozcTKy-&zzjB=qxp}xRm%wI&1{9X!8ZzB9$t}XU}$PJ#gh?nwy%WNkSTRKVG>l z!;XZ2ZVzg`IFK`urzt|upblA#-DOxX!I?LoBdYV(F#j#$|&2(_ZJk}hgt z47~%6#03-;WFyZbpUC_Wxie-PYjJT5@}ZfZ(mDn9NBdhy3rJmWT?sqt%em2?qfy zfyussy--}RNjC0;JfhO&XdfooH#L=)mnZfr&4RlFa%b8CQNz2uyu3_I8)5@;{*WlH zhTyJr#y3>=LnJC0vl+o8K{@J2aDi@z`v}5zvsO#F7Pg}Q}mTyVL#{r9`LpoHtKynju5ZR_fz>Yeu7&6Mnca0{3nvee8On4Rd zm;L3g-iZ!fMRltCqXW%gtRG5!2kbVpn#V_E7mZG*`5>y?;VV zADl&;p;a;h9*B0yaH@u6+8V7dEsxd4Mq`~r zTup>94bGk=vJDi=5P~racK`+NI0Ov>``K_^QgQyOzqPoKi^gQ#QLILqn|?GGxS>W*}*_EL;L%b{EPKNJddm zIYGXIh8$7hWi+F<*bG~8h2WNlywZq#^fU8!kOPQ{iXs!b^f=TR?f(9Pq?isjo8w`% zj3R9!mdI0#KiN{b#u_@w4@G&YFyKIj*HW@Mf-5$h{Fm2xBdnF%;#l3L(X7=Oh8wJI z@|hl25qy;-99DlKO{-{-kiMbFGDH+a%ig{e41WC(3H6E`)`*(z7^W(ju$%Vt@6!kt zluo9TkdmKOzkrSXF!ER5pDF)`cPJ<{(C5mVN#m27mkED&-_f6_a*nQuDk<41HJ?_< zR^5Xvr9GDS1ePb;(DO|)TDhzsUqN@vL$oYlhGb}Y8`@A0XlQ7jJo)R#HvSbdnZ4U7 zA#?V{rV~6gG@?qB<@uKz&%+NE7PJ(E{YjO2`kbSP=nl@MO7f>^&sQZ8;M#arulF!b zkdK)&j09fTQf`YTd(IQx%RQrEYvkzgYvMx5y{lLVxu+0}wPzEK`D8p0JdcPAfGlT)b%n4YlvC z=RRD-v$=9t9T#eXdnyX!V$$)XIr@Ln8_wf#QDW2`@&tu`VkiYLeKXn}Ih)XGnYWO1 z5d=bN)Mu3ycmCqFC@y;$!P$=36R4RLN>6gv8?)Uf;qzw=cUw5E{=5n~3LxWDn8|o> z?;eEqpHB};q$%;SQs4LKOgPa_AJ1Hj=-69}&$(v8?p$LY7N?$Zd;IC|f+p^6joVc- zYv%&+^!i#y)W!_XAs8ex`i`e5PVfV}ySqUE>ta18Pz}dr8UYdmg`}#m@JBDJ`R?TP z*^cJ*uk!m_0~&O?wcwYH$I9geKVH3~;Opz?=tvhi;0&QVq^=1fC#2H!M84`81vD;V zPc@v@gk~NUYPS&G1JJ)Lg05_%oijvjDU4p_+m%Lnb;)l|Zy!iTrB-x`+t_SFJ*t4N z4en4C1fx-(lv7t9huV>j_z@E9O;)EQbZ0TAnw;GtsX1RUTQ&Ua*VmK5Lq=5)Q^EL) z0O)}Dg@pLk67}M-oq3&iXpS*i*%OB!ZojAUeM|WCSR!hSKg>!k#c)858G!e7ocD_} zH3HEN$<1wQ;ZOLOtY{n{T$s^ARKGz{)xiq7gZHEY(>9{n5Wfi-&yBz_v@ImyA*kkb z`3!Z`k#(}#%&SSr*llN9WA8ALbJ>|e#ekfeo0}W#$@xZ%TFfdD{0+V@fP4G(-i$89 zsuRe>y?=rkS@#7bK!JEzr>JiKv}sG zq*o0A6tQ762ZY1_;{t>|2t&<6@miAq;ity&dKl!5oc?sxm&MSBotO;w!~6H(N5PMc zuh(@E`Oc)J#K6CM^qBE@5C0YgFF#r;Wj>Kurez2U4!%J_VVd{4mjOE)nNwf!Msd{j zWQ3|CC+Dw5iEVM^QOl5f)Vm@>Y!XjQ;rjopTm|^~YanS^*bN9|_LY!7UR`Q=ryJJ#1*~T_;xKz-g?y{$??V}0hdB~oRw6t`AZim7?8jWsA7NV)F ztc2w32=E#V>XbKkfRWFl@5u7DXwZEcDgBY+We5pefWh4RZnu-R!c1yiQ8WWj<98Rm)Wh9#xvbH&38?i$A=Wkd(N7uTRd( zs&HB{9>PK2CUk`p^LKp!0f@F8XNPnT#_@1>f7szXpB&a~t01!o5wV3L^DxwyRR#7| z2$R%7P7kTx33L#Gjc;u^909%&>^tGOS_#fUmLcDGgmoqi+QsNpc540sAHBcn{&I@JA+eiXe$hodatJ9H9HnsNvw zcReZH@UQA9s%~$}dsZA*oh6hEPm<)(K3CtOt*u4MyGb&$;qh-UU8W_LWN!w8 zqPl>80H{o-pbW0SUfSOE0cS!Al^Nhu;C=`Q61!f5;GxQwjAUH~b%9LBT2(a)jdp}Q z10VuYa&i}LV%uld3%w9D?+_9u_RMowFEGFP?h3)W%*it|GZW0m=O<)DEvtXbAn^u2 z?fn8W5ZY1Ku&AiRG200;Zim9SILc?w>>yTw|52RzTY)+`h6Mnqyig*aI-Vw*0=OMqn7Vy&x{G(m&S7<#x{1M<=@0l9KJsA#?zCg5Q8LYyJCq zJZ95zCxEFjH7AtLAv5orTiV)=pb!KH7#0~h0%1imnnU92lbVi>)nVRb!@V*?*H{Ux zcrV#wsuz@kN9u2m?w>YRn?{7?vdmw#=vz3Tt%cxR_{qFp?4pC+G(P+1`w@{c(06xJ7NzOdSK@AfV?o^35pCTAAwH>;V zP+CFGv;a6vU0odpngMDEI2#J6c5-uHC3ZP&c8SQh-#2E&ap&tP+;H0F9C=sG8)HJp zHqX`Dc+?cB%xx~4@kAr>bjW7`O+gPJ%y)z{=|UppKcga)1jw#w^^r{vIr$ANs?Pes z<@`y({gLX1C9YVtW4j!j>guZ|oXNVSXm!WrIV^;0hBB1beFj;%vkyqn(uu-;BrLR4 zRFjb8D=8^K4`+F#B&X|3ydSjne4foTD`ztLMC1=HWn4?H*xDG<)c?=_1Bu_KGOEq8 z8e`95T!lQ=@5#B%4@syW95P@t+h;Ofjx+h1Rh)eAW&Du+K5NEL^G>y#=zjDM+~)}# zo(iKLM6g@0@NwLPGg}P~xH#6bG};^H4$GWU1JK9buwJ$#<7aG_fov70jOicJ77SMn zM(#HB7hIZ2c=I`Iq*Y~@iz!vY)sz1R#8E`&Ys^>;1_h5tVmF%ublY`_Ij?=(FRgxZ zcOlI!t72>~9_UEli>A=joqB`I>up`VCnbBmO`8IZHM2Y`1s{tY*S{&mm}K$-L(DY- z@^ins$4|pi6J{2s@3N;~h=dwuS!|RHkQ({Mrb@d(+vqgrdcfbRSg6wVWT`<~zoaaqV7p>7>@XmDmH( zPb;JxwnlSz1f1m_VMda`gOQM)Up8XZ9IYD5j2Z)D2&ztQk7&O>cyluYD$jT@lt&~H)$4i>37xrcL-6%wUOSYaS$d29hbZ5#BXv9R5#k3mqRG!w8z zZx5*qS2&4W)S%{#hnrGGoW`(wt&o+!(sBZhZ5Ue2wE&I4dtkMQKb8DW9z)=ID|z{s z1CF~Z$4jD-Mc(M}1H;TA16lvV%YW@ova<=xSrkj2z(}Rnu&CnR8|Ntn(tk{)xAB#$zfMM-%Ec5@hf5}jJ4uF)zCfz2}#NRc`Lvg4FF=dv5?wfXd9Bjko2zl@!>E>`90`~eQkM{y(5WhbLU9~_qPqrBNg)&3^z>< z#7Y7Jv7a5*6yLeW?*DR$e7nm%`)!r*sl;4;sqwM4Og7R!-Oj+{yl^4%pcKWGH!?O> z+na@bBodu1G@S?@`RAqU81VfdE#phjD|wodKm>8>@XDvL3L zEeAQ42dp+{Ux&+PM4;I#N=DlQD2@%#Y@(4Lfi85-&78gYISQ{%gs@z4aZF$=9d2-K205rHTR)ufW)WF`sWUT~CCx9svV8OQuXq#K z2n1gU+%Wc#p`cyWaR~%96VIRGY%JKQ^gOZ9h!MjE)dj^^_@4Huwn==4LZVHP9D2#h zPnR32=#TnN7n(}$hF_}Qf_Im9Z!54?#&`X1)g5Zc+gA*Kdt%nv?!TJJw;ZBu)RD!> za}w}uCO#!{rEX0vWhX$c=po$jOPK)2O}Ri$@XbDd;cg(B}DTIFj_xjd*i zVgNexy$xV-vel!g_}rKF&x#c5YemN@$M)PX%BxwsqZrpPK1Ot~ffoi04b9NUvK~!zXtpX284jF<{i8R2{a8!vxJ!D=6v)j zmP(r6VBmC?=dh^EgtQe#KFNDlkH#i(RZ#WL9n2pMU$9SC!7vzKDZ*y;0qe^4@i>~E zRovcAxAAiy-u5;V$(hcjK8KfFUSq#UO}xSruAa)}H1$p4q!Jyeo*{j<4igZy&$X1_ z0jjsM9z9I&`l*u0S^caqdRPb}XX^kE!|cG<)-_+~H$6fEPmH0mWZ-wqNYI0pC55Mi8B>my1NOFqKqOyRq(YL(# zaJ;-Kw!~Y-??}-uL$^}}E_Y8nANvB2yY359x@Q!O%&gv#YCmETwjX@ljhg;+48)cN z1&nx@5m;2J5p5=@*%8f+6E9hEz_)&*JrC^A8KhkYm3C}qfK<8j`ayyr+5;t5cR z#vUI~m=w-z;lguDcV7roc$v>i*Wcu?n<=jn`KD}ZE!xA=r4Sia1BVRIrbBM9Kw3Ns zicW)L?y*9WZc4bUitC2Y0PM=he5;dTP5tJ&>T3oYsA=@|3-Ib+?{VDC=yfuT*Sn7v z8Io&=P5kyd2JiIJ1L+6x3U^WWy9Y!&8ja)d3mT-u{>&J&QpBt_cW`OvG4JkJm#@Cr zw(;^fd5_YmED+WNIFr{iSr6(o$W$$#3E4k0)azAA6#W1XnptBDFgx3zxvFM=uAe8i z{c2}oHd3bfl?J0__&AeT$HgmybB@=8w|m%1Tx?Z|trs!UiNbcnml)+`i{3YDv`;?L ztNwW+`KRF;AzX5O&*$}RY0Nm!)QCHyFlFm`{YkRtvl2_$HbQWXFOi>8keVn~mhtTxk9JE9aB38I2SsxFQq?dSL8l%( z`ub+Das$I~ko0R>BrKKfs$hvxhQfX5vTt#pg%F!Cdz!=fSyT6(wP{^P)>ITP7URlk^_&$jSd0W;ZDdboNu za?Isq{d}I15OQidTjSsbFADF&nWg)Izx8W~qSs}OZN?|?6Am36$*@c<83x!Ls7iO> zV%%Vi4)bq;9~ZJKXQx#S;zUYf+HdE>@kURZusr(T6q%6 z`HxfTA0e}_xI!mTi3)WBjF^RzQR3GQahI$N9w%`Tm=73&dw=k=MPk_pF1p@-&xeyz zJjJ&T-idB`r@?xDq+4Um0dwh_J0H%RHBi00a{?YNr&S_js>+JeXW$Y-;;I|IWHY>R z&jR%}O-PV~bwmA08v5UKFc%j*wi@wLe*1b!=csM*nF2BM|6FYUgHF`nuxX%K#%r)$ zCRoWZV23gJdITxmdqi95!>blPcgOTnA3{2tcD5gKVDzeB^hYgt57F0v8m9UzT;(E& z%ynOY(%o`zr$g5^s)dN4Qla4R_|DO%3ujvu@d%45>gURClp=~NvGBxNw=q)r;=e5} zgdraRE4L?b`mwOW?bi`rdd%y4y)oy=mzXg6z>JSY)f*hF8&S6X zwcEwv%_1}c|Gh~D-sCsNz@$LdjA3~nyvZqP9F03QCs#u%d;yl&Rnb9<{r6sf3L_q` zEYHt;J6qcKB7B^9f2iT+1}GGVJD|A9wT}BYMF>LHTrkC|CM1$9(!Ls_U}sZ=D>osp zEu5G8h#9aWW%KWoCrTK7e+9aCl|CzOv&@=Uk;vKR)t&pNUdEt{t+j=e+rbLRNq~O? zO$9o9BtZLtD!7Q3n~shS2vuUb++1AHI$cP3$?RV3;>e61e1ru0p9aN{=&}VyYyj!S2^tgIFPf3#2|asfbP>pFLxz2LdPjPLyS2XN?m8?yYhm} zBudZ9JRi`V&SxQQf+i65@K^r*JslTx?MKVL!*ciyyciH!z(%N!yco!BjL;JBv z*}A-;Qg$MAuwpeJ#n($AF`Ow?NlYdI1j=_LCMqh8#)f#Mlm!hyt1Jb>BIUm9WPZ#H zXlMusY;AW=XFyD>h$7Q=2eQE|ph$`Ne(~?NmxcgZ^M)1$z_8HX9l-SU)9zTO)EhZ! zJLY#+<*2;rn2q_T02K~b+=UaR1>rPRI+u#Faym0`aMG*Wp<5^>F0N8!aFfVps5=-~ zV|&mo2eeu3)vH`+xreDcq(%6`5s}j)B>-jgDRzIh;)p&y=cU(6?S8U5DQDrPBp6|j zMm;MtMW{$XE+e^Rdl~U7JvhytBbot;6j)X!k>kD~@c8j#0vcM{^z}^5H-E(}#mJzs zVVx`sc*$ivJSkC8cA$3|w+K43TgLwxTh0?Z$m)td&EZ@N(i)8)1RFUgtIz<;T1YTw zKoNC*QXb$!Q9;QVE_-fbe&?@c+pp7p+(({QxyUmbcBv9$Nj+(ee5povzD7i(8_{Xh z0K_Ah1i)eQwXLFWeFj2FwMH_jCS!SpZ7Ga`f+>AYPPS|cZvVlPQLnf!)B^OVBxuAM znJ*-04@aliQ#aEZ*e0BM07eAlo(lS}m;)_u0K#01d)G@4^ke&Qe_HGSBGlHWzw#yI z7-f=AZ{!=SMx6j!<@*zub97O|<<^EWGGDx2etilrKSHt-#wLnS&>0OlzB zEoL03C)Tpe3$-X0KkhL3M@W8klN`T4Nj8|6h)7omaC?=}#{&#bWInXkfUQ_#&h_Ad z?rdu~vO8HkERb3x6x9rzHRwG8Qr25h!8HRXu)MnGpvR>F4X(X*pdQ-o&!-4!0aHWq zYN*~5$Q?^u*fR<>D7t7mgNn2;FM5!i=ED1NQHwGB!c~$&)QQW7nkNRmso+y%fHw#{ zg{Gz^AV^jpu8VunB!XbMT@FjVfVV}P=qrYX=1%hzGYHHQaJ4LjMWEh6`-u(AeQvG< z7-j%}YDh&l7ZYynOZURzK?~|JneYX14he+4sP44ccHKNbY3x zMMOm{8I4FX^GRZKLa<(s8AC8y=uH~|Vk_o&g7sqXbWKf-co;+F!c})4XhDH|CcPiT zc=`K}ms#rWab6ekBiRCYS|bxwxkmLo|t7rKwj`#mvLEP^f3gg|QUZg-9?bFrz5k@U5r8 zV7$xV?8<24QS#g6UIt8b`rb!?BYjb3L&6f}CqJCyxAc2ieRby>CSfgg!4~LsLm9KH zy*3~STzOj+uxXrjre4{X-0%k$?UZYvDhk;~HH>{%z?40Fn*5aYTM?C$NqsuRfdtVJ zV_j5&X8~Civfu2M;=xS7hlIe6TFH8p&aU(#-0+KZOInt$J_z21R2n$x{|tjgfKqT7 zLbA4$K(?3NEvp>=|EagZM?NoQMit|eQ7iKY`{5;p`jfhHXV%0bL@7v5?<2`&8UI2M z&Wse8YCgcErEzP};bHY@$;>&j64pOCD&7Y6<5?m13KtgI;8`6j)x_rg0+)B1>4S2H z8k{~rxDG?P)&R%KEK%Ol!zZil*T^qKpJhF%WLQ)NOCVDAdpZRA6iZt#s$UefV6v}Q z;xODx$mT9qM=K7)q*DhBdQVdUzAO+nlj#vD@QVlnf!`kF`0;-)qQ+0S@MYsArVNK| z_>NhI# z{s~al^O67lO^Jh#vcB(!HZdxXO;o?*cKcsS7`;;v-fHbXSrfnf-c#_uw6lQ$Fs+xb zp9_9e#>};Qva%Fs@)R?b1$;Mr#kKy&z~vwtW&NY@@ig_m@6PA7aCa`8Xtk`g^kLm; zy+!z(QqX#QkEIwOkU*esdlu=MOT!3pqEz@(KHa!t#KMhq%VDc}IsZl`g^@RpP3K@k z;V@S6iI-&CnL_iCfg}ys@6FnCP6u!En&{eL%5FWt6H1nKw2I$(yUapjeYTH};h9?9t~H?CBfD9DT8ed;{o7&8mDE-PN81thWbVa& z8wdL7(`7&@A}G|d^Wed3sMm|HIct+H^nIsh#^(&{U}QxfMH@dAbDX6&hN|5YBO(bR zjUDrFi2JcGAKxJ0O`L3U%lfwvZX`T{F-sDuYeqA=%&96E+}YIuHZj&FrsJ5JK}B$M zYgpG*Kk>{e7ob8%Ip~i3n5@ySRB=Bb>7&QMu6)ka_)`fzw>>5(q=*T!gg0tGKm50j zRUG%yKSvYoLrXRUw=JLR&Al@HKUeSx%3i%Lw$k|0?K0V4yg-Cey12LaI8;c+lYr9e z1@eOX#ha&I>NMqM#>S$m*UEFQV3O3YHlwq}!}t(Pkpj&`n#5c=K`3_s@cni+R}vhz z&c31L^%~Q;;B82(`V3kA-%wHks(r4)y?-oAWSLTOU@!|)6cQ$O$UOxx#2#f&ccc!fu z%D3Ey{>KFnqO?*2ZNb1>+pRT5!Wht@loTs|ai5DLKDCt=2>^$w-#aFZ5BWX=Gk_z> zwnoAy1N@`h7y~UuV#WIo+c6$F+2mpH$1y0~&Z-|MaXN*ZHyxw8zjpC<*Tu;eVR|r# z1xoz#1j70Mcw;Lmkq%k2^N}iN28XbQ(YsKn09l*JTN6e0;wZec&4{~(72iVhu;|f9 zY*OKEa*RV)z3tXH1C^EBKXv{HEupj2G@S~+oCvKpt2S)>e)2R>{UE?mYuUC`f`e0n z^#iG~{b-MW6C`x&EPD3wV#=1uv zv{k~80bwA(t8jMc%%>niV04c@9gSOLIfbzmX(4CZVs-&rKyj_E>63fZbprj_Wf$9> zC;t}1gB72#tECv#ZI`4W&PG)>kpXn*)Q%8y{FFvh*Db|aW83k;Dws6+lFr0phQzMDzp}yY-E6^FVvA!! z_|pP|haipxDUF(qY!0TliRXOV|8$)CL)R93oXGsxcCCiFV6PWmB_nETk^i=HP5|yF z64D?gcZ##cg_ZVWMqzmVLNA}ux4EB8Tz0r8{PAV@Ebcni+n}wP<0Qrm2|*J$x$-}ge7iiP!-a1;7zqt^?(3h}l{dhfqFvzli#m@7ZV1(Vla zO@xy8l^0&KtjF`$CEX-egfyD(dnyIn(n#C_(zTsM&T ztSlOU^^xFh8K;@t!;BL}>Xs`Cm_K`n^h0Eo@R56V+nIlKm8HgKr4fI86;E=3U}gTB zY{@Om{gVECgI2-HMs#@h>5M~zFwxaa9;TvM=e@b~4yJx>vm#mI^FLYHz?JEiBiJ3D z!Ib|-P90DwEvzR{Uaojv>mvpw;WPaw0S@>)Z~c{6c;Ee#*vbR{fb`}Q-sA9>0+jLh zsIaf&+`EK*i3Kb0o0peZ7z6F)@`NRyW<2Y#qNRbNx6k>p`3Y*|ea~rFrYwoyM-Ap>VA)h^CkD{UDkY2c_eV7IRDdED+N^f+07(wx$({P3==m)vWs<}sAG^KzGVWOJL$%{ zGQQ2Uf=RJb8Q+WBvd$d&M^C=NSH}C6do{O@Dza2Cy#dz?K750eYV@=tsHe{X$_ej> zJ`{Y8=_cJtGL=dRR`?@$Hz`O(*OvI-H26VLU)(t%eaun$cnlN95!r-pxsy#lA9LeJ z(;%;rv;~i23t&DU@a7x*Ys4O{n%(33vy)+kCoAHAg1re(3>`Z941aAnlOLNa-{AM8 znGn)XZPy7d`pq7zFK7M>KcC==lOsp6Knii-q}td>iB`o!7~OSIgwp5@>&bEBVZx`= zCY#v@kf^A#y69`wVlO>1=A9h_(|?<8gkAgbE_3%2_1?M+kAi<2lM9l%UU!%v>(Fx= zn|=wy2cJG2cIWcW5l7b_CSVp}atm|-$M5CSOp%U%pMX`?>~3$yP758J$^5$n_}5$c zm&H*2?Kc2zzW=oPbcT^`e1lJxo`rpD@cn3IvDoReb~Yrqle#yz9&?1RU?L8J?Go(y zPdb{D$#)-zbA^RMSmFp%P|YR`JSJ1N-ZIPkmkM0MdV3z9Bs`sUCB+ewtbK2L zPFZOEW2U@vuBVUH?errFLHKAw<3$G@4RPR#apcZl1CxKEAjcL^DOqj>GkWk}QNcem zx{Vbtki^CGr*h#1VVVNV3$GlJUy+stbCk7ZXq_djSpu%{K+_3sik4hE`^x8Ud!hr?#7&lrZ1#=wxheHYHZ zU=IHX-i5PYz}Um!lEC0YLp==SPa(|NBwqOP9u8-s{&nXimZGQMJi`*tpBKiskWnq` zTR3piNM6nn&Zm+)Z%Ws>P*B94QsCjNG`v$~*`5b@i?y`^e!>NCq6&^c-`cL;U&w&- zyvTe2sUkHhukP~PS2TXP^y59IR7IFnaa?i7z!K`}F-KN>A5dF!6)Z+ zQ57syUN$Zn)3NvovfupEg|t{2eA@D$Yu*ZoY&QY{9EqR+`dj93>NeNa_MNAwPsEjU z-wQk}onKzS^!LAy_r9eBfgSI_t+E zIcxHZ7cV}3oC9YxfW_MKL$%VOX!yM~hgy;Gf{3KFlATPI*E2n4O)PHXlqU$jqTVo8 zjWI-L?jOMRBvZQdmX>iVuAP6&&+q0XH_ZJI3G_E66P>-geKC#eqJs6njbwG@hJ8}m>LR6`q)1^mBN_sZW_=O%i8k)4tRI1wB<(KKBl7=^4^LTq{>FTOH zOLwui{nJ^qF1ipToT#rNJvlv{2vjXKTtpmE?`!JF{b(>V1tB31;lwV3B7-KY18L7S z#jM+3BUSe7MCx3olmE-$5G|U^bGnYvEY~v7EPzP^(@k69dmye8C@LySNs0R|rGe06 z5)zPoTe^Cf!VHlb4|f7j5mR;8 z9XKMRj_(;T(~H)CDi=WthQ(v`=d;(S^?+Jm%pA}QZv@7=>^B{L<|qgX>H!j^X|6Kn z!CW>lAUG=Eu(Lvsq(B|!HT}+lQ%Q^Y&1l34pTZlOq zg0{JR`}W6Z3=ZCx5$46UR!<0qBf|+s3#a59sTnKnBiT8MP&zYF|PHX z<#F{545mF<=c!R@Mny|2CJ4u(fMK|@ylg!B?Eho$z2mX|`}g7V(^OHEWQ3dzl~rcQ zNTOwB6VgC-_6mIxN|Fj$5oKm1qs&TWuQ<)3va)4w_wlCB{r&#&yZ^cGfA1dGr5b`yzTigZOmy8l zcL%X>U-({PqH3mmVE=yg^g;A&N&la$r>?F;4D4oPTJ8*FL<)fB@$&MbuaDp&U$<^Z zP=WP7dgeC6L_cK!y^OGsO#_pl$v30-#ofIS#i@Hcxh#*Pp8{`lGijVnW=DJVF&5d#S`07GHcbRq4(-+`h;TuA)? z?cXo!1|}O*3F}R|w0>e$ye;yth}-|?zil!d{z;HkQ&TfHf2EN;1fPaAw;B`HCJ=3* zTwG>jU1h=HK_MYgV)lnuCjs4pP|BE8)xY`m_oRziljkzf?Wm=xoT5l^$Le%rXt)pn zJNW4-T02SaGYCd3>V@j8ks?+r<-)mF8%dW=oH=thBt#R19?bh4qlyqdkD;t46vrqY zVq#*Dx#`2+w7mNIA)5@#c4lT^>uQmToMhA=52AR99Sb!zT-9UYPYIlhR-QCTx*PS0 z(4Zi7ib}<<-2ix|Rw4K*3WXvQZVYZYsQYSd@WN%))x3Os9r@1VkeEReOyg624hgSp zvV_F(IIti1U8 z@@KBJd@}j*0fo&pG$~Cn1KV%aY7jl`aP8T#v7Kn!y)V8NLwDSwRgg{_#aEDBQ#ALG zqHWN;kn_#Pua%0LIukLV=UEg*Inmv_dCL}YwBog1;h^>Q^78WW0iXWau^S)X3Rt5B z6z!w6CW6>N;8!OFi@ER0?PR>gR_6agE&rKIC>&Z^IECS0PNT{BZ-;=os_7HvA zWPYeGjK{7t3_~~oZ7&pCLz1WIDS3H6qLnftBH|U{C2WZDL8}zO&z7lxZAhjW=NgAl z(8N%irYt`45lecrbTsk4!jbb_t!V~QASt-NJRgnCLA=YtmkH?=->?Zm zVfuA4;j}QY!dQ7%-5b&c4iHi%q-?oK+PL`m4x0*|!@HR)!-NK~s3t~7(=S{ndFrTY z_Mp-p#HOy<1EYujNz^D(o67q)oRqVWv9wHWO_)%<*6a)#`&{xSlCr?zb!?~(p^k)@ zHSD6wXTN`_mIJXmO_6QbSzLxamVI_f(1IceNRKWuN6=@72Y>#vYojj zNc2|ifn#D~_fDge;-x%#SsJ|MViSwP;Qt{NGDZ|+W_!YkfD$X4W?t{&MW~L5xi2`; z&Ehkf>3eHQ<`D&Yp|;zeD_Gmx@1%=V)YQ;0l02h#E1bEk zE>AR=Ku$tY7K`j<|N%tMt`j;0d?530tQl7n$s#W5={)QP)+96uaiGrWZy9MF+%tf1aaR1oa6m**K-B_7q(auANk*gh*5{CB{nkk~3_&&vwqg!(QFO zm%oP$a}G<18K%a4@O4RlPL~+6P7b6$_)fs= zrS7^|d1!M|(y0!R-ZyeQTPJ-MWsMB_!aL4WJr9h^p2uQHA_ zm14!-o$e+=Uwp z2nfhBn@w|JEIYl8gScSxp*8>KzY|>|)d*QEgtAB+dsUSr>{+GswY1)XErb09^;D=E zVc9lzbS%g1B49I;LyZ2~pXfu=c%^j|a=8OkUI=}|#T_kSe++Aosn3J-;eoapgct>h z*H%`7UP2K^Ec8%d7>6ep2SI0wJ0JQeGIHq0k0VgTLyVGR-f}@!BTXM`aWH&UOSjq2 zWwRGL3RL6H&mzuA>oi7=1f2<86_q;d9SA(Y?_&i@ps5o*Tx94z#lbOj47w1*7X2r= zP5Nm>#BtMxgNSM%AE4)GKHs05h9PQz_=-e>A}41&6cBPz+$WDACHnU2-<9!pZy1vB z0>Fa~&SIKpSMhe_?Tn00XgFmWv1-qsZAerN;nue4Dh<4UpBi}ti`yO&>D4K;rGb6p zxf2oN0E2RlgcsuY8*<<}*s*d#=we48h!kP$%u??8zQ65q2UzYCcs^DtoSgEq=rpSg*vfcBI<^j$3R}8eIusMRE_peUk)&*8e%0JJh3|aS z!-vtr=t95bo{3IM(-*&y@b_nN6IV8w>9=S7IPfqkDoq&HUH|%RL@n|0@x9&M+L8h2 zmdgqVLSJy(SihpFX@AzQjC0zbzf0(?geeT5C&+&K@S$ji|(?0H?ntOP=Kle zfeF)bIT|b-k!Svc2$MI^QmK!0zyVYS$jQqm2Z|yUPZ%lhZ~pF{ z(r`Re>S8%C%$&aDa5fx2)@8PNCx& zPWB5_l&Hngewd;W6@>{#Kw`LzenBWnzi>}lI+wCBcA45sy!vI3`jMNW_`PR%WwsI1 zckJtyH^!%~qFX&hXOYh5qMlv|pMm7fxe4^-6A0t4Pj}%jiRF(j<~?M%;&3thBq6_4 z0SSq4`x}nn1ymk7EY27%!5{6v%7d*yiZ+1 zizajIjU1<&6J`;<=Hidfu4IkYw$~?IZWc&r$;!$qDn3ASA0pht7S>P<&1(OFh^(q9 zOzGS?sO@y(k+A?_>o~!6B3d~wJiYg1a`uASs#PTCzGx{8l0Wt0WOAIQJ~PGXF&{~g z?Qa6#p|kjeX6e8hQbS^x+jvv4m5&RJmvF@f51M4@=F|d5ACKjyfd+@kCC`|IqfvA~ zM@Yg3pvlTRgtt>!m|b9cS}SJqrTy2-?2}6ITB`*of9hMcjSAGJ@xs{|GsNt8hToGm z8IW_dYWvutBFp=tH|ku)o4-q9+nVPowhnf0Inz^G+nLXB62{mw+#5Lew~m1TmDuNj z-{e+m4{_HS2WVU0z0PqGvbQ_P+Z1^|AL5+Nl;Y0>XHwaJVPOG~2|Tv2sAvm?BD7~u zG~igsSNP0kTu5hy8r$sbEJAY2rqswRv&1{F8~t`-uz&E;IwlTC%CK`qL`0CryCkRd zpjW-Kv-8xaj*gDH*VTM=P!&Y0@TnJ2T7mUW8SuHygK8TIdJrT1J@3XZhWVQNpVxNs zi6Uk_`Yi4R@vg6k0uel%--`cR0I4x(sAQitOlXA08$>7yp)HfD{pL$+R)Y-i37BxA zuOGeKIwn(CV9U_QK)+`i$ zzgV&`*=42)my(E~I3OvB&RI7?_RP3OSXAu#*B8;z(f_R7KuFR8+x&~gVX_{M?9bH5v%2&1=3tggFp17h!(;WWipMNlij|ifj zHzZ`tZb~oOI5@a>1J@#Hb69|cID~0$KP4FxKAb;Zt!w%2^NU3wa3J!1hsIH{y1lk` z3s#P7*Xt5CTL*_FECi^1!CiTDmD16*WL{TwahU`CdZ4!#nCtWD4v%H%i~utn0#Nuf z0)mwWMea8tjt#U1q8A%!m?uDvMrEPA>p3NH7*h)VUZj+VJ0(dSs|YHEOG`^&xrR#K z%msUuhqxIMijWXavd>mlQ>c=lqQi6E`cZIjHgvc&HJhMkn)&vv6R3%pwex4sngT~Z zeYzB=4Vu3>JExHM;{&9|PepBwAkqL_WFF{0z;Yt|@fJoN8+CK41-;r&pFC-Japo~9 z0{4Ns;8xybe;`h2D;rf0*&2GIM*V{8Rto%P9>xS?vO1*Z`13Uo?-;nxzVyA%ER+O%w@0ebl#&F-GfF($*p4@U zj768+f8s`g|MOa0&!vC zY`hFO!Th51J9gl;QOWQjga~8K7xH7FS9qMT3=Q%NA96+!1i~&hh6-STsQR-jtn8R)yNG zJ60z$*#lDi2u(9G_$gm&YV6inLmg{NnrAL)a%}7#3X6(K_W(g7e81l|(){|Qtjp9O zz#5_AYdL?+w$st6^mQ*`&xHpE8;$)2As1&k2wd;$>dHiA472A~ipftKNdaVwC=Sfk z2Vpxw0O4l>4~sC$L3=4emiaAo}ZP9&}Rt^LRS<)hqKqzdrX^DWjxIeCu(2l9U{l zaK!>0@DXmg4(hr7LNR~}@D{mtM+j#{{jjEPt*cn|E7Ll<9-KPz=R1 z53+h+^L8>Z&B7IFs;S}lij5mKpaDT+$O8&OK&@Eln4lfe{Q3&W${tvpd_@cVe0)|2 zxQNOzvJ?fj{oLG;gOMC)FPPt3 zqMS3##DCS7NDwAb3c%SYlKlJ`Fx!X&QD*|Xz5`(%6to~*ISz>ne# z1P`(h1*0A!C^!MoJ@rgWFiKB^z%`jz*!bMp$!Ry17V1CwKvD24iV??t{u(Q>DF@zk zAyN_bQdk6|OP79p_S*&hd3qL>Jh)y+j{>A)QglUl3lCrL>Q&{34?iIc$IgHCG=LvG z7b0gt!;fAFVZ$`vBCv*p3N%wc=5g8a9+|9~b z06z!4v3%qW=(rJDR@Mfpmm>()J8zWbpWSH~QS7U*}t zPa~`bbPnVQiakHkIIxUb8zyc7x@s)Ugp38YEO|RUy&xb_lnvm7Z?5)R!ENMX({WVj z<(w@N`v~z21Wm}Taqsg{k`l*`9pm8{8n2Nm!q7lNan0Jb>?p@mGSbtnVb?JZWE)T# zwn2lauI?x|w>ho~Wk0-tgu~!dplmb@+G+iQmcsPHGZ)laPd*LPeYNNz-t}%|H^cDh zLXE2_z%NGHf&C;?}M)T`eH8aVm28%L?jRvy>I9N zhy*f`4bR~=)rO9{&7`+p8A}Qd3QDZD4zlJJ=;Nq_{$yYqP#vgIdKT3Wv47yky(8f$V6}G!qRXo)eH;`FRrVkz0VDdIi_==9?C`Q z`)56lhOQ6Z(w1&`+hsFlYfN&(TOiU6O z83n$TU=j@>mxw+*2-zcHsW;`DvNn4`G44*;bF9Oip-77{-NP+InuwxsexBci5j;qsE}_+vtr`!E;t6vV#aH#>2D3BT2=VH1LI zVyINL_IZEWjzA<%%p;mPG-g??;0{$7D_^;ZpjP|wA{5stFc>senM*ZFuk!Np{zP4( zFP6WFB*#0lX%|&hkr*~q{MI|(-eD2FkW>DmB!$z3kRg!A0z4Lq7ft|0i(xML{8@e0 zhB2{B#6zNs-iXQKQry%Z4VG~7qZOLo2E^^AC%gUUjv7}-B(d>=^l_D17f?t4xHCZW z%3f_m&nnYDLThe{nbhtXKeS)X>Bz-oy&Ob&wzbOSF%@JGg zqe5awxwr<g*hvX--KB$`!8|ouFKgjEtnzALYx_uy=8Bk%X@}Adc-Cqu&ObeAUS4p08YN zsIWztFKQ!5#ZR6S($7R64~#}4rL#Or=_;%t3Iaz&8?r5Q$F+SMlHs}I&z8g`y>mkh zY3}O))>T<$rQoO2SMa-_fyGbocPca!>U0&-{<{j`uR(j@i8^8LGJ;+qaq%{%<+a<6 zr>_>IKBmhT$P#*bFs}-V&}n<+eTKy`-GF^OZR_L(g3IFO{Q_BJK6niMN{nP1ATK+) zxmbUhJ-zhKuqvif!i%O7sdZGlL!3;!6l2B3Skfg&2I>);tn^n)>`hgl%WQ6=s-El* z#kz`d-ga3;p~^;*l11T3YMaI~r9Baoj|$3Z>aOn7%7l zt|)8`mEyDC`#3EvZI(NceEI3?1Blzv(?t+LmaqSo7ixsnM&uLs@+D>L%tFrg$<5(P zkN1*^VN*Pjv|V1lCI;RNA zvI!&sxJRsf5v1v0z8tPRHSJUgwv9w{6&xWDAzBs9Tp23@$Yq~$XR zOW9LDN=4rpLp$s8rqvz?|kSD-NObbZ;MO?b7_mRa)>hWo*T&$#}irTtwF<=B4x3 zuk%ykQhbyDYT7@;*b5`&OGr2!c~xy3PCdRCZxKt<-$=*Dt$PJ4ux0ej*zlPY#Y3@c%g9Lpq7euw%;fYU%dDY>7v@6 zZ#cjNWC@MrNFg%~8usd$J}}wNQItNp70uOp`}ic!A5Ol!@SKO6djSComI$^{-+((; z6)0t9h)=O%=8%D_H~q#`*o#F1?FMw1wDl}i)lz-~8|9@&pL0WE!*a5r69}AQk*QyOgxOfMc^>C{IYKd3S1MoFi0(pl z%A?!&TpW@Hlb*%q?#(pX?{{bX$&)7uG$$Q%e9yyK!{VZ3Iz;G+<7_^sy1e1sijVAj zlOT7CWrN+oeVp#GM87kX=-(uLo})kc34ZJwEHZ^YgV{fBK8iSS1&3x7r+7B~L}+-! z(Xpnwx*dl_ZT2$F{|z-jlb=z~ak$zd1`2`xG&BUwp%V#6rfG$!h`N3kFr_6FQ5GiC zJa)zggP3{W!}I*8lSZqiO+ea!qvd3$2E2RbAk%V zGYDN?)Vq(3VpBr65k373ydm~t-x0&?BSXJcdF?p2z&CdL+thE~^J%3=Bjpw8ju7FM zlq~$Zzeg=fOF=FabZ!Q$pS)g9Ec5-oGWlKYQ)4j$5z#r^za-rlu!S(qGC zKadk)WXgo%xf5Ka?2Cki-yO?KId=#}NYx$Zo(2dePw>r&3~1~o-t9^`qJ3cR;LrH_ zQV9iTwKE=26bz1vS_V>Bv3%fhQi3$NK_+iwE1%|?ibRxKf6(i@zY9UT>CrQ`LKs-e zGco(}{68>@IGd3;r6TuogV0U&5kMuEaiEhRbKb0t00L1TrzcfV1)gRsKwP(tYnL)IBh65K?g|^P`twys$i^s@xJS8 z7-USRvc)6ZadNPu$Uq^$xf5qSVz6Yp;1L9hdh)D)%7E)aC?3-Y*c+qX@11=0He7k) zrx=EgH-itvhigrMLM9S{1vvv= zaJ()6$H-7^+XjAuqn(}L@hr&Re_2Q(&<+p_k>KePgkD<+ZzlK7AX^L-gp?bw%v9$V zhOXXTf`E2F919op02?~UTEryPUIN}g9)mP>QkFVOxiO7ld0S1N`vR*>=BWRYdhy*D zY{b(+wX_T7=7V@lGxzM-@!siyrV&1mS--g&=o4fCj<9+h3=gHc>|9;Q0ikj=aeq3BdJ*sAK z(0sh9{$CwR-j=%V*sSyC8kx`tXF<2HleELaRKIvbDwkc@13mj5f`~ja0+>>TrKtO<^ z;{a=RWU0#Rry9-~c(5?C-Fi-{i9=9(wBW**@gC6ighfP}tW7X8{R|}-7$yhiMh-!P zOy#sD+*4B)XQW)t_q_}Ny<=%gWK#7@#V}r~ag>2EY6wh@3r&qn^)`NPIm&_qS6p0jpLYX+YuM8Zu&I+T7@)IC z0Wm?|kw`gBySFD^X8j0MqCrLosEm+%;`sPDMduK*FqEiF<8_|uqxJt)jq|Tho8ScK zLXTdNQ_yEBsCsp>`G?2!H~Ps@nWo@wX=IrtueNIXtuI=ve>n#&$4j9S8)XXg*_oMJ zU!2)7X@>+~0A^ULH51Cr*-eFA(u(6Xn5mfse*-RiCSd%)Q0qJ97GOEGKd@p7eHbL7It6Td z&Qt1MTzvI_$H$|U{$BYjY?tN2hZ*98rm39k^+tG85UB~oWsd7E zIPuU<_OEe6DQeP(+Ss@k>7*&Dr-a72j{4;f|E|9fF71R~4KVg6*Wi4Ze#FckzwUBU zI~D_uqts^LoGu>S!(?zgJwRE7z4{DipL7-l-21VwuJ!K|Y46z}$WV*SU$5!Qs7k0erXi!%XYV8ECG#;V03ZAKn=v`-ZO2>ahNKI7`-1T0lo!Qbi4 zn&*n~^N7u`$Q0PPjvTQDGg(MV{pGDuXgUjV4?-iu_~(B9bsvdjJ~xFL;RYLe1-`Z0 z5chzDF0!GVGG{^ND%%FG}QdM6Q=yhGL2W3i<#PdlfG+JZHvhf zz@(o($v!?i1#x1@#rqKSMi^fe70c{w@|A#2F=>n#%Z6jLsW=D_FsNXtaRw+Vpynp@ zZzNF0BqJ23vlnO&9A2bCr7Tox03XBgCo09=ARY@4p*OYF5AgrK)}`o7{jMv1aZOrU z8b_C)k;G8jj{v7U^lm9zJ@GfAsOsqJOBz@29#=x^MJP0Wkc^y}ha^xa-}#Y|5f9AN z_+z3fcVIaNr(l8U`25)=ARPK>1o491dZ4fG`nPGzV?lqS9d82_*X1eIKG`2{nO{Yd z^f`ma|0&LROAI0ZN5CpsU=Mhtd$E0(GD7qk?(4rpcgsRyxdl8RBCH@^1~AOQvY=qM zayko0Ne1~&M|pTqx*}@xNRe5fQ*~#S6Hs0T@UKfdJKj_)J918Lo7R z2?@%#r4SINY%pPh-cSc{B;Y+fuZ(GT?IKiyJF5Fp`4FQi z*i8g=YR%)*(;|iSWuH*OQO`be`t<0ZKP_+vsJelUjwfQ>zMVj0lb>zA4RP$!($jQI zl5TJB1RcioE~DOgfRj^PR20WJ+M{6DqnWb-kVreyJFtzy0QjP=fZJqWukXRjBOt^J zi(H)M5^^)6#?cipm&~lJDHKy2LUB??CTWi41ca>t8Yo2^3&c*tzCc!r$q(hzPJI#- zH1zG=IFe^1Qc%>Mgn0l>sB3W04XGZg6bRz9^o8~z69!94C=W;HH5quM^so|w+o%OJ zT&g~MbG%9f>@fO3usWZnUAH`;&i))>zGX|sDOQV)!bOx!C<)adyWnUh0+rnN6G%C@ z3G*lkVKcx@peT-L$lztvD2NS6?upibLx;+Wi?5)T2@qDjMp@v>e_VjQ!Z?X62k=CF zAF9rl(6It0H>o`YEFY1++01>MzWMOcBV=QUi7jWw@7amYt7H&)h^+v52=ai+iC{xsY(sNNBlHlj(N0-LI zgQe*SdutCKtw``ys235F@x6s>LVYuwy?1Z$R@`$Rk*|jW28vRYta|p z`CO`(d2vjZ%*8^qh9@xGO8>*?>KBsd_t^K7@he02!@&ysK@NLn73V&wehRSd3Gjil@w(j7Mr!@ zy~0#&3M<2iBp-R;0cU0Z$Q7c?HVZh$E4?+O_l315o12fjnaQWzmXjq~%pa=$?PYJ~ z1tldMow*OFO~x1RP)F)7ci;W=*>SxVWR9dKCtjgzP(vL+?vp1kD5f{v2F)I_N_hF# z?p-UE98LH2o)1!Pw`S1>{`>Ww0$thP3-RDW zI<^}Y>(0zD#jdnuse$-qB0>M{`Q647vJXBPNQ49%uQnGq?_OgVOZk#j<`wN=I{(Ic zW#N;a;tEE#%e#egmvTOR-5mM%mS(tROM<0^*gK&efoRw;KQqm7++c)%C}FMLi9}j-jo)fG`+Ted;{s#S`o`aDq3u(zux_L%| zjW}R3t7J#HJ$S9e(s=KH1y^)5$H_Uz{4n{@yU*g)asRCi2x!cRikb9K_a|gaNw~DE z_WP%^u9L|dorwm~G<1aT>L;V4S%g3hiEhpF$WePU;oQ7<-`^81t8aU7os8?zk?d;I zD?_in@V4q^D+9cP%4_OZA)Cd`?_qaOySShE-ABLLTKpb@BU3U1(avtloLL29RI9H` zOEpyX?F4IN=2r3;4t{NEIR5wB5ao7wakCc*_HH!mrylbMgHTgZ8A{rS0*SunwK ze&33V_x{us&$PzzHv);yQu4-s+x|7c#24p@U}ewEy4||;R8fZb`U5(up}GZ*NFipr zK+N6_n|rH`|D=IEw5_qa`8xNhN9hA?BAKc0cQ{h7$X&+EfXNOg|lu%O&qJn_tQN?dsOY z3+PN|SB>GYZ*W98dlb=^LJJz!ShRiwC}Qx zoljJ2^Qi7+8_U0y=Sod+MUl`AhQuu4O zEhX1*9PVwb>`UZ`q)ZJ+UCdbBDgDs6R(HWrh8)nL6AgU$X4)-x^(NMjp=Gu|jiEYV zTmOq}gEplV`fF`7EtO$e44r%RgRNwnW0LbF=R#Kpj1XV&+7HDHNwM_U)}^8mKAly{ ztq4@BC{BN>JrC$?q!VQfx8HN1Vs)Xvy^iOVp!B_KU3^tI)C zcilf8=SAkm^j9pD=NC_D->|t7J>uWYE>2DF;{U7H!2(4&1$!H_DJ|c$*0`0OV6qNR zcE{sBwMqZ)J>;L7sl&&@jaKdMH)!vgeu!7E=iKP1(Z)9Kf{im~4Y~*XI}ISI1KsqinXtYTDMUXCE1YE{$w? zmsf9ekrOvcu@{K%9huN+#~ei3B%ZOge$Kn5N_Qq-BY&aEX?1fG zIw&_JE{2&HFjEvPiYDt{M#S*{{goI#itO3i-&|F%E}OBXqJ8O5>*`D-2tiZs@#Dsy z9n%|Hb_=~XXVjZ}BWCXFlxco;>U`FNFs19*e@KWnH? zczGUd$R%y2q6+rQv_JVe=A}k~zV0HWpE8xJC!44f!j;7lnAFu( zN@OL>(R=6Tv@tvP=~fl7*Pm>0UohBct{Cw5N89kDl7(a!ySuM_PaFD=BP)t0)IX{I zp_j>gKovXOcf+_b(ZhYQZbvr`t|1(QwIV(W3q5%u$iAPIjs2W5arX~O9l{1ipjv?y zRbEq*qmzP+hfTyXqR!;_a!yE4&`x^#2#d7Om-~fjGFO%M4cQ+!_DjhU|_AF ze(irL%T+ea>^Sh_iHCX3jzH&%Y4_##CfDu~ZjW^0V0zB|-0#Ck`3_k?N7xYDC=>!| z1JSdJD(EB_QsOn^;CLPLJXDwTEV7pGYr>AeNM}l#M@X{6ima~j&Sowz;59l$?x05? z`NWw>#Hq*NmJ?0Z5IhDBY>PTauPxh4+G;eh0!TK?%|Qy062=^|PpEaFv{^qOO>7T& zIjjFYPl){kzat5(L`#mefS`Mklyv;m{35_Hr0lFmFMq-TeiL)-6}_m@*nmEFw-k`$ zjVht0h;cQI39>_Ca&!*KEdzrXlIOi9+tGnB|pdD%%C@nYyZ|NDGnUk8Pyv{&- zhvU^IO-r_D2QtY-8~_U$eB(F=TGIRVqb>#L@`cFl{{5$hxTQ>QKimFZR}L(n=WePI z=8>9dZx+PZaZCCjns6k z#0R@SAhwg2r(CEELRHD5M@Yc9~8|| z(f}pi!9;G{b4;h?++%(PmlR(&+n9x+l=y}RMEDr}nxuHxw!h&J-5CW13x_m*ePC!h zI<4kcUd7YPgj7(_r#d!fbIlrcAoAEJfOgPpApj~HTb_Trdcuc}&a!=Yx$l#-OhA9@~LWbZ(7!0~aY-vo1O zU(nMdq*t8^AmiGby}QSaId<&Rm4^qpxhH1b^wUJ>IfD`%b=k+ob*Y_&hA)SYFTK=V zJ{~t4wUs38`Up)`4(l*y<1PhgEY?YB9GFase5tTL9a`HCbVozaR}H7IrzIzw%^ok` z`4Mbr0!1z7_r8bI_MC76Ap{|ufJRwCkQ>FsOhwB~Hop_|CCL|t=LWre7p^GHW)|KE z*?($vNv_O;(Hm{qi@cg|T(P7w3N82XyD2DC zp{6;FQ@XOjXOB`-OJ(0cq5p}sWfu}@^1E7acH-?~{moO7May^7{Bn+4ztpc-EFiTO zMbAB3LpsLU-I#v~Iu|tStS^KTXi#EGiiLyK;++p~zN_k30XqPP$*N()PE-a4P}uiH zVY&BF2KnKVKQV_cY8|(9V9oFpcD$ zfktWUWT)fDa_2p-Ci^x=Je!y7vEjwUMB&?i9L2SUx>eCTl5cS*t?+1ZSfeSHJW; z)7>AFA%V{NYc^qMS2VhI4OR^M5vs@^My8=2gnr~Ku#iF?scJirqlkdzmrZ-`G@1qQ zmN3{I)<+~Im%t>puyahiJ`QV$)8R8(UOY%g%=NY6r$S}B?1HWg`?#)JZm%tyIU1S{l~3ecUmG+u z?bx+=#r4@r)Z%&M1c$8h)2E?!^EqgVQ%u%AZhQLG=RM?-ih<#a zxw=EL_)I$Q6o+hW-}WocwsY6Yrx51ASthQGa&$oqEtye)?V;UBX=?e@+KTDn@-z)0 zVs2_BRjBA*EcM1M-4@e5_37syh2F&$ULgkjnCV2=uxxy&g)v zcKkd6{$=vxQ8c3zRs7<%s%0;~+iUeRZb#A=Vj;A$;GJpwJhG%1vIqo4(*5PS53U(5^CC^qgU_T?D;jMA7wB^ z1bx!3(j2l>zZrJ@8RpwyCP*eHZwp>9q@4Ks(|_*JJ~xyp`c#tI_tISI&D1D1?cZCj zrI+!#&zUx0dsB{+?$7+Ssd;gmd*-H`#DL1M+@a+-nOw*HO!S3(3B17#mjeY^FJaZh z3E4&3j|aV|_TQlM4)72XBqFtw`?GQiOV$bCv-h84Y000cPiGh290=WHgvi;wYkc?W z<2=77<6A3Wf5~QXoq&g);{>+Vs^OC?c9B=E0I+&)q`Yf06Eb6T1=aj728xNK5BYzg|^%BWZ6F+Y1v+^pN z@G9IAjbne(yu&7S=vp+jY%B6QT%XzzZ*t5EH_jeRy9JA8bP?I$s&$^Y^JXZ{}#dUEsq$jIYCfM6+pm-X%KJgco>gS?Bm! zIDYlld$8PHABQ#=eopf_M2HOWnYi7x>9^Cy*ZMMX%7{a*>93BQ zW5*@4P7*8hgpZ8x)b$HSU)uz#xwVRhO5*}E$~)BN z(ecQ&qr~+$@sa1h_|?egyP-vF!Exq%-|Q|gan7&Wt96?&z*7ElOTrdEDmf07SL_nr zJ-=u?Pw^)PVcpuz93THxOm?1c{7}EaUPFJWJ2^JM?OCklK71-|k4fEvb9kyDG> z+5#J*LLDcpIwB($mlOj66k!%TM`buU? zi@P$uqc7`Cmn3i2O0?(&g;Y#4C_35tRrRR|5ev1}0XHzy@$U%=-?-p@Ua7k~?Bsqa z*P*trIw84<_=0CP4D#E0ldhIcH=~$3G@ak=&#{@{3RhHbr6{b&7c&3Z%&`X{bn~+` zMW%#$Q`vp-rNN71O|Dza8nzN&SjTXO_Sh9ghdC+ZYoQZ>bo9F4+I)zcl&|>vIqeH=R*`>A%oye8482Qx zuo~1-QEld^ZH}&Pv>IWjh#WnOo#8z5CIW+K)Z#)sp%lGLG*jQ}V1*(kd;5R~6=xJ`zj?#H2IM(Ul^fC6dp~ZmEla)wSo;2pV7yi!EEE0Y0 zKm?P~JC&(!*@hoIcJ2E&^K1PoIZciuKCV4(>22MUiID_!{B|F`%#Zwwfed+*x43*9 z?yBhX&P{bSYZmb&I3$D<8Rc7ge8cUfY`92e)icq3r<~vQInCDY61Ei6PqjRZFZ_s6 zp}Mu@($U}T;i6q>B2)EdLgYsVLyY77IapUWvTTVpvFo-B)y4E#&1tQh)1zJoV}0Ki z6k?Un=2a z#oyi}79a=lr6eE@*^<`Xh`-0i*xSZ4^qbQs)n2YHKwFG`%AQ!&2FK}u+|GM~-Q9s- zTLYK#`dYH&-Q0_EKM>E$fWd8~Gi)euuZZ@jF25(tBKv7*Qew=xx<-FdIOk)kgCM>Z z?TnQmq)_x~{K0Ijyq&+geyX^R@NbXCqMV`3)w>yC05uwUcrO=!3-riGxZrg2<#&kz zc5zE*N8Rfw=Y~vho%c$_?c$qEpS?}3`7$pzbw5B&E_kTCW}zat+jR?thDaj?WjWTZ zx#r|D_@LuKp_x;z++Okpwa$oz#>Qo>{DS=Il$A%4_L8Amr}pGbkxA?OAjgY=+buNY z7_4drmcMDT4;@k#AvCEm($O>*qw21YoYd?P7F2iE*6NHHo0?Ybm@SNMeQtRK-|-T~ zCSbVC?d@pEy3oQ}+|Reu{cT=!hwZ@9)b}&NkdK0h#z8OXHl_}d8yzEQg|<#%V`_#k zzu%nB_#SJ}l9`q+xAJaO^0=GAsc;&PaAA`niIxKQr=Al7o!z&iI!1r@irVw0<$|3+ zqP0Be<+(X^xbDXENlhsS1-{#gTx83%k)kFxs19kej~MC^D>jpLGe`8+H~RApG)&^X z0c^m5_-!&ix{tT%rY*NQ`kXbTRAI1)uy0*M1K;c7T-P@p&u(bPAAHQ8F?XrVv*?v8 zk`c<*fR($}4y#c86LejWe}0U2BRi9T<5kT_jlE>vw2`!d2UANUSytxNlSell!kyQ6 zV_@$v`Wb$xT3hIGX(H%*=aaw~=HAG2j@Js(e^wN~>^DLLEA4uUW8J@{*AC%`@&|6q zQr?CwUnHSDo8hS6wzm%sWrzp;Ow8=BY5RE?)z z6m~V~_;m2vi_FH!+W2`_Ty-3>5nEsutm&{iN^4E7_P_6vD9W1~VhXYM^Hbii#Vlf6 zs-Y^ z7Z^R4Qd&^~AO#FVFuR7hsc6`uJj$vUmY2px+dqcQoq($J#5p%>yXm76o$8evyn@h` zM|bAjIaP5g(vLMjaL}q3sTcx^g+nlV)(NHOwD**$>K@E2j^0)ds=n*TB#*SXAoaq9?d}UE z1<{yn{9jLTL~Upko_7M(vtix@%VU;b&8!APW|9rBH%*LUHXs zUwXcI440Z6`*YtHICaj}VYjwgUZg*i@(n}~PQrf~YQ@s7p=_;r6zS~IVbh=Yc&EPu z&FSnVd5!Xv+p4*rwA9KrcrpC1?@q$|<`+yhxVDXLPGY4g$zrZbu)LA8RWVfTpy)Fn z>RWGcLFt1rwBCrzYJHn}mwzdjEnA2exLFx~SF+lVqd%kuc1l?&_acz%BvYI2U-vJ< zl>bKX)*ECdlI^N90YmXkyLl()+{YYc(Z3zt zV{snWH`r&lH%RrxE#1{lJj%?FBCUn3``=qw(MKe24Ze{eI!5dpGZJO);d3s{ISWNR7uq%r_O%yrL!_)C@Bl zH=4Cc?xTed`@iq9hBK}Fb-(nVqOJ5E&Tlin4qLi-evW1dWD}1wUZ6;bZ$0OCwEv(F zmBs)1O{-@~Z--mPWn@x(TZ7Cc)LZP>nCb2w>6d#^qECtK{5{O-^YXJ6^}?+DZV>fC78@ipJfCwOwBb#+Nq!U*(;7G*xZi$4@;KrMl@Z2@#b<6iOjObsVJaqx$ODk zUsu{uZ&-#lUP(H4T+^+ski*biC8=uqY;e;{n!t@Me|u_ngz5C_UZdLf=DgfcMccTU zUN;>f*$fX? zV_GII@#v{x0t&$osv+AVxoc~mssF8W{jp2 zcOCLLsao?{6PqSObq0!L`toD6j(+_4Z=Ekz#OFPp>Ift5KIr#h0l}gz)3rrgqMStw z`m}8o4Ye2((nn`5-CV@KUiq7}YJcJ0__{{)R~8|C7T0{-x0wY|t*+K#RW3Zv>Mxm9 zA9ul)9;rXOI80-vq`3`f$sE00R-{Q@FKb6hdH(Cv_BFe%4aI#DkSaP+P{^A6{Fvxh z;_ef&%Z{HE*o?+v2B2+?HFFnTTJDynVtb}!A}x(~^ihwQ#1J0RDdy%D#TO?iDH|6b z$hv&zdfIlL!zt`J9pu?=o>NZp_6RntYzuqOYl*!}L5j)PYEhfQZ4|z&0 zVB`UNi=2RnKwy!zqtWuOzsYBxSTEq~mg!j)FuHxGJ>R|bQmTyne4w@4pw4$uDpM@I zTSxbTZm;bR&Vsgx3zw?*zC6SmoX6#{n~a)oWD9@0s6eVpRRG`iomN=F*^z|4;U9rz zs6gr`(Izv73XRb@A7nkfrIlAWpSeF(M%`9U%gSNyLE*X*&(rq(k2-0${Iqk+iNEg@ zrpg@Q+}bE6o?v6(f2zI|{N)|1(4YNF3R&M`B*AN;CG=x)DNB$Y%W2!?@7BLP{IoIR zW9t$5vpxFEv5}gzZuCJ%^~A8gjRToZ9EQF7hI2TqBpy+9PkW?4voRnig+;wuK~iET z`iOZLrR(0uA%Pc-8(7#`vuILCeX3h+d zdku3qPgn=D1pbuV`1ye#hRzx+$a(CX(*q|Z#ro6*ed63iwJcWtqg7VbaLZmk-Uzw6>zoG@u) za-FvG{TAB+K1|QpNf-tS-PdYV;!zy?@#&TyUz}nV%_*UD6wj#pbwm4`@&!$?`Wg}X zrVged??i5w(7tpVYc`K`>jnw5TaRwG7~!?UchwOS)lrkcP)Q-mlTC7uHzCQDLexDS z&)E@X zJ_tS=tKzgz14p%n|4e%sCtMJh`EpQ4=Bg<3y4KwV5fwH=4evr~VZ~57i_3xG2N}sT zCodcimr!VW%w>T~sZ`)dl%HS>@OyO>cKmV z9fE)U8YGy;Q0^KT8Ff33!6oN4+aFPDIl24RrR~Q_siGOKTQud=v}D)W@TQ1vSC$?e zR#njmk;0WR;gY3rVV{zM@jmzEC@b-c1n+;4i0v-dqOBsRC3g(lagF+OHAr6k9_b;&{0J-m^Og&7I z;3<8d@_;rP|Nr3reTYzX3=PEuL0_&0zCm1K&rNovd!ji-fwpyTtW``ya+6vg8utt5 z%LLhF-mq4=Q>%5JakYSgO}v&XW;@qQSe^)0=I1dDmS7}`-Qo%osI(2pA4;sfbtSjk zx>djSmTu5%;^>ih*HgPb{;#2b&AS_`*}NyCdIAX33a7Zi^97H8@8}jAWC9)q$?{_K z9w*rt@b^$O1_5`5fY-TcCMGcjMAqvs7zN0epmc>(pfo%hkKohH^j0lf=ZCGusy2qo zhwAR@UAD?d!_V{>A}?I`((}X}KCgWIqhq5`Sxb6o9#_JdIpIVFT2hcSPrBtl!%y*> zHYn@=(0-us=6TS8A+w#q9BX3U$A{!|35FEAX$$TBYvUoK{`=2s;OHPo7+JrtTQx9z zyxjV+9ajV+6}c~He|h0Rq>Y|JJsfyHp)WNg6CfruKuajyHXlwHq(Q)K5Jv2OKO;Y5 zU&+d{F*FO8sXZu?<=o~F-d2P`X^ZRVglxn_l9_T$NxSmaf2gFi=$@TBnOJArpd2;D zL5aDT6_mq;b&U7%xsg+>qy1Y?tgh%I5dW$EU8jlSuKk5%w~SXg8BhQO1sKSPWR zvuF_k@dg<{K;UVf&uUUb=Hn?n3yUCUzTv4^(UDOa|F0L>C272|swL>(nJ+z4c}GQV zr*wRI;TGMl#T+xB$*0jG(y~kT&#m8p>8oDII|>(hSEX5l@KWoQ@ZwLeliF+!ss3^B z8#Rm)qn&sse~8g@rIoR7O$H_LP7W9OomoTVRIyY_Q^3R{?GI~7N(Wd?1Ui9scqsvX zI;A9Co1vv+mghFhVXxI;{J z+K4RuWysbP+855S*3^j0zgsl%U{&=_J{Og{F+iv?fk@OdZ*o_DXI7^p@+^QHg&hwH zIb2Xga7~O5?fKHUrff*S&_V9B*_!xMSs@3atzyF{W#hLkl)3LR@*+15@K=OZ={;V@ zN^*RS9Zq1mgarYmsWmFW^Y#e_Xl%=W{Wq=3ewh^q&AT>Nuzh3T}E-W{TWW~ynMzXxJM5h^WGW`PRN#(tCrA*$6Ja^^Te~N zd(*BKb{YBPHTV8-XBZfj&38g>3xq9Hn+toe0pJUaq&Y$!(rzf%_6^o#(2t3iQ0!Pw^kR1B^zhP zUQKh%E!n(5Zn9l>z20QeT@CU!*IUz5!J?#tn_eAv|L>B4H(jx`Q*~~9iH(o%-BUL( zNbij5xB`VW?wS>+Xn<-VOnAl+vLudS$Sx}5_ z7@lfbebqj;_3Ol(!StG*k1M^(Hm~c?>}3PDDWSe8us-f;+~n@qq`hgUvb3h2cCz}_ zB{|%-E4>+aP07%^!nikI(Ob(}{oxI1_E*QRgZ3xD>FV zk_UJd144p=GoVPJhAQmw8umvjblFl@*{jDX3cHJ_u)pfwoKCYsUIX|vxR6%T? zb?~o=F^YTZJaF|g?s9t0hwG=@(aU$oXOg@JbP-o7wJOqjKDjf~>nY9JFe7%=tM_-L zY`za=u%$i`qAQWuo_5)9<#_Pn<4E`1I9|Tav3=2lRHjjl+*V=US9~YT${T8mE!EC(Mm|$+%R#uOL^Pwek_o!-yeDz>XvK5cj z4;zO^Z+oxBGPsnRjgR+7mX31ucthMBDDvDexifA6zln$BPD#HP{mhEZLgs)=Wg?xkm|XP>1}OIpg* z5<0Up%zQ~2_69m~t0TWm&hqAe>+73|*CW&u+3XYwCGe!3on5XcBWpN@Y1D9QkIdk8 zJ%zPc!iqnHFbNsM2A6WuN|lSZ)tQ?`SU*pxKhsA@$>9>6Stdj!Vp;sU#tl*Op;f(m z#l<KzVj+uyLf?4`jOIE3h**9}df%|K3ur}@wXIYU6nBo|4g z;Juk~e;dkw(i;^L+ZV(aDZd+>1P0?pqxiqo5&Pui^u2Xs%fsf5^)Dyty_#h+5h(o{ zC<>?(xi6!j+nQ5$qTyqF z`{g-5A?6CN4u&K`{j)bANg_2ES*?_Pn*BdfHkjes(2=%=!J&@$jlEEw5!{H@bgV`J zThxnSmT=dd;*k^6@p^thsfAkX!6I(|z(C+hJ-x_|V_1V%dSaoO(!3f@V!MV5EA?5G zlfbjWr6VK9;RqK${}Pf|q>GOVU*7L8IDvYE;Kqk=#)GIn2hW+)u#FmK2BeIe|6YMm z@~-efR07ONb;}ApSa*P_54n5S-lGo{*u$wcuogvS9x~R{qyj_$j#4{wno6ZYw_xNw z+n;g&9!_)xL&kqi(n-|i1($?u;)Sk>HCj~SHJCLK$K?MUe^|4y3Pu#V5&JwOf6mNh zT)Wa^vqz0P9)^b_Ek#pT7oN1|Zk&)fvA%hdwt_T>AHrf34q~*f?sK|}WrX#rm z7I=sc#rOxt-BB%sfkBn02T>5=sueQQZ<<;3&XfAA0>9B>t%G+ita@`{@MD(&%X#9~ zdJTy!q<9PX5GNrItjoVv7cFy6eo9jxnoR1eVHY7GA&;YcQMIjaOxZa1%{0gT(!?vO z6xK#`AaB%$9T&y=)|s-;LZ$`M#K7b%ISC>s`vUqGN8lEB%gGTLN9e&x9V=FlYUyC3 z!13KaoxkwMKS&Lg#G{p(nu=T_&b!xlSdPt^Z) z0$wPXj7Ud`DJXb@7=kRdXH~ryi>~&A**D_m37!=Z4Iv%Xa(6B1O3knfg-o9DDmPyE zx)pv!8xJJ_4k01xP~alPzX1L39QeS=$wHEn6Sj)k`Zx{DX3D#8&3SD`JO@matgMCs z%vplLHtFq|;ab03fNK z4ln0tkjnvPEa~d5e2qnM7lLF9V`9{66LmSHzg#D1$@+?bPnfZ(c!N+$qcoozfaNg4 z(CtY8+CfN3hR*kZw(91bl`?dfoi5)oG8%b}D~DD&V{!lp2-WT&>6MJI4y%-;+Ei3N)Mn-M4%p_dw-#+Cesy1Q-JTrSK z7Ew?mMmQzDz?(gD=1i0j+j{$L8`dF*h(^ivN&Uu>mYUij{yXXOg79ufd|=R26Z}F+ z3mR_7%-mf05;&V^A;4LzFRy}#y8pp!JI!c*{*oF#R##V7L9+u~)DFvELAv`mEfVwd z^Us>EAl1Deb^&8VmEb$TFYkie!`sCKBPhzF*uxI70YEv4@Q{4(#d}FA(mfoQ-yg`_ zJRl6OJIA<3S?#E6Nf!OiI9Vfw4qjVVm&qRrFe91;vP>b4>v*OZ zaa&kOtBM@wFV#u;9}|$2JWuvgh@&&@WlzPt{h}@nscDDoHd4H@cG?tx$ujhAP{I}- zoKxTk14K>OX3I*_jp&IFrN4f6-$`7H4y)hs#dUii89n zN7=GLsLeyrSzQo*3Av~fZ}&I@Kx;3wK9PORO}s>ed8V2}q+LMivVcc4ktw-?B>v>R z*`0s@c9dU9#DINWL*WVhs;R$58*YW48vxHqWgoxpbxjEtCM_# z4qDc5S%@?y$JKyOG(FlSDoBeqW&UIJPF>8&qy zd;OY<9z{fxKq&0k1_Lvn=ZFLcn9d$B@M>XhRCs_hs6V1&;aNcGbcfA`xWS3}MPfmQ zSpGN@C4Dx-Jwpw1p_V!l2M5mN@nZbiA_>f&x2tIWRxs5u(!4(jdu5NN6x0lYFIO-N6Eg^MZ-= zd{J7(3%LHP#Y@tm14h_H#Uj%I>{LRDd9C~UWt2sNL=I7pQ`L4m9vNR@|6@sog){hx zgGcTJ0{eaf?cBEi2C7kMlur8DCV$i;#7+V1mV$1Npw*~Ro=4}h2mXl{krc4tDA#WJ z!T1WS_B`G>n`eUUZXf3|Fc5D;1v37cg&#pTXHuFiE?ufY*9Pvz?l7D2N+r)c6p651 zgHtq!@fv;#v=z6^)jnu@LDK3#-&f2btm}-{Z6TFQ3-wF3U$XK1W6VxBDw9=I?6J;+ zUbGfke2i3fk814mVV1x9ccOC*{g2i^EjofM$SBL Ga^qj|%WaMT literal 0 HcmV?d00001 diff --git a/previews/PR184/mtk_integration/index.html b/previews/PR184/mtk_integration/index.html new file mode 100644 index 00000000..384f03e5 --- /dev/null +++ b/previews/PR184/mtk_integration/index.html @@ -0,0 +1,84 @@ + +ModelingToolkit Integration · NetworkDynamics

ModelingToolkit Integration

NetworkDynamics.jl is compatible with ModelingTookit.jl (MTK). The general idea is to use MTK to define component models (i.e. edge and vertex dynamics) which are then connected on network scale using NetworkDynamics.

The main entry point for this interop are the constructors

VertexModel(::ODESystem, inputs, outputs)
+EdgeModel(::ODESystem, srcin, dstin, [srscout], dstout)

whose docstrings can be found in the Component Models with MTK section in the API.

These constructors will:

  • transforming the states marked as input to parameters and structural_simplifying the system,
  • generating the f and g functions,
  • generate code for observables,
  • port all supported Metadata from MTK symbols to component symbols and
  • output a Vertex-/EdgeModel function compatible with NetworkDynamics.jl.

The main usecase for this feature is when you want to build relatively complex component models but interconnect them in a very homogeneous way (i.e. having the same output/input pairings in the whole system).

In theory, you can achieve everything you want to do with plain MTK. The idea of combining the two is, that NetworkDynamics offers far less flexibility when in comes to interconnection of subsystems on the network level. This might allow ND to exploit more knowledge of the structure without very expensive operations such as tearing of thousands of equations.

Warning

ModelingToolkit is a fast paced library with lots of functionality and ever growing complexity. As such the provided interface is kinda experimental. Some features of MTK are straight up unsupported, for example events within models or delay differential equations.

RC-Circuit Example

In good MTK tradition, this feature will be explained along a simple RC circuit example. The Dynamic Flow in simple Gas Network example is another showcase of the MTK constructors.

The system to model is 2 node, 1 edge network. The node output states are the voltage (to ground), the edge output sates are the currents at both ends.


+ideal v source      Resistor     Capacitor
+            v1 o─←────MMM────→─o v2
+               │               ┴ 
+              (↗)              ┬
+               │               │
+               ⏚               ⏚

Obviously there is no need in modeling such a small system using NetworkDynamics, however the method extends quite easily to construct large electrical networks reusing the same fundamental building blocks.

using NetworkDynamics
+using ModelingToolkit
+using ModelingToolkit: t_nounits as t, D_nounits as D
+using OrdinaryDiffEqTsit5
+using CairoMakie

All our components have "terminals", which have a voltage and current. We don't use the @connector from MTK here because our pins mark the interface towards the network and do not follow the MTK connector semantics.

@mtkmodel NWTerminal begin
+    @variables begin
+        v(t), [description="Voltage at node"]
+        i(t), [description="Current flowing into node"]
+    end
+end

An ideal voltage source is just a model which pins its output voltage to a fixed parameter. The source ejects whatever current is necessary. We introduce another variable i(t) to "capture" this current. This variable will be removed during structural simplify, but will be available for plotting through the Observables mechanism. The VertexModel can be generated from an ODESystem by providing names of the input and output states:

@mtkmodel VoltageSource begin
+    @components begin
+       p = NWTerminal()
+    end
+    @parameters begin
+        V = 1.0
+    end
+    @variables begin
+        i(t), [description="produced current by ideal voltage source (observable)"]
+    end
+    @equations begin
+        i ~ -p.i
+        p.v ~ V
+    end
+end
+@named vs = VoltageSource()
+vs_vertex = VertexModel(vs, [:p₊i], [:p₊v]; vidx=1)
VertexModel :vs NoFeedForward() @ Vertex 1
+ ├─ 1 input:  [p₊i]
+ ├─ 0 states: []
+ ├─ 1 output: [p₊v]
+ └─ 1 param:  [V=1]

A capacitor is a slightly more complicated model. Its voltage is defined as an differential equation based on the inflowing current.

@mtkmodel Capacitor begin
+    @components begin
+        p = NWTerminal(;v=0)
+    end
+    @parameters begin
+        C = 1.0
+    end
+    @equations begin
+        D(p.v) ~ p.i / C
+    end
+end
+@named cap = Capacitor()
+cap_vertex = VertexModel(cap, [:p₊i], [:p₊v], vidx=2)
VertexModel :cap PureStateMap() @ Vertex 2
+ ├─ 1 input:  [p₊i]
+ ├─ 1 state:  [p₊v=0]
+ ├─ 1 output: [p₊v=0]
+ └─ 1 param:  [C=1]

For the resistor we need two pins, one for the src and one for the dst side. The equations are straight forward.

@mtkmodel Resistor begin
+    @components begin
+        src = NWTerminal()
+        dst = NWTerminal()
+    end
+    @parameters begin
+        R = 1.0
+    end
+    @equations begin
+        dst.i ~ (src.v - dst.v)/R
+        src.i ~ -dst.i
+    end
+end
+@named resistor = Resistor()
+resistor_edge = EdgeModel(resistor, [:src₊v], [:dst₊v], [:src₊i], [:dst₊i]; src=:vs, dst=:cap)
EdgeModel :resistor PureFeedForward() @ Edge vs=>cap
+ ├─ 1/1 inputs:  src=[src₊v] dst=[dst₊v]
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[src₊i] dst=[dst₊i]
+ └─   1 param:   [R=1]

Having all those components defined, we can build the network. We don't need to provide a graph object here because we specified the placement in the graph on a per component basis.

nw = Network([vs_vertex, cap_vertex], [resistor_edge])
Network with 1 state and 3 parameters
+ ├─ 2 vertices (2 unique types)
+ └─ 1 edges (1 unique type)
+Edge-Aggregation using SequentialAggregator(+)

We can see, that NetworkDynamics internally is able to reduce all of the "output" states. We end up with a plain ODE of a single state.

Now we can simulate the system. For that we generate the u0 object. Since the metadata (such as default values) was automatically transferred, we can straight away construct the ODEProblem and solve the system.

u0 = NWState(nw) # generate state based on default values
+prob = ODEProblem(nw, uflat(u0), (0, 10.0), pflat(u0))
+sol = solve(prob, Tsit5())
+
+# plot the solution
+fig, ax1, p = plot(sol; idxs=VIndex(:cap, :p₊v), label="Capacitor Voltage");
+axislegend(ax1)
+ax2 = Axis(fig[2,1])
+plot!(ax2, sol; idxs=VIndex(:vs, :i), label="Current produced by ideal v source")
+axislegend(ax2)
Example block output
diff --git a/previews/PR184/network_construction/index.html b/previews/PR184/network_construction/index.html new file mode 100644 index 00000000..6ac728da --- /dev/null +++ b/previews/PR184/network_construction/index.html @@ -0,0 +1,61 @@ + +Network Construction · NetworkDynamics

Network Construction

Building a Network

The main type of NetworkDyanmics.jl is a Network. A network bundles various component models (edge and vertex models) together with a graph to form a callable object which represents the RHS of the overall dynamical system, see Mathematical Model.

A Network is build by passing a graph g, vertex models vertexm and edge models edgem.

nw = Network(g, vertexm, edgem; kwargs...)

Two important keywords for the Network constructor are:

  • execution: Defines the ExecutionStyle of the coreloop, e.g. SequentialExecution{true}(). A execution style is a special struct which tells the backend how to parallelize for example. A list of available executions styles can be found under Execution Types in the API.

  • aggregator: Tells the backend how to aggregate and which aggregation function to use. Aggregation is the process of creating a single vertex input by reducing over the outputs of adjecent edges of said vertex. The aggregator contains both the function and the algorith. E.g. SequentialAggregator(+) is a sequential aggregation by summation. A list of availabe Aggregators can be found under Aggregators in the API.

Building VertexModels

This chapter walks through the most important aspects when defining custom vertex model. For a list of all keyword arguments please check out the docstring of VertexModel. As an example, we'll construct an second order kuramoto model, because that's what we do.

function kuramoto_f!(dv, v, esum, p, t)
+    M, P, D = p
+    dv[1] = v[2]
+    dv[2] = (P - D*v[2] + esum[1])/M
+    nothing
+end
+function kuramoto_g!(y, v, esum, p, t)
+    y[1] = v[1]
+    nothing
+end
+VertexModel(; f=kuramoto_f!, g=kuramoto_g!, dim=2, pdim=3, outdim=1)
VertexModel :VertexM FeedForward()
+ ├─ 2 states: [v₁, v₂]
+ ├─ 1 output: [o]
+ └─ 3 params: [p₁, p₂, p₃]

Those keywords are the minimum metadata we need to provide.

However there is a problem: the vertex is classified as a FeedForward vertex, which is unnecessary. We can improve the implementation of g according to the Feed Forward Behavior section.

function kuramoto_g_noff!(y, v, p, t)
+    y[1] = v[1]
+    nothing
+end
+VertexModel(; f=kuramoto_f!, g=kuramoto_g_noff!, dim=2, pdim=3, outdim=1)
VertexModel :VertexM NoFeedForward()
+ ├─ 2 states: [v₁, v₂]
+ ├─ 1 output: [o]
+ └─ 3 params: [p₁, p₂, p₃]

It is still annoying to explicitly write this trivial output function. You can prevent this by using StateMask. By writing

VertexModel(; f=kuramoto_f!, g=StateMask(1:1), dim=2, pdim=3)
VertexModel :VertexM PureStateMap()
+ ├─ 2 states: [v₁, v₂]
+ ├─ 1 output: [v₁]
+ └─ 3 params: [p₁, p₂, p₃]

we told the vertex model, that the output is part of the states x[1:1]. This enables a few things:

  • outdim is not needed anymore, can be inferred from StateMask
  • outsym is not a generic :o any more but inferred from the state symbols.

We can be even less verbose by writing g=1:1 or just g=1.

In a last we define better names for our states and parameters as well as assigning a position in the graph to enable the graphless network construction. Whenever you provide sym keyword the corresponding dim keyword is not neccessary anymore. We end up with a relatively short definition

VertexModel(; f=kuramoto_f!, g=1,
+              sym=[:θ, :ω], psym=[:M=>1, :P=>0.1, :D=>0],
+              insym=[:P_nw], name=:swing, vidx=1)
VertexModel :swing PureStateMap() @ Vertex 1
+ ├─ 1 input:  [P_nw]
+ ├─ 2 states: [θ, ω]
+ ├─ 1 output: [θ]
+ └─ 3 params: [M=1, P=0.1, D=0]

Building EdgeModels

This chapter walks through the most important aspects when defining custom edge models. For a list of all keyword arguments please check out the docstring of EdgeModel.

As an example edge model we want to define standard sinusoidal coupling between the vertices in our network. The full definition looks like this:

function edge_f!(de, e, vsrc, vdst, p, t)
+    nothing
+end
+function edge_g!(ysrc, ydst, e, vsrc, vdst, p, t)
+    ydst[1] = p[1] * sin(vsrc[1] - vdst[1])
+    ysrc[1] = -ydst[1]
+end
+EdgeModel(; f=edge_f!, g=edge_g!, dim=0, pdim=1, outdim=1)
EdgeModel :StaticEdgeM FeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[src₊o] dst=[dst₊o]
+ └─   1 param:   [p] 

This is a purely "static" edge without internal states. This means we can omit f and dim entirely. Also, we can define a variant of g without the e input

function edge_g_ff!(ysrc, ydst, vsrc, vdst, p, t)
+    ydst[1] = p[1] * sin(vsrc[1] - vdst[1])
+    ysrc[1] = -ydst[1]
+end
+EdgeModel(;g=edge_g_ff!, pdim=1, outdim=1)
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[src₊o] dst=[dst₊o]
+ └─   1 param:   [p] 

which no classifies as a PureFeedForward edge. In cases like this, where the edge is actually anti symmetric we can alternatively define a single sided output function and wrapping it in an AntiSymmetric object

function edge_g_s!(ydst, vsrc, vdst, p, t)
+    ydst[1] = p[1] * sin(vsrc[1] - vdst[1])
+end
+EdgeModel(;g=AntiSymmetric(edge_g_ff!), pdim=1, outdim=1)
EdgeModel :StaticEdgeM FeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[₋o] dst=[o]
+ └─   1 param:   [p] 

which can also lead to briefer output naming. Available single sided wrappers are

Once again we can add additonal data like defining a src and dst index

function edge_g_s!(ydst, vsrc, vdst, p, t)
+    ydst[1] = p[1] * sin(vsrc[1] - vdst[1])
+end
+EdgeModel(;g=AntiSymmetric(edge_g_ff!), psym=:K=>1, outsym=:P, insym=:θ, src=1, dst=4)
EdgeModel :StaticEdgeM FeedForward() @ Edge 1=>4
+ ├─ 1/1 inputs:  src=[src₊θ] dst=[dst₊θ]
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[₋P] dst=[P]
+ └─   1 param:   [K=1]
diff --git a/previews/PR184/objects.inv b/previews/PR184/objects.inv new file mode 100644 index 0000000000000000000000000000000000000000..86279a8c378ffcdf3d14ee5ba439855637ad0338 GIT binary patch literal 2695 zcmV;23V8J+AX9K?X>NERX>N99Zgg*Qc_4OWa&u{KZXhxWBOp+6Z)#;@bUGkTWpsCM za%)6+ZeeX{V{-~4AXa5^b7^mGIv_AEIW95^BOp|0Wgv28ZDDC{WMy(7Z)PBLXlZjG zW@&6?AZc?TV{dJ6a%FRKWn>_Ab7^j8AbMo&NW;xRDSEN}!Z!UlNJj{dTd~yUdD=z9J#B zcNtF+{t2NEw4fEqlP!@O3jeT_uXGuZj3$MN|QeFsI)v08> z@L@vlC+NXEMOWU_MC`Upp0jkpl*+7F`#8Oq6Ew4r(5-!xY^fv}k!0^2_8DkzKP9YS zl98PKNxItZznK8C|2^5tuOMI2b=BkSyqXyEfKqeL^RG+-RP!>qe7yB};p;^GldSd4 zNSaO7R7zl82uUjVzIb7Bvv9V|b_Ln8RQMPpStsBHnhebhnI}7A6-^ZoI^eJ@lzsF zk}1oq2+Qk=hQWJe6LjSsp{aS~p@RETAr`z?fFFwi`*euFb@c-TE;LsU{EH{TUDm+$ zwghmAM7UT=W}skB@r-3O!#CNQ;?K1#YiV@K$r9o_9M|8!L53M=W~7*rWlpa6w&VpZ zB-S1+u<|E-KmW83t9%%68fxSJ0x4<))QMFSUv(2j0})IWfEi2{^9{w80ZU%;oUeD7 z;AKTvfr-pX=h%_X3gQ6Sse&9b!iXS^jWl-h0H?DC8It2)lsW|vTcae#ws=|>`Y`w- z%}ZK|$rC7{J_JlVz;f|++AtXsKx!f*5|Hmy8Q7=J}4t9-GX!{2sMJh(5NpcdD_s5f>YxqU9;l1eZk-FzrFZ* ziu4n3Rb=RsCSBpFm*@hj_fwsU;9jx=Q#~s*W%0u|dMvaolD+_Yol^?gYRan@Qf2r( z-H>O-tC)uQW}b+H+zkPB1&|&3`KKTw9bz-yVLw668+-mOJqoqB~|gHNRcB&PLVds3Et}-jyQC% z)9_=Npgj`j)yBi{z2A?vPUSk%#ueMv^n(?R4?A+d8wM=L+xKs;h9A|)tKd$l_chBi zW4s5iH918E7if;O$LxGh^)>!r%N*cIuf;)OMUiAjn#^_CQ-=Q_0{`0|h$LZR|^oT{s~tj>2O1&M@p1Jk-6ZZm^%+>oOmO%6UQw5UY} zp;o}v>J&IG1A5%ZayL2fk(IW_M@EKXuuG24ERSzHJAgK-J6iy+RD|{b-PtN?q}uCo z+C9l(%k+08`UAG7=fRodjiE*@k-ndvMC}T0zBBpVWaA*Fb8nNE4PpOGgE_Bv5}o{@ zIeCWJ)s{_&&ux^$STX|I_DC^W8N}e^ITBVB0dM_yZ9mJ;?$g1*Ccu1GKl5`>$jJc^xOeU*RiOr8QKP zn^&S)k5!YF1zDD)jiU`%EkDD$ZIC&nHq6w_ds2CC8Ixv1s|K&q2^(x@hK4U62DLEB z-U1kB!4_u(x}N783gm~n)B|KibMk7sU@lUoI?!G|jW@Z2MJ+7yU_0Bj#+GMirTs-) zgWHkkwPxQ~qK6!qP6s2pKb-1-p1*K>&7kp9-7*x(n^$Q*pI@|JIP#EDgPaVhh?C

e4iKtG(g}+mro(E{omYN)GUEc;=)Wl5p|%CnMwH*Y}5|T)e%y zc>5nC$$SQB7r$N)96_6#f>DA0yU^K>F@a_QXfWiyO(M?Q@U&+P>%Ad@70|xLUezPd zcNCIg)pm=DRYLD}h^_9Wnd=Jx`9f$cvLN9#br0UNOPj`|;hr>|F#NMny)_AX+; zZ6Xd)1}x$}O`<|3B(0nOIpsTa0!X8WC*)K(&wfW1AXqPg3 z2;)w1d1sFYTxc+I!;-gHdc9MM~?Apg3XV*bnjtQ{`?gd$Fz8ZH~N}UA^{4A@XD?TYG z$L9F`;5?e&pU2cs-6W0dXO#(}n?OYzZvJNUe>J!QBYC?hi@36VTh3B;fA^jU`s4MD zTQKue%o+wd&=J>Ei1=1mQHRa&>2lQZn=W+}*Uh6@Xh)EG18RJC)MFa#k46UQDCeB% za#^u7>YULQ5#*UJ+I36ZrSJ2Eul}6j@ZT8{g9D?Env|EjQ%8snz=?B1IcDNW@h$&O-yC!PKuIrm7rMMO8+fRALWI%Q0nv*K$PP_B;x^TMYHLlM12!9=7F8baapF zyDp(%jY=~I)&qY)dZ^Za=>@?re}9YpfI+k!yngZvm?vx@|4&F_(q()FIk}Dh2io_b zDf%TZu*5mB3Le_v3^o^b#)@t)Ed6kmF+FZHo*@szsiAsg5!cD;gss5I^U6Osw;Xk@ zu>-taScs@)NPmHJMnl}+C5>r{n?KT|i`1Db%HcwcVb@!?t{!X6)oLNR{f&-{7?oEm zX?HXuN?Oc~eZx)bxr^4O_nFCE9;JNW-C`F^ecu{PfNM7|MMq3CNFJ``{|BhXEFpaG BGZFv* literal 0 HcmV?d00001 diff --git a/previews/PR184/search_index.js b/previews/PR184/search_index.js new file mode 100644 index 00000000..f60c051c --- /dev/null +++ b/previews/PR184/search_index.js @@ -0,0 +1,3 @@ +var documenterSearchIndex = {"docs": +[{"location":"mtk_integration/#ModelingToolkit-Integration","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"","category":"section"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"NetworkDynamics.jl is compatible with ModelingTookit.jl (MTK). The general idea is to use MTK to define component models (i.e. edge and vertex dynamics) which are then connected on network scale using NetworkDynamics.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"The main entry point for this interop are the constructors","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"VertexModel(::ODESystem, inputs, outputs)\nEdgeModel(::ODESystem, srcin, dstin, [srscout], dstout)","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"whose docstrings can be found in the Component Models with MTK section in the API.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"These constructors will:","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"transforming the states marked as input to parameters and structural_simplifying the system,\ngenerating the f and g functions,\ngenerate code for observables,\nport all supported Metadata from MTK symbols to component symbols and\noutput a Vertex-/EdgeModel function compatible with NetworkDynamics.jl.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"The main usecase for this feature is when you want to build relatively complex component models but interconnect them in a very homogeneous way (i.e. having the same output/input pairings in the whole system).","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"In theory, you can achieve everything you want to do with plain MTK. The idea of combining the two is, that NetworkDynamics offers far less flexibility when in comes to interconnection of subsystems on the network level. This might allow ND to exploit more knowledge of the structure without very expensive operations such as tearing of thousands of equations.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"warning: Warning\nModelingToolkit is a fast paced library with lots of functionality and ever growing complexity. As such the provided interface is kinda experimental. Some features of MTK are straight up unsupported, for example events within models or delay differential equations.","category":"page"},{"location":"mtk_integration/#RC-Circuit-Example","page":"ModelingToolkit Integration","title":"RC-Circuit Example","text":"","category":"section"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"In good MTK tradition, this feature will be explained along a simple RC circuit example. The Dynamic Flow in simple Gas Network example is another showcase of the MTK constructors.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"The system to model is 2 node, 1 edge network. The node output states are the voltage (to ground), the edge output sates are the currents at both ends.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"\nideal v source Resistor Capacitor\n v1 o─←────MMM────→─o v2\n │ ┴ \n (↗) ┬\n │ │\n ⏚ ⏚","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"Obviously there is no need in modeling such a small system using NetworkDynamics, however the method extends quite easily to construct large electrical networks reusing the same fundamental building blocks.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"using NetworkDynamics\nusing ModelingToolkit\nusing ModelingToolkit: t_nounits as t, D_nounits as D\nusing OrdinaryDiffEqTsit5\nusing CairoMakie","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"All our components have \"terminals\", which have a voltage and current. We don't use the @connector from MTK here because our pins mark the interface towards the network and do not follow the MTK connector semantics.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"@mtkmodel NWTerminal begin\n @variables begin\n v(t), [description=\"Voltage at node\"]\n i(t), [description=\"Current flowing into node\"]\n end\nend\nnothing #hide","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"An ideal voltage source is just a model which pins its output voltage to a fixed parameter. The source ejects whatever current is necessary. We introduce another variable i(t) to \"capture\" this current. This variable will be removed during structural simplify, but will be available for plotting through the Observables mechanism. The VertexModel can be generated from an ODESystem by providing names of the input and output states:","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"@mtkmodel VoltageSource begin\n @components begin\n p = NWTerminal()\n end\n @parameters begin\n V = 1.0\n end\n @variables begin\n i(t), [description=\"produced current by ideal voltage source (observable)\"]\n end\n @equations begin\n i ~ -p.i\n p.v ~ V\n end\nend\n@named vs = VoltageSource()\nvs_vertex = VertexModel(vs, [:p₊i], [:p₊v]; vidx=1)","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"A capacitor is a slightly more complicated model. Its voltage is defined as an differential equation based on the inflowing current.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"@mtkmodel Capacitor begin\n @components begin\n p = NWTerminal(;v=0)\n end\n @parameters begin\n C = 1.0\n end\n @equations begin\n D(p.v) ~ p.i / C\n end\nend\n@named cap = Capacitor()\ncap_vertex = VertexModel(cap, [:p₊i], [:p₊v], vidx=2)","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"For the resistor we need two pins, one for the src and one for the dst side. The equations are straight forward.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"@mtkmodel Resistor begin\n @components begin\n src = NWTerminal()\n dst = NWTerminal()\n end\n @parameters begin\n R = 1.0\n end\n @equations begin\n dst.i ~ (src.v - dst.v)/R\n src.i ~ -dst.i\n end\nend\n@named resistor = Resistor()\nresistor_edge = EdgeModel(resistor, [:src₊v], [:dst₊v], [:src₊i], [:dst₊i]; src=:vs, dst=:cap)","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"Having all those components defined, we can build the network. We don't need to provide a graph object here because we specified the placement in the graph on a per component basis.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"nw = Network([vs_vertex, cap_vertex], [resistor_edge])","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"We can see, that NetworkDynamics internally is able to reduce all of the \"output\" states. We end up with a plain ODE of a single state.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"Now we can simulate the system. For that we generate the u0 object. Since the metadata (such as default values) was automatically transferred, we can straight away construct the ODEProblem and solve the system.","category":"page"},{"location":"mtk_integration/","page":"ModelingToolkit Integration","title":"ModelingToolkit Integration","text":"u0 = NWState(nw) # generate state based on default values\nprob = ODEProblem(nw, uflat(u0), (0, 10.0), pflat(u0))\nsol = solve(prob, Tsit5())\n\n# plot the solution\nfig, ax1, p = plot(sol; idxs=VIndex(:cap, :p₊v), label=\"Capacitor Voltage\");\naxislegend(ax1)\nax2 = Axis(fig[2,1])\nplot!(ax2, sol; idxs=VIndex(:vs, :i), label=\"Current produced by ideal v source\")\naxislegend(ax2)\nfig # hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"EditURL = \"../../examples/getting_started_with_network_dynamics.jl\"","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Getting-Started","page":"Getting Started","title":"Network Diffusion","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"This introductory example explains the use of the basic types and constructors in NetworkDynamics.jl by modeling a simple diffusion on an undirected network.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"This example can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Theoretical-background","page":"Getting Started","title":"Theoretical background","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Diffusion processes are relevant for phenomena as diverse as heat conduction, electrical currents, and random walks. Generally speaking they describe the tendency of systems to evolve towards a state of equally distributed heat, charge or concentration. In such system the local temperature (or concentration) changes according to its difference with its neighborhood, i.e. the temperature gradient.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Let g be a graph with N nodes and adjacency matrix A. Let v = (v_1 dots v_n) be a vector of (abstract) temperatures or concentrations at each node i = 1 dots N. Then the rate of change of state v_i is described by its difference with its neighbors and we obtain the following ordinary differential equation","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"dot v_i = sum_j=1^N A_ji (v_j - v_i)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The sum on the right hand side plays the role of a (discrete) gradient. If the temperature at node i is higher than at its neighboring node j it will decrease along that edge.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Modeling-diffusion-in-NetworkDynamics.jl","page":"Getting Started","title":"Modeling diffusion in NetworkDynamics.jl","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"We begin by loading the necessary packages.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"using Graphs\nusing NetworkDynamics\nusing OrdinaryDiffEqTsit5\nusing StableRNGs\nusing Plots\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"From the above considerations we see that in this model the nodes do not have any internal dynamics - if a node was disconnected from the rest of the network its state would never change, since then A_ji = 0 forall j and hence dot v_i = 0. This means that the evolution of a node depends only on the interaction with its neighbors. In NetworkDynamics.jl, interactions with neighbors are described by equations for the edges.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"In order to bring this equation into the form required by NetworkDynamics.jl we need split the dynamics into edge and vertex parts and bring them into the correct input-output formulation. The vertices have one internal state v which is also the output. The input is the sum over all flows of connected edges. This directly correspons to the component model definition outlined in Mathematical Model:","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"beginaligned\ndot x^mathrmv = f^mathrm v(u^mathrm v sum_k^textincident y^mathrm e_k p^mathrm v t) = sum_k^mathrmincident y^mathrme_k \ny^mathrmv = g^mathrm v(u^mathrm v sum_k^textincident y^mathrm e_k p^mathrm v t) = x^mathrmv\nendaligned","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The edge dynamics on the other hand do not have any internal states. Thus we only define the output as the difference between the source and destination vertex:","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"beginaligned\ny^mathrm e_mathrmdst = g_mathrmdst^mathrm e(u^mathrm e y^mathrm v_mathrmsrc y^mathrm v_mathrmdst p^mathrm e t) = y^mathrm v_mathrmsrc - y^mathrm v_mathrmdst\ny^mathrm e_mathrmsrc = g_mathrmsrc^mathrm e(u^mathrm e y^mathrm v_mathrmsrc y^mathrm v_mathrmdst p^mathrm e t) = y^mathrm v_mathrmdst - y^mathrm v_mathrmsrc\nendaligned","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Definition-of-EdgeModel","page":"Getting Started","title":"Definition of EdgeModel","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"function diffusionedge_g!(e_dst, v_src, v_dst, p, t)\n # e_dst, v_src, v_dst are arrays, hence we use the broadcasting operator\n e_dst .= v_src .- v_dst\n nothing\nend\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The function diffusionedge_g! takes as inputs the current state of the edge e, its source vertex v_src, its destination vertex v_dst, a vector of parameters p and the time t. In order to comply with the syntax of NetworkDynamics.jl we always have to define functions for edges with exactly these arguments, even though we do not need p and t for the diffusion example.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"diffusionedge_g! is called a mutating function, since it modifies (or mutates) one of its inputs, namely the edge state e. As a convention in Julia names of mutating functions end with an !. The use of mutating functions reduces allocations and thereby speeds up computations. After the function call the edge's output value e equals the difference between its source and its destination vertex (i.e. the discrete gradient along that edge).","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Notably, this function only models g_mathrmdst. However we can wrap this single-sided output function in an AntiSymmetric output wrapper to construct the EdgeModel:","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"nd_diffusion_edge = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow])","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Definition-of-VertexModel","page":"Getting Started","title":"Definition of VertexModel","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"For undirected graphs, the edgefunction! specifies the coupling from a source- to a destination vertex. The contributions of the connected edges to a single vertex are \"aggregated\". Default aggregation is the summation of all incident edge states. The aggregated edge state is made available via the esum argument of the vertex function.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"function diffusionvertex_f!(dv, v, esum, p, t)\n # dv, v and esum are arrays, hence we use the broadcasting operator .\n dv .= esum\n nothing\nend\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Just like above the input arguments v, esum, p, t are mandatory for the syntax of vertex functions. The additional input dv corresponding to the derivative of the vertex' state is mandatory for vertices described by ordinary differential equations.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The output function g is just taking part of the internal states. For that we can use the StateMask helper function g = StateMaks(1:1)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"nd_diffusion_vertex = VertexModel(; f=diffusionvertex_f!, g=StateMask(1:1), dim=1)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Constructing-the-network","page":"Getting Started","title":"Constructing the network","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"With the components defined, we can define the topology and assemble the network dynamics.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"N = 20 # number of nodes\nk = 4 # average degree\ng = barabasi_albert(N, k) # a little more exciting than a bare random graph\n\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The Barabási–Albert model generates a scale-free random graph.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"nd = Network(g, nd_diffusion_vertex, nd_diffusion_edge)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The constructor Network combines the component model with the topological information contained in the graph g and returns an Network compatible with the solvers of DifferentialEquations.jl.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"rng = StableRNG(1)\nx0 = randn(rng, N) # random initial conditions\node_prob = ODEProblem(nd, x0, (0.0, 2.0))\nsol = solve(ode_prob, Tsit5());\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"We are solving the diffusion problem on the time interval 0 2 with the Tsit5() algorithm, which is recommended by the authors of DifferentialEquations.jl for most non-stiff problems.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"plot(sol; idxs=vidxs(nd, :, :), fmt=:png)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The plotting is straightforward. The idxs keyword allows us to pass a list of indices. Indices can be also \"symbolic\" indices which specify components and their symbols directly. For example idxs = VIndex(1, :v) acesses state :v of vertex 1. See Symbolic Indexing for more details.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"In oder to collect multiple indices we can use the helper function vidxs and eidxs, which help to collect all symbolic indices matching a certain criteria.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Two-Dimensional-Extension","page":"Getting Started","title":"Two Dimensional Extension","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"To illustrate a very simple multi-dimensional case, in the following we simulate two independent diffusions on an identical graph. The first uses the symbol x and is started with initial conditions drawn from the standard normal distribution N(01), the second uses the symbol ϕ with squared standard normal inital conditions.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The symbols have to be passed with the keyword sym to VertexModel.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"N = 10 # number of nodes\nk = 4 # average degree\ng = barabasi_albert(N, k) # a little more exciting than a bare random graph\n\n# We will have two independent diffusions on the network, hence dim = 2\nnd_diffusion_vertex_2 = VertexModel(; f=diffusionvertex_f!, g=1:2, dim=2, sym=[:x, :ϕ])\nnd_diffusion_edge_2 = EdgeModel(; g=AntiSymmetric(diffusionedge_g!), outsym=[:flow_x, :flow_ϕ])\nnd_2 = Network(g, nd_diffusion_vertex_2, nd_diffusion_edge_2)\n\nx0_2 = vec(transpose([randn(rng, N) .^ 2 randn(rng, N)])) # x ~ N(0,1)^2; ϕ ~ N(0,1)\node_prob_2 = ODEProblem(nd_2, x0_2, (0.0, 3.0))\nsol_2 = solve(ode_prob_2, Tsit5());\nnothing #hide","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Try plotting the variables ϕ_i yourself. [To write ϕ type \\phi and press TAB]","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"plot(sol_2; idxs=vidxs(nd_2, :, :x), fmt=:png)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"Using the eidxs helper function we can also plot the flow variables","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"plot(sol_2; idxs=eidxs(nd_2, :, :flow_x), fmt=:png)","category":"page"},{"location":"generated/getting_started_with_network_dynamics/#Appendix:-The-network-Laplacian-L","page":"Getting Started","title":"Appendix: The network Laplacian L","text":"","category":"section"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"The diffusion equation on a network can be rewritten as","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"dot v_i = sum_j=1^N A_ji v_j - d_i v_i = e_i^T A v - d_i v_i","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"where d_i is the degree of node i and e_i^T is the i-th standard basis vector. Introducing the diagonal matrix D that has the degree of node i in its i-th row and the Laplacian matrix L = D - A we arrive at","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"dot v = e_i^T(A - D) v","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"and finally","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"dot v = - L v","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"This is a linear system of ODEs and its solution is a matrix exponential. To study the asymptotic behaviour of the system it suffices to analyze the eigenspectrum of L. For this reason L is an important construction in network science.","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"","category":"page"},{"location":"generated/getting_started_with_network_dynamics/","page":"Getting Started","title":"Getting Started","text":"This page was generated using Literate.jl.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"EditURL = \"../../examples/stress_on_truss.jl\"","category":"page"},{"location":"generated/stress_on_truss/#Stress-on-Truss","page":"Stress on Truss","title":"Stress on Truss","text":"","category":"section"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"In this exampe we'll simulate the time evolution of a truss structure consisting of joints and stiff springs. This example can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"(Image: truss animation)","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"The mathematical model is quite simple: the vertices are point masses with positions x and y and velocities v_x and v_y. For simplicity, we add some damping to the nodal motion based on the velocity.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"beginaligned\ndotx = v_x\ndoty = v_y\ndotv_x = frac1Mleft(sum F_x - γv_xright)\ndotv_y = frac1Mleft(sum F_y - γv_yright) - g\nendaligned","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"The vertices cannot absorb any torque, so the beams only exert forces in the direction of the beam.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"F = Kcdot(L - Δd)","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"where L is the nominal lenth and Δd is the actual length of the beam.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"We start by loading the necessary packages.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"using NetworkDynamics\nusing OrdinaryDiffEqTsit5\nusing Graphs\nusing GraphMakie\nusing LinearAlgebra: norm\nusing Printf\nusing CairoMakie\nCairoMakie.activate!()","category":"page"},{"location":"generated/stress_on_truss/#Definition-of-the-dynamical-system","page":"Stress on Truss","title":"Definition of the dynamical system","text":"","category":"section"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"We need 3 models:","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"a fixed vertex which cannot change its position,\na free vertex which can move, and\na beam which connects two vertices.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"function fixed_g(pos, x, p, t)\n pos .= p\nend\nvertex_fix = VertexModel(g=fixed_g, psym=[:xfix, :yfix], outsym=[:x, :y], ff=NoFeedForward())","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"Here we need to specify the ff keyword manually, because NetworkDynamics cannot distinguish between g(out, x, p, t) (NoFeedForwarwd) and g(out, in, p, t) (PureFeedForward()) and guesses the latter when mathrmdim(x)=0.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"function free_f(dx, x, Fsum, (M, γ, g), t)\n v = view(x, 1:2)\n dx[1:2] .= (Fsum .- γ .* v) ./ M\n dx[2] -= g\n dx[3:4] .= v\n nothing\nend\nvertex_free = VertexModel(f=free_f, g=3:4, sym=[:vx=>0, :vy=>0, :x, :y],\n psym=[:M=>10, :γ=>200, :g=>9.81], insym=[:Fx, :Fy])","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"For the edge, we want to do something special. Later on, we want to color the edges according to the force they exert. Therefore, are interested in the absolut force rather than just the force vector. NetworkDynamics allows you to define so called Observed functions, which can recover additional states, so called observed, after the simulations. We can use this mechanis, to define a \"recipe\" for calculating the beam force based on the inputs (nodal positions) and the beam parameters.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"function edge_g!(F, pos_src, pos_dst, (K, L), t)\n dx = pos_dst[1] - pos_src[1]\n dy = pos_dst[2] - pos_src[2]\n d = sqrt(dx^2 + dy^2)\n Fabs = K * (L - d)\n F[1] = Fabs * dx / d\n F[2] = Fabs * dy / d\n nothing\nend\nfunction observedf(obsout, u, pos_src, pos_dst, (K, L), t)\n dx = pos_dst[1] .- pos_src[1]\n dy = pos_dst[2] .- pos_src[2]\n d = sqrt(dx^2 + dy^2)\n obsout[1] = K * (L - d)\n nothing\nend\nbeam = EdgeModel(g=AntiSymmetric(edge_g!), psym=[:K=>0.5e6, :L], outsym=[:Fx, :Fy], obsf=observedf, obssym=[:Fabs])","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"With the models define we can set up graph topology and initial positions.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"N = 5\ndx = 1.0\nshift = 0.2\ng = SimpleGraph(2*N + 1)\nfor i in 1:N\n add_edge!(g, i, i+N); add_edge!(g, i, i+N)\n if i < N\n add_edge!(g, i+1, i+N); add_edge!(g, i, i+1); add_edge!(g, i+N, i+N+1)\n end\nend\nadd_edge!(g, 2N, 2N+1)\npos0 = zeros(Point2f, 2N + 1)\npos0[1:N] = [Point((i-1)dx,0) for i in 1:N]\npos0[N+1:2*N] = [Point(i*dx + shift, 1) for i in 1:N]\npos0[2N+1] = Point(N*dx + 1, -1)\nfixed = [1,4] # set fixed vertices\nnothing #hide","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"Now can collect the vertex models and construct the Network object.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"verts = VertexModel[vertex_free for i in 1:nv(g)]\nfor i in fixed\n verts[i] = vertex_fix # use the fixed vertex for the fixed points\nend\nnw = Network(g, verts, beam)","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"In order to simulate the system we need to initialize the state and parameter vectors. Some states and parameters are shared between all vertices/edges. Those have been allready set in their constructors. The free symbols are","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"x and y for the position of the free vertices,\nxfix and yfix for the position of the fixed vertices,\nL for the nominal length of the beams.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"s = NWState(nw)\n# set x/y and xfix/yfix\nfor i in eachindex(pos0, verts)\n if i in fixed\n s.p.v[i, :xfix] = pos0[i][1]\n s.p.v[i, :yfix] = pos0[i][2]\n else\n s.v[i, :x] = pos0[i][1]\n s.v[i, :y] = pos0[i][2]\n end\nend\n# set L for edges\nfor (i,e) in enumerate(edges(g))\n s.p.e[i, :L] = norm(pos0[src(e)] - pos0[dst(e)])\nend\nnothing #hide","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"Lastly there is a special vertex at the end of the truss which has a higher mass and reduced damping.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"s.p.v[11, :M] = 200\ns.p.v[11, :γ] = 100\nnothing #hide","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"No we have everything ready to build the ODEProblem and simulate the system.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"tspan = (0.0, 12.0)\nprob = ODEProblem(nw, uflat(s), tspan, pflat(s))\nsol = solve(prob, Tsit5())\nnothing #hide","category":"page"},{"location":"generated/stress_on_truss/#Plot-the-solution","page":"Stress on Truss","title":"Plot the solution","text":"","category":"section"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"Plotting trajectories of points is kinda boring. So instead we're going to use GraphMakie.jl to create a animation of the timeseries.","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"fig = Figure(size=(1000,550));\nfig[1,1] = title = Label(fig, \"Stress on truss\", fontsize=30)\ntitle.tellwidth = false\n\nfig[2,1] = ax = Axis(fig)\nax.aspect = DataAspect();\nhidespines!(ax); # no borders\nhidedecorations!(ax); # no grid, axis, ...\nlimits!(ax, -0.1, pos0[end][1]+0.3, pos0[end][2]-0.5, 1.15) # axis limits to show full plot\n\n# get the maximum force during the simulation to get the color scale\n# It is only possible to access `:Fabs` directly becaus we've define the observable function for it!\n(fmin, fmax) = 0.3 .* extrema(Iterators.flatten(sol(sol.t, idxs=eidxs(nw, :, :Fabs))))\np = graphplot!(ax, g;\n edge_width = 4.0,\n node_size = 3*sqrt.(try s.p.v[i, :M] catch; 10.0 end for i in 1:nv(g)),\n nlabels = [i in fixed ? \"Δ\" : \"\" for i in 1:nv(g)],\n nlabels_align = (:center,:top),\n nlabels_fontsize = 30,\n elabels = [\"edge $i\" for i in 1:ne(g)],\n elabels_side = Dict(ne(g) => :right),\n edge_color = [0.0 for i in 1:ne(g)],\n edge_attr = (colorrange=(fmin,fmax),\n colormap=:diverging_bkr_55_10_c35_n256))\n\n# draw colorbar\nfig[3,1] = cb = Colorbar(fig, get_edge_plot(p), label = \"Axial force\", vertical=false)\n\nT = tspan[2]\nfps = 30\ntrange = range(0.0, sol.t[end], length=Int(T * fps))\nrecord(fig, \"truss.mp4\", trange; framerate=fps) do t\n title.text = @sprintf \"Stress on truss (t = %.2f )\" t\n s_at_t = NWState(sol, t)\n for i in eachindex(pos0)\n p[:node_pos][][i] = (s_at_t.v[i, :x], s_at_t.v[i, :y])\n end\n notify(p[:node_pos])\n load = s_at_t.e[:, :Fabs]\n p.edge_color[] = load\n p.elabels = [@sprintf(\"%.0f\", l) for l in load]\n fig\nend","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"","category":"page"},{"location":"generated/stress_on_truss/","page":"Stress on Truss","title":"Stress on Truss","text":"This page was generated using Literate.jl.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"EditURL = \"../../examples/directed_and_weighted_graphs.jl\"","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Neurodynamic-model-of-synchronization-in-the-human-brain","page":"Directed and Weighted Graphs","title":"Neurodynamic model of synchronization in the human brain","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"This example can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Topics-covered-in-this-tutorial-include:","page":"Directed and Weighted Graphs","title":"Topics covered in this tutorial include:","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"constructing a directed, weighted graph from data\nsome useful macros\nparameter handling\nstiff equations","category":"page"},{"location":"generated/directed_and_weighted_graphs/#The-FitzHugh-Nagumo-model","page":"Directed and Weighted Graphs","title":"The FitzHugh-Nagumo model","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Dynamics of spiking neurons have been described in a simplified manner by the FitzHugh-Nagumo model.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"beginaligned\nvarepsilon dot u = u - fracu^33 - v \ndot v = u + a\nendaligned","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Here u is a fast, excitatory variable corresponding to the membrane potential and v is a slower, inhibitory varibale. varepsilon is a parameter separating these time-scales, and a is a control parameter.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"In simplified models of the brain, such relaxation oscillators may be used to model individual neurons, clusters of neurons or even larger areas in the brain. The FitzHugh-Nagumo model has been widely used for studying synchronization in neuronal activity, which in turn has been connected to physiological phenomena such as epileptic seizures.","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Coupling-relaxation-oscillators","page":"Directed and Weighted Graphs","title":"Coupling relaxation oscillators","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"While different coupling schemes for FitzHugh-Nagumo oscillators have been proposed, in this tutorial we focus on coupling of the excitatory variables via electrical gap junctions, as described by the following system of equations.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"beginaligned\nvarepsilon dot u_i = u_i - fracu_i^33 - v_i - sigma sum_j=1^N G_ij(u_i - u_j) \ndot v_i = u_i + a\nendaligned","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"This is a simple diffusive coupling mediated by the difference between activation potentials in pairs of neurons. A similar coupling term was introduced in the \"getting started\" tutorial.","category":"page"},{"location":"generated/directed_and_weighted_graphs/#The-network-topology-a-brain-atlas","page":"Directed and Weighted Graphs","title":"The network topology - a brain atlas","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"In the following we will use a directed and weighted network encoding the strength and directionality of coupling between 90 different areas of the brain [Nathalie Tzourio-Mazoyer et al., 2002, Neuroimage].","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"The network weight matrix is given as a text file containing 90 lines with 90 numbers representing the coupling strength and separated by commas ,. The data can be conveniently read into a matrix with the DelimitedFiles module.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"using DelimitedFiles\nusing SimpleWeightedGraphs, Graphs\nusing NetworkDynamics\nusing OrdinaryDiffEqTsit5\nusing OrdinaryDiffEqSDIRK\nusing StableRNGs\nusing Plots\n\n# adjust the load path for your filesystem!\nfile = joinpath(pkgdir(NetworkDynamics), \"docs\", \"examples\", \"Norm_G_DTI.txt\")\nG = readdlm(file, ',', Float64, '\\n')\nnothing #hide","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"The data structure for directed, weighted graphs is provided by the package SimpleWeightedGraphs.jl which is based on Graphs.jl.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"# First we construct a weighted, directed graph\ng_weighted = SimpleWeightedDiGraph(G)\n\n# For later use we extract the edge.weight attributes\n# . is the broadcasting operator and gets the attribute :weight for every edge\nedge_weights = getfield.(collect(edges(g_weighted)), :weight)\n\n# we promote the g_weighted graph as a directed graph (weights of the edges are included in parameters)\ng_directed = SimpleDiGraph(g_weighted)\n\nnothing #hide","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Setting-up-the-ODEProblem","page":"Directed and Weighted Graphs","title":"Setting up the ODEProblem","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Defining the VertexModel and EdgeModel is similar to the example before. The macro Base.@propagate_inbounds tells the compiler to inline the function and propagate the inbounds context. For more details see the julia documentation.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Base.@propagate_inbounds function fhn_electrical_vertex!(dv, v, esum, p, t)\n (a, ϵ) = p\n dv[1] = v[1] - v[1]^3 / 3 - v[2] + esum[1]\n dv[2] = (v[1] - a) * ϵ\n nothing\nend\nvertex = VertexModel(f=fhn_electrical_vertex!, g=1, sym=[:u, :v], psym=[:a=>0.5, :ϵ=>0.05])","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Base.@propagate_inbounds function electrical_edge!(e, v_s, v_d, (w, σ), t)\n e[1] = w * (v_s[1] - v_d[1]) * σ\n nothing\nend\nelectricaledge = EdgeModel(g=Directed(electrical_edge!), outdim=1, psym=[:weight, :σ=>0.5])","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"fhn_network! = Network(g_directed, vertex, electricaledge)","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Since this system is a directed one with thus directed edges, the keyword argument coupling is used to set the coupling of the edges to Directed().","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Parameter-handling","page":"Directed and Weighted Graphs","title":"Parameter handling","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Some of the parameters have been declared with default values. Those default values will be used when creating the NWParameter object. We can use getindex on the parameter objects to set the missing weight values.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"p = NWParameter(fhn_network!)\np.e[1:ne(g_directed), :weight] = edge_weights\nnothing #hide","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"The initial conditions could be created similarly to the parameters as an indexable NWState obejct. Since we chose a random initial condition we initialize the flat array directly:","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"x0 = randn(StableRNG(42), dim(fhn_network!)) * 5\n\nnothing #hide","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Solving-the-system","page":"Directed and Weighted Graphs","title":"Solving the system","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Now we are ready to create an ODEProblem. Since for some choices of parameters the FitzHugh-Nagumo model is stiff (i.e. numerically unstable), we use a solver with automated stiffness detection. Such a solver switches to a more stable solver only when the solution enters a region of phase space where the problem is numerically unstable. In this case we use Tsit5 and switch to TRBDF2 when necessary. AutoTsit5 is the switching version of the Tsit5 algorithm.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"Not that we call pflat on the NWParameter object to get the flat array of parameters.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"tspan = (0.0, 200.0)\nprob = ODEProblem(fhn_network!, x0, tspan, pflat(p))\nsol = solve(prob, AutoTsit5(TRBDF2()));\nnothing #hide","category":"page"},{"location":"generated/directed_and_weighted_graphs/#Plotting","page":"Directed and Weighted Graphs","title":"Plotting","text":"","category":"section"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"The plot of the excitatory variables shows that they synchronize for this choice of parameters.","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"plot(sol; idxs=vidxs(fhn_network!, :, :u), legend=false, ylim=(-5, 5), fmt=:png)","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"","category":"page"},{"location":"generated/directed_and_weighted_graphs/","page":"Directed and Weighted Graphs","title":"Directed and Weighted Graphs","text":"This page was generated using Literate.jl.","category":"page"},{"location":"initialization/#Initialization","page":"Initialization","title":"Initialization","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Initialization of the system describes the process of finding valid initial conditions, mostly a fixpoint of the system. We distinguish between two types of initialization: full system initialziation and component initialization.","category":"page"},{"location":"initialization/#Full-System-Initialization","page":"Initialization","title":"Full-System Initialization","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Full system initialization describs the process of finding a fixpoint/steady state of th entire system.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"To do so, you can use find_fixpoint, which creates a SteadyStateProblem of the whole network and tries do solve it. ","category":"page"},{"location":"initialization/#Component-wise-Initialization","page":"Initialization","title":"Component-wise Initialization","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"In contrast to full-system initialization the goal of component-wise initialization is to find a valid initial condition for a single component first, given a network coupling.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"This can be usefull in cases, where there are nontrivial internal dynamics and states within a single vertex or edge. The idea of component-wise initialisation is to find internal states which match a given \"network coupling\" (fixed inputs and outputs).","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Lets consider the following example of a Swing-equation generator model.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"using NetworkDynamics, ModelingToolkit\nusing ModelingToolkit: t_nounits as t, D_nounits as Dt\n\n@mtkmodel Swing begin\n @variables begin\n u_r(t)=1, [description=\"bus d-voltage\", output=true]\n u_i(t)=0.1, [description=\"bus q-voltage\", output=true]\n i_r(t)=1, [description=\"bus d-current (flowing into bus)\", input=true]\n i_i(t)=0.1, [description=\"bus d-current (flowing into bus)\", input=true]\n ω(t), [guess=0.0, description=\"Rotor frequency\"]\n θ(t), [guess=0.0, description=\"Rotor angle\"]\n Pel(t), [guess=1, description=\"Electrical Power injected into the grid\"]\n end\n @parameters begin\n M=0.005, [description=\"Inertia\"]\n D=0.1, [description=\"Damping\"]\n V=sqrt(u_r^2 + u_i^2), [description=\"Voltage magnitude\"]\n ω_ref=0, [description=\"Reference frequency\"]\n Pm, [guess=0.1,description=\"Mechanical Power\"]\n end\n @equations begin\n Dt(θ) ~ ω - ω_ref\n Dt(ω) ~ 1/M * (Pm - D*ω - Pel)\n Pel ~ u_r*i_r + u_i*i_i\n u_r ~ V*cos(θ)\n u_i ~ V*sin(θ)\n end\nend\nsys = Swing(name=:swing)\nvf = VertexModel(sys, [:i_r, :i_i], [:u_r, :u_i])","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"You can see in the provided metadata, that we've set default values for the node outputs u_r, u_i, the node inputs i_r, i_i and most parameters. For some states and parameters, we've onlye provided a guess rather than a default. Variables which only have guesses are considered \"tunable\" for the initialization algorithm.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"In order to initialize the remaining variables we use initialize_component!, which is a mutating function which tries to solve the nonlinear initialization problem and store the found values for the \"free\" variables as init metadata.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"initialize_component!(vf; verbose=true)\nnothing #hide","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"vf #hide","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Which lead to a successfull initialization of states :θ and :ω as well as parameter :Pm. To retrieve the residual you can use init_residual.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"As a quick test we can ensure that the angle indeed matches the voltag angel:","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"get_init(vf, :θ) ≈ atan(get_default(vf, :u_i), get_default(vf, :u_r))","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"EditURL = \"../../examples/heterogeneous_system.jl\"","category":"page"},{"location":"generated/heterogeneous_system/#Modeling-a-heterogeneous-system","page":"Heterogeneous Systems","title":"Modeling a heterogeneous system","text":"","category":"section"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"This example can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"One of the main purposes of NetworkDynamics.jl is to facilitate modeling coupled systems with heterogenities. This means that components can differ in their parameters as well as in their dynamics.","category":"page"},{"location":"generated/heterogeneous_system/#Heterogenous-parameters","page":"Heterogeneous Systems","title":"Heterogenous parameters","text":"","category":"section"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"We start by setting up a simple system of Kuramoto oscillators.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"using NetworkDynamics, OrdinaryDiffEqTsit5, Plots, Graphs\n\nN = 8\ng = watts_strogatz(N, 2, 0) # ring network\n\nfunction kuramoto_edge!(e, θ_s, θ_d, (K,), t)\n e[1] = K * sin(θ_s[1] - θ_d[1])\n nothing\nend\nedge! = EdgeModel(g=AntiSymmetric(kuramoto_edge!), outdim=1, psym=[:K=>3])","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"function kuramoto_vertex!(dθ, θ, esum, (ω0,), t)\n dθ[1] = ω0 + esum[1]\n nothing\nend\nvertex! = VertexModel(f=kuramoto_vertex!, g=StateMask(1:1), sym=[:θ], psym=[:ω0], name=:kuramoto)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"nw = Network(g, vertex!, edge!)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"To assign parameters, we can create a NWParameter object based on the nw definition. This parameter object will be pre-filled with the default parameters.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"p = NWParameter(nw)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"To set the vertex parameters, we can use indexing of the p.v field:","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"ω = collect(1:N) ./ N\nω .-= sum(ω) / N\np.v[:, :ω0] = ω\nnothing #hide","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"Here, the index pairing :, :ω is used to index state ω for all node indices.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"The parameter object contains information about the network structure. For the actual problem definition we need to throw away this wrapper and use the flat-vector representation of the parameters pflat(p). Note that pflat(p)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"Similarily, we could use NWState(nw) to create an indexable wrapper of the initial state. However in this case we can also fill create the flat state array manually:","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"x0 = collect(1:N) ./ N\nx0 .-= sum(x0) ./ N\ntspan = (0.0, 10.0)\nprob = ODEProblem(nw, x0, tspan, pflat(p))\nsol = solve(prob, Tsit5())\nplot(sol; ylabel=\"θ\", fmt=:png)","category":"page"},{"location":"generated/heterogeneous_system/#Heterogeneous-dynamics","page":"Heterogeneous Systems","title":"Heterogeneous dynamics","text":"","category":"section"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"Two paradigmatic modifications of the node model above are static nodes and nodes with inertia. A static node has no internal states and instead fixes the variable at a constant value.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"function static_g(out, u, p, t)\n out[1] = p[1]\n nothing\nend\nstatic! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], name=:static)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"But wait! NetworkDynamics classified this as PureFeedForward, because it cannot distinguish between the function signatures","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"g(out, u, p, t) # PureFeedForward\ng(out, ins, p, t) # NoFeedForward","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"and since dim(u)=0 it wrongfully assumes that the latter is meant. We can overwrite the classification by passing the ff keyword:","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"static! = VertexModel(g=static_g, outsym=[:θ], psym=[:θfix => ω[1]], ff=NoFeedForward(), name=:static)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"A Kuramoto model with inertia consists of two internal variables leading to more complicated (and for many applications more realistic) local dynamics.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"function kuramoto_inertia!(dv, v, esum, (ω0,), t)\n dv[1] = v[2]\n dv[2] = ω0 - 1.0 * v[2] + esum[1]\n nothing\nend\n\ninertia! = VertexModel(f=kuramoto_inertia!, g=1:1, sym=[:θ, :ω], psym=[:ω0], name=:inertia)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"Since now we model a system with heterogeneous node dynamics we can no longer straightforwardly pass a single VertexModel to the Network constructor but instead have to hand over an Array.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"vertex_array = VertexModel[vertex! for i in 1:N]\nvertex_array[1] = static!\nvertex_array[5] = inertia! # index should correspond to the node's index in the graph\nnw_hetero! = Network(g, vertex_array, edge!)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"Now we have to take a bit more care with defining initial conditions and parameters.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"First, we can generate a NWState object based on the nw_hetero! object which will be populated with the default values.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"state = NWState(nw_hetero!)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"The node with inertia is two-dimensional, hence we need to specify two initial conditions. For the first dimension we keep the initial conditions from above and insert! another one into x0 at the correct index.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"For the θ states we will use the same initial conditins as before:","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"state.v[2:8,:θ] = x0[2:8]\nnothing #hide","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"We're still missing one initial condition: the second variable ω of the 5th vertex.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"state.v[5,:ω] = 5\nnothing #hide","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"The NWState object also contains a parameter object accessible via state.p. The edge parameters are already filled with default values. The vertex parameters can be copied from our old parmeter object p.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"state.p.v[2:8, :ω0] = p.v[2:8, :ω0]\nnothing #hide","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"For the problem construction, we need to convert the nested stuctures to flat arrays using the uflat and pflat methods.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"prob_hetero = ODEProblem(nw_hetero!, uflat(state), tspan, pflat(state))\nsol_hetero = solve(prob_hetero, Tsit5());\nnothing #hide\nplot(sol_hetero)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"For clarity we plot only the variables referring to the oscillator's angle θ and color them according to their type.","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"colors = map(vertex_array) do vertexf\n if vertexf.name == :kuramoto\n colorant\"lightseagreen\"\n elseif vertexf.name == :static\n colorant\"orange\"\n elseif vertexf.name == :inertia\n colorant\"darkred\"\n end\nend\n\nplot(sol_hetero; ylabel=\"θ\", idxs=vidxs(1:8,:θ), lc=colors', fmt=:png)","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"","category":"page"},{"location":"generated/heterogeneous_system/","page":"Heterogeneous Systems","title":"Heterogeneous Systems","text":"This page was generated using Literate.jl.","category":"page"},{"location":"metadata/#Metadata","page":"Metadata","title":"Metadata","text":"","category":"section"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Component model such as VertexModel and EdgeModel can store metadata. We distinguish between two kinds of metadata: component metadata and symbol metadata.","category":"page"},{"location":"metadata/#Component-Metadata","page":"Metadata","title":"Component Metadata","text":"","category":"section"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Component metadata is a Dict{Symbol,Any} attached to each component to store various information. Use metadata to retrieve the full dict.","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"To access the data, you can use the methods has_metadata, get_metadata and set_metadata! (see Component Metadata API).","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Special metadata: ","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":":init_residual: after Component-wise Initialization, this field stores the residual vector of the nonlinear problem.\n:graphelement: optional field to specialize the graphelement for each component (vidx) for vertices, (;src,dst) named tuple of either vertex names or vertex indices for edges. Has special accessors has_/get_/set_graphelement.","category":"page"},{"location":"metadata/#Symbol-Metadata","page":"Metadata","title":"Symbol Metadata","text":"","category":"section"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Each component stores symbol metadata. The symbol metadata is a Dict{Symbol, Dict{Symbol, Any}} which stores a metadate dict per symbol. Symbols are everything that appears in sym, psym, obssym and insym.","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"To access the data, you can use the methods has_metadata, get_metadata and set_metadata! (see Per Symbol Metadata API).","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Special cases for symbol metadata are:","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"default: Stores default values for states/parameters. In initialization, those are considered fixed.\nguess: Stores a guess for a state/parameter which needs to solved during initialization (\"free\" variables).\nbounds: Store bounds for variables/parameters\ninit: Stores the solution of the \"free\" variables during initialization.","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Fore those, there are special functions has_*, get_* and set_*!. See Per Symbol Metadata API.","category":"page"},{"location":"metadata/","page":"Metadata","title":"Metadata","text":"Those are closely aligned to the metadata use in ModelingToolkit. They are automatically copied from the ODESystem if you use MTK models to create NetworkDynamics models.","category":"page"},{"location":"symbolic_indexing/#Symbolic-Indexing","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Using SciML's SymblicIndexingInterface.jl, ND.jl provides lots of methods to access and change variables and Parameters.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"details: Setup code to make following examples work\nusing NetworkDynamics\nusing Graphs\nusing OrdinaryDiffEqTsit5\nusing Plots","category":"page"},{"location":"symbolic_indexing/#Provide-Symbol-Names","page":"Symbolic Indexing","title":"Provide Symbol Names","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"When construction component models, you can pass symbolic names using the sym and psym keywords.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"function _edgef!(e, v_s, v_d, (K,), t)\n e .= K * (v_s[1] .- v_d[1])\nend\nedgef = EdgeModel(;g=AntiSymmetric(_edgef!), outsym=[:flow], psym=[:K=>1])","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Here we created a static diffusion edge with suitable variable and parameter names. Similarly, we define the diffusion vertex with symbolic names.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"function _vertexf!(dv, v, esum, p, t)\n dv[1] = esum[1]\nend\nvertexf = VertexModel(f=_vertexf!, g=1, sym=[:storage])","category":"page"},{"location":"symbolic_indexing/#Fundamental-Symblic-Indices","page":"Symbolic Indexing","title":"Fundamental Symblic Indices","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"The default types for this access are the types VIndex, EIndex, VPIndex and EPIndex. Each of those symbolic indices consists of 2 elements: a reference to the network componen and a reference to the symbol within that component. As such, VIndex(2, :x) refers to variable with symbolic name :x in vertex number 2. EPIndex(4, 2) would refer to the second parameter of the edge component for the 4th edge.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"details: Setup code to make following examples work\ng = wheel_graph(5)\nnw = Network(g, vertexf, edgef)\ns = NWState(nw)\ns.v[:,:storage] .= randn(5)\nprob = ODEProblem(nw, uflat(s), (0,2), pflat(s))\nsol = solve(prob, Tsit5()) \nnothing #hide","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Those fundamental indices can be used in a lot of scenarios. Most importantly you can use them to","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"sol(sol.t; idxs=VIndex(1, :storage)) # extract timeseries out ouf solution object\nplot(sol; idxs=[VIndex(1, :storage), VIndex(5,:storage)]) # plot storage of two nodes","category":"page"},{"location":"symbolic_indexing/#Generate-Symbolic-Indices","page":"Symbolic Indexing","title":"Generate Symbolic Indices","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Often, you need many individual symbolic indices. For that there are the helper methods vidxs, eidxs, vpidxs and epidxs. With the help of those methods you can generate arrays of symbolic indices:","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"vidxs(nw, :, :storage) # get variable \"storage\" for all nodes","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"plot(sol; idxs=vidxs(nw, :, :storage))","category":"page"},{"location":"symbolic_indexing/#NWState-and-NWParameter-Objects","page":"Symbolic Indexing","title":"NWState and NWParameter Objects","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Internally, both state and parameters of a Network are represented using flat arrays. To access the state or parameters of a network, you can use the NWState and NWParameter objects.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"p = NWParameter(nw)","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"creates a NWParameter object for the network nw. It essentially creates a new flat parameter array and fills it with the default parameter values define in the component. The parameters in the NWParameter object can be accessed using the symbolic indices.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"p[EPIndex(5, :K)] = 2.0 # change the parameter K of the 5th edge\nnothing #hide","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Similarly, you can create a NWState object for the network nw using","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"s = NWState(nw)","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"No default values were provided in the network components, so the state array is filled with NaNs.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"s[VIndex(:, :storage)] .= randn(5) # set the (initial) storage for alle nodes \ns #hide","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"For both NWState and NWParameter objects, the there is a more convenient way to access the variables and parameters.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"@assert s.v[1, :storage] == s[VIndex(1, :storage)] # s.v -> access vertex states\n@assert s.e[1, :flow] == s[EIndex(1, :flow)] # s.e -> access edge states\n@assert s.p.e[1,:K] == p[EPIndex(1, :K)] # s.p -> access parameters","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"The NWState and NWParameter objects are mutable, thus changing them will also change the underlying wrapped flat arrays. You can allways access the flat representations by calling uflat and pflat.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"note: Note\nThe NWState and NWParameter wrappers can be constructed from various objects. Fore example, within a callback you might construct p = NWParameter(integrator) to then change the parameters of the network within the callback.","category":"page"},{"location":"symbolic_indexing/#Observables","page":"Symbolic Indexing","title":"Observables","text":"","category":"section"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Sometimes, the \"states\" you're interested in aren't really states in the DAE sense but rather algebraic derivations from DAE states, parameters and time – in accordance with the naming in the SciML-ecosystem those states are called Observables.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"A prime example of Observables are edge/vertex-outputs, such as the flow in the edge model defined above. It is also possible to define additional Observables manually by using the obssym and obsf keyword on the EdgeModel/VertexModel constructors. When building models using ModelingToolkit, the reduced algebraic states will be preserved as observables automatically.","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"Observables can be accessed like any other state, for example, the flows in the network don't show up in the state array but can be accessed in all the ways discussed above, for example","category":"page"},{"location":"symbolic_indexing/","page":"Symbolic Indexing","title":"Symbolic Indexing","text":"plot(sol; idxs=eidxs(nw, :, :flow))","category":"page"},{"location":"mathematical_model/#Mathematical-Model","page":"Mathematical Model","title":"Mathematical Model","text":"","category":"section"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The basic mathematical model of NetworkDynamics.jl splits up the system it two parts: vertex and edge components.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The main goal of NetworkDynamics.jl is, to express the overall network dynamics as a Differential-Algebraic-Equation (DAE)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Mfracmathrmdmathrmdtu = f^mathrmnw(u p t)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"where M is a (possibly singular) mass matrix, u is the internal state vector of the system, p are the parameters and t is the time. To make this compatible with the solvers for OrdinaryDiffEq.jl, the created Network object is a callable object","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"nw(du, u, p, t) # mutates du","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"with stored mass matrix information to build an ODEProblem based on the Network.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Instead of defining f^mathrmnw by hand, ND.jl helps you to build it automatically based on a list of decentralized nodal and edge dynamics, so-called VertexModel and EdgeModel objects. Each component model mathrm c is modeled as general input-output-system","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"beginaligned\nM_mathrm cfracmathrmdmathrmdtx_mathrm c = f^mathrm c(x^mathrm c i_mathrm c p_mathrm c t)\ny^mathrm c = g^mathrm c(x^mathrmc i_mathrm c p_mathrm c t)\nendaligned","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"where M_mathrmc is the component mass matrix, x^mathrm c are the component states, i^mathrm c are the inputs of the component and y^mathrm c is the output of the component. It is possible to have mathrmdim(x^mathrmc) = 0 and thus no internal states.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"In the network context, the output of the edges are flow variables. The outputs of vertices are potential variables. In interconnection, the flow on the edges depends on the potentials at both ends as inputs. The potentials of the nodes depend on the incoming flows from all connected edges as an input. (Here, flow and potentials are meant in a conceptional and not necessarily physical way.)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"","category":"page"},{"location":"mathematical_model/#Vertex-Models","page":"Mathematical Model","title":"Vertex Models","text":"","category":"section"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Specifically, a (single-layer) vertex model has one input, and one output. The input is an aggregation/reduction over all incident edge outputs,","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"i^mathrm v = mathopmathrmagglimits_k^textincident y^mathrm e_k qquadtextoftenqquad\ni^mathrm v = sum_k^textincident y^mathrm e_k","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The full vertex model","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"beginaligned\nM^mathrm vfracmathrmdmathrmdtx^mathrm v = f^mathrm v(u^mathrm v i^mathrm v p^mathrm v t)\ny^mathrm v = g^mathrm v(u^mathrm v i^mathrm v p^mathrm v t)\nendaligned","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"corresponds to the Julia functions","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"function fᵥ(dxᵥ, xᵥ, e_aggr, pᵥ, t)\n # mutate dxᵥ\n nothing\nend\nfunction gᵥ(yᵥ, xᵥ, e_aggr, pᵥ, t)\n # mutate yᵥ\n nothing\nend\nvertf = VertexModel(; f=fᵥ, g=gᵥ, mass_matrix=Mᵥ, ...)","category":"page"},{"location":"mathematical_model/#Edge-Models","page":"Mathematical Model","title":"Edge Models","text":"","category":"section"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"In contrast to vertex models, edge models in general have two inputs and two outputs, both for source and destination end of the edge. We commonly use src and dst to describe the source and destination end of an edge respectively. ","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"note: On the directionality of edges\nMathematically, in a system defined on an undirected graph there is no difference between the edge (12) and (21), the edge has no direction. However, from an implementation point of view we always need to have some kind of ordering for function arguments, state order and so on. For undirected graphs, Graphs.jl chooses the direction of an edge v1->v2 such that v1 < v2.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The inputs of the edge are just the outputs of the two nodes at both ends. The output is split into two: the dst output goes to the input of the vertex at the destination end, the src output goes to the input of the vertex at the src end.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The full model of an edge","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"beginaligned\nM^mathrm efracmathrmdmathrmdtx^mathrm e = f^mathrm e(u^mathrm e y^mathrm v_mathrmsrc y^mathrm v_mathrmdst p^mathrm e t)\ny^mathrm e_mathrmdst = g_mathrmdst^mathrm e(u^mathrm e y^mathrm v_mathrmsrc y^mathrm v_mathrmdst p^mathrm e t)\ny^mathrm e_mathrmsrc = g_mathrmsrc^mathrm e(u^mathrm e y^mathrm v_mathrmsrc y^mathrm v_mathrmdst p^mathrm e t)\nendaligned","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"corresponds to the Julia functions","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"function fₑ(dxₑ, xₑ, v_src, v_dst, pₑ, t)\n # mutate dxᵥ\n nothing\nend\nfunction gₑ(y_src, y_dst, xᵥ, v_src, v_dst, pₑ, t)\n # mutate y_src and y_dst\n nothing\nend\nvertf = EdgeModel(; f=fₑ, g=gₑ, mass_matrix=Mₑ, ...)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The sign convention for both outputs of an edge must be identical, typically, a positive flow represents a flow into the connected vertex. This is important, because the vertex only receives the flows, it does not know whether the flow was produce by the source or destination end of an edge.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":" y_src y_dst \n V_src o───←─────────→───o V_dst\n","category":"page"},{"location":"mathematical_model/#Single-Sided-Edge-Outputs","page":"Mathematical Model","title":"Single Sided Edge Outputs","text":"","category":"section"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Often, edge outputs will possess some symmetry which makes it more convenient to define \"single sided\" edge output functions","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"function g_single(y, xᵥ, v_src, v_dst, pₑ, t)\n # mutate y\n nothing\nend","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"There are multiple wrappers available to automaticially convert them into double-sided edge output functions:","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Directed(g_single) builds a double-sided function which only couples to the destination side.\nSymmetric(g_single) builds a double-sided function in which both ends receive y.\nAntiSymmetric(g_single) builds a double-sided function where the destination receives y and the source receives -y.\nFiducial(g_single_src, g_singl_dst) builds a double-sided edge output function based on two single sided functions.","category":"page"},{"location":"mathematical_model/#Feed-Forward-Behavior","page":"Mathematical Model","title":"Feed Forward Behavior","text":"","category":"section"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"The most general version of the component models can contain direct feed forwards from the input, i.e. the edge output might depend directly on the connected vertices or the vertex output might depend directly on the aggregated edge input.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Whenever possible, you should define output functions without feed forwards, i.e.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"gᵥ_noff(yᵥ, xᵥ, pᵥ, t)\ngₑ_noff([y_src,] y_dst, xᵥ, pₑ, t)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"instead of the more general","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"gᵥ(yᵥ, xᵥ, e_aggr, pᵥ, t)\ngₑ([y_src], y_dst, xᵥ, v_src, v_dst, pₑ, t)","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"NetworkDynamics cannot couple two components with feed forward to each other. It is always possible to transform feed forward behavior to an internal state x with mass matrix entry zero to circumvent this problem. This transformation can be performed automatically by using ff_to_constraint.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"warning: Feed Forward Vertices\nAs of 11/2024, vertices with feed forward are not supported at all. Use ff_to_constraint to transform them into vertex model without FF.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"Concretely, NetworkDynamics distinguishes between 4 types of feed forward behaviors of g functions based on the FeedForwardType trait. The different types the signature of provided function g. Based on the signatures avaialable, ND.jl will try to find the correct type automaticially. Using the ff keyword in the constructors, the user can enforce a specific type.","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"PureFeedForward()","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"g!(outs..., ins..., p, t) # abstractly\ng!(out_dst, v_src, v_dst, p, t) # single-sided edge\ng!(out_src, out_dst, v_src, v_dst, p, t) # double-sided edge\ng!(v_out, e_aggr, p, t) # single layer vertex","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"FeedForward()","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"g!(outs..., x, ins..., p, t) # abstractly\ng!(out_dst, x, v_src, v_dst, p, t) # single-sided edge\ng!(out_src, out_dst, x, v_src, v_dst, p, t) # double-sided edge\ng!(v_out, x, e_aggr, p, t) # single layer vertex","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"NoFeedForward()","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"g!(outs..., x, p, t) # abstractly\ng!(out_dst, x, p, t) # single-sided edge\ng!(out_src, out_dst, x, p, t) # double-sided edge\ng!(v_out, x, p, t) # single layer vertex","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"PureStateMap()","category":"page"},{"location":"mathematical_model/","page":"Mathematical Model","title":"Mathematical Model","text":"g!(outs..., x) # abstractly\ng!(out_dst, x) # single-sided edge\ng!(out_src, out_dst, x) # double-sided edge\ng!(v_out, x) # single layer vertex","category":"page"},{"location":"API/#API","page":"API","title":"API","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"The following functions are designed for public use.","category":"page"},{"location":"API/#Network-Construction-API","page":"API","title":"Network Construction API","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"Network\ndim(::Network)\npdim(::Network)","category":"page"},{"location":"API/#NetworkDynamics.Network","page":"API","title":"NetworkDynamics.Network","text":"Network([g,] vertexf, edgef; kwarg...)\n\nConstruct a Network object from a graph g and edge and component models vertexf and edgef.\n\nArguments:\n\ng::AbstractGraph: The graph on which the network is defined. Optional, can be ommittet if all component models have a defined graphelement. See vidx and src/dst keywors for VertexModel and EdgeModel constructors respectively.\nvertexm: A single VertexModel or a vector of VertexModel objects. The order of the vertex models must mirror the order of the vertices(g) iterator.\nedgem: A single EdgeModel or a vector of EdgeModel objects. The order of the edge models must mirror the order of the edges(g) iterator.\n\nOptional keyword arguments:\n\nexecution=SequentialExecution{true}(): Execution model of the network. E.g. SequentialExecution, KAExecution, PolyesterExecution or ThreadedExecution.\naggregator=execution isa SequentialExecution ? SequentialAggregator(+) : PolyesterAggregator(+): Aggregation function applied to the edge models. E.g. SequentialAggregator, PolyesterAggregator, ThreadedAggregator, SparseAggregator.\ncheck_graphelement=true: Check if the graphelement metadata is consistent with the graph.\ndealias=false Check if the components alias eachother and create copies if necessary. This is necessary if the same component model is referenced in multiple places in the Network but you want to dynamicially asign metadata, such as initialization information to specific instances.\nverbose=false: Show additional information during construction.\n\n\n\n\n\nNetwork(nw::Network; g, vertexm, edgem, kwargs...)\n\nRebuild the Network with same graph and vertex/edge models but possibly different kwargs.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.dim-Tuple{Network}","page":"API","title":"NetworkDynamics.dim","text":"dim(nw::Network)\n\nReturns the number of dynamic states in the network, corresponts to the length of the flat state vector.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.pdim-Tuple{Network}","page":"API","title":"NetworkDynamics.pdim","text":"pdim(nw::Network)\n\nReturns the number of parameters in the network, corresponts to the length of the flat parameter vector.\n\n\n\n\n\n","category":"method"},{"location":"API/#Component-Models","page":"API","title":"Component Models","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"VertexModel()\nEdgeModel()","category":"page"},{"location":"API/#NetworkDynamics.VertexModel-Tuple{}","page":"API","title":"NetworkDynamics.VertexModel","text":"VertexModel(; kwargs...)\n\nBuild a VertexModel according to the keyword arguments.\n\nMain Arguments:\n\nf=nothing: Dynamic function of the component. Can be nothing if dim is 0.\ng: Output function of the component. Usefull helpers: StateMask\nsym/dim: Symbolic names of the states. If dim is provided, sym is set automaticially.\noutsym/outdim: Symbolic names of the outputs. If outdim is provided, outsym is set automaticially. Can be infered automaticially if g isa StateMask.\npsym/pdim=0: Symbolic names of the parameters. Ifpdimis provided,psym` is set automaticially.\nmass_matrix=I: Mass matrix of component. Can be a vector v and is then interpreted as Diagonal(v).\nname=dim>0 ? :VertexM : :StaticVertexM: Name of the component.\n\nOptional Arguments:\n\ninsym/indim: Symbolic names of the inputs. If indim is provided, insym is set automaticially.\nvidx: Index of the vertex in the graph, enables graphless constructor.\nff: FeedForwardType of component. Will be typically infered from g automaticially.\nobssym/obsf: Define additional \"observable\" states.\nsymmetadata/metadata: Provide prefilled metadata dictionaries.\n\nAll Symbol arguments can be used to set default values, i.e. psym=[:K=>1, :p].\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.EdgeModel-Tuple{}","page":"API","title":"NetworkDynamics.EdgeModel","text":"EdgeModel(; kwargs...)\n\nBuild a EdgeModel according to the keyword arguments.\n\nMain Arguments:\n\nf=nothing: Dynamic function of the component. Can be nothing if dim is 0.\ng: Output function of the component. Usefull helpers: AntiSymmetric, Symmetric, Fiducial, Directed and StateMask.\nsym/dim: Symbolic names of the states. If dim is provided, sym is set automaticially.\noutsym/outdim: Symbolic names of the outputs. If outdim is provided, outsym is set automaticially. In general, outsym for edges isa named tuple (; src, dst). However, depending on the g function, it might be enough to provide a single vector or even nothing (e.g. AntiSymmetric(StateMask(1:2))). See Building EdgeModels for examples.\npsym/pdim=0: Symbolic names of the parameters. Ifpdimis provided,psym` is set automaticially.\nmass_matrix=I: Mass matrix of component. Can be a vector v and is then interpreted as Diagonal(v).\nname=dim>0 ? :EdgeM : :StaticEdgeM: Name of the component.\n\nOptional Arguments:\n\ninsym/indim: Symbolic names of the inputs. If indim is provided, insym is set automaticially. For edges, insym is a named tuple (; src, dst). If give as vector tuple is created automaticially.\nsrc/dst: Index or name of the vertices at src and dst end. Enables graphless constructor.\nff: FeedForwardType of component. Will be typically infered from g automaticially.\nobssym/obsf: Define additional \"observable\" states.\nsymmetadata/metadata: Provide prefilled metadata dictionaries.\n\nAll Symbol arguments can be used to set default values, i.e. psym=[:K=>1, :p].\n\n\n\n\n\n","category":"method"},{"location":"API/#Component-Models-with-MTK","page":"API","title":"Component Models with MTK","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"VertexModel(::ModelingToolkit.ODESystem, ::Any, ::Any)\nEdgeModel(::ModelingToolkit.ODESystem, ::Any, ::Any, ::Any, ::Any)\nEdgeModel(::ModelingToolkit.ODESystem, ::Any, ::Any, ::Any)","category":"page"},{"location":"API/#NetworkDynamics.VertexModel-Tuple{ODESystem, Any, Any}","page":"API","title":"NetworkDynamics.VertexModel","text":"VertexModel(sys::ODESystem, inputs, outputs; ff_to_constraint=true, kwargs...)\n\nCreate a VertexModel object from a given ODESystem created with ModelingToolkit. You need to provide 2 lists of symbolic names (Symbol or Vector{Symbols}):\n\ninputs: names of variables in you equation representing the aggregated edge states\noutputs: names of variables in you equation representing the node output\n\nff_to_constraint controlls, whether output transformations g which depend on inputs should be\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.EdgeModel-Tuple{ODESystem, Vararg{Any, 4}}","page":"API","title":"NetworkDynamics.EdgeModel","text":"EdgeModel(sys::ODESystem, srcin, srcout, dstin, dstout; ff_to_constraint=false, kwargs...)\n\nCreate a EdgeModel object from a given ODESystem created with ModelingToolkit. You need to provide 4 lists of symbolic names (Symbol or Vector{Symbols}):\n\nsrcin: names of variables in you equation representing the node state at the source\ndstin: names of variables in you equation representing the node state at the destination\nsrcout: names of variables in you equation representing the output at the source\ndstout: names of variables in you equation representing the output at the destination\n\nff_to_constraint controlls, whether output transformations g which depend on inputs should be transformed into constraints.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.EdgeModel-Tuple{ODESystem, Any, Any, Any}","page":"API","title":"NetworkDynamics.EdgeModel","text":"EdgeModel(sys::ODESystem, srcin, dstin, AntiSymmetric(dstout); ff_to_constraint=false, kwargs...)\n\nCreate a EdgeModel object from a given ODESystem created with ModelingToolkit.\n\nHere you only need to provide one list of output symbols: dstout. To make it clear how to handle the single-sided output definiton, you musst wrap the symbol vector in\n\nAntiSymmetric(dstout),\nSymmetric(dstout), or\nDirected(dstout).\n\nff_to_constraint controlls, whether output transformations g which depend on inputs should be transformed into constraints.\n\n\n\n\n\n","category":"method"},{"location":"API/#Output-Function-Helpers/Wrappers","page":"API","title":"Output Function Helpers/Wrappers","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"StateMask\nSymmetric\nAntiSymmetric\nDirected\nFiducial","category":"page"},{"location":"API/#NetworkDynamics.StateMask","page":"API","title":"NetworkDynamics.StateMask","text":"StateMask(i::AbstractArray)\nStateMaks(i::Number)\n\nA StateMask is a predefined output function. It can be used to define the output of a component model by picking from the internal state.\n\nI.e. g=StateMask(2:3) in a vertex function will output the internal states 2 and 3. In many contexts, StateMasks can be constructed implicitly by just providing the indices, e.g. g=1:2.\n\nFor EdgeModel this needs to be combined with a Directed, Symmetric, AntiSymmetric or Fiducial coupling, e.g. g=Fiducial(1:2, 3:4) forwards states 1:2 to dst and states 3:4 to src.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.Symmetric","page":"API","title":"NetworkDynamics.Symmetric","text":"Symmetric(g)\n\nWraps a single-sided output function g turns it into a double sided output function which applies\n\ny_dst = g(...)\ny_src = y_dst\n\ng can be a Number/AbstractArray to impicitly wrap the corresponding StateMask.\n\nSee also AntiSymmetric, Directed, Fiducial and StateMask.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.AntiSymmetric","page":"API","title":"NetworkDynamics.AntiSymmetric","text":"AntiSymmetric(g_dst)\n\nWraps a single-sided output function g_dst turns it into a double sided output function which applies\n\ny_dst = g_dst(...)\ny_src = -y_dst\n\ng_dst can be a Number/AbstractArray to impicitly wrap the corresponding StateMask.\n\nSee also Symmetric, Directed, Fiducial and StateMask.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.Directed","page":"API","title":"NetworkDynamics.Directed","text":"Directed(g_dst)\n\nWraps a single-sided output function g_dst turns it into a double sided output function which applies\n\ny_dst = g_dst(...)\n\nWith Directed there is no output for the src side. g_dst can be a Number/AbstractArray to impicitly wrap the corresponding StateMask.\n\nSee also AntiSymmetric, Symmetric, Fiducial and StateMask.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.Fiducial","page":"API","title":"NetworkDynamics.Fiducial","text":"Fiducial(g_src, g_dst)\n\nWraps two single-sided output function g_src and g_dst and turns them into a double sided output function which applies\n\ny_dst = g_src(...)\ny_src = g_dst(...)\n\ng can be a Number/AbstractArray to impicitly wrap the corresponding StateMask.\n\nSee also AntiSymmetric, Directed, Fiducial and StateMask.\n\n\n\n\n\n","category":"type"},{"location":"API/#Accessors-for-Component-Properties","page":"API","title":"Accessors for Component Properties","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"fftype\ndim(::NetworkDynamics.ComponentModel)\nsym\noutdim\noutsym\npdim(::NetworkDynamics.ComponentModel)\npsym\nobssym\nhasinsym\ninsym\nhasindim\nindim","category":"page"},{"location":"API/#NetworkDynamics.fftype","page":"API","title":"NetworkDynamics.fftype","text":"fftype(x)\n\nRetrieve the feed forward trait of x.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.dim-Tuple{NetworkDynamics.ComponentModel}","page":"API","title":"NetworkDynamics.dim","text":"dim(c::ComponentModel)::Int\n\nRetrieve the dimension of the component.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.sym","page":"API","title":"NetworkDynamics.sym","text":"sym(c::ComponentModel)::Vector{Symbol}\n\nRetrieve the symbols of the component.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.outdim","page":"API","title":"NetworkDynamics.outdim","text":"outdim(c::VertexModel)::Int\noutdim(c::EdgeModel)::@NamedTuple(src::Int, dst::Int)\n\nRetrieve the output dimension of the component\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.outsym","page":"API","title":"NetworkDynamics.outsym","text":"outsym(c::VertexModel)::Vector{Symbol} outsym(c::EdgeModel)::@NamedTuple{src::Vector{Symbol}, dst::Vector{Symbol}}\n\nRetrieve the output symbols of the component.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.pdim-Tuple{NetworkDynamics.ComponentModel}","page":"API","title":"NetworkDynamics.pdim","text":"pdim(c::ComponentModel)::Int\n\nRetrieve the parameter dimension of the component.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.psym","page":"API","title":"NetworkDynamics.psym","text":"psym(c::ComponentModel)::Vector{Symbol}\n\nRetrieve the parameter symbols of the component.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.obssym","page":"API","title":"NetworkDynamics.obssym","text":"obssym(c::ComponentModel)::Vector{Symbol}\n\nRetrieve the observation symbols of the component.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.hasinsym","page":"API","title":"NetworkDynamics.hasinsym","text":"hasinsym(c::ComponentModel)\n\nChecks if the optioan field insym is present in the component model.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.insym","page":"API","title":"NetworkDynamics.insym","text":"insym(c::VertexModel)::Vector{Symbol}\ninsym(c::EdgeModel)::@NamedTuple{src::Vector{Symbol}, dst::Vector{Symbol}}\n\nMusst be called after hasinsym/hasindim returned true. Gives the insym vector(s). For vertex model just a single vector, for edges it returns a named tuple (; src, dst) with two symbol vectors.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.hasindim","page":"API","title":"NetworkDynamics.hasindim","text":"hasindim(c::ComponentModel)\n\nChecks if the optioan field insym is present in the component model.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.indim","page":"API","title":"NetworkDynamics.indim","text":"indim(c::VertexModel)::Int\nindim(c::EdgeModel)::@NamedTuple{src::Int,dst::Int}\n\nMusst be called after hasinsym/hasindim returned true. Gives the input dimension(s).\n\n\n\n\n\n","category":"function"},{"location":"API/#FeedForwardType-Traits","page":"API","title":"FeedForwardType-Traits","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"FeedForwardType\nPureFeedForward\nFeedForward\nNoFeedForward\nPureStateMap","category":"page"},{"location":"API/#NetworkDynamics.FeedForwardType","page":"API","title":"NetworkDynamics.FeedForwardType","text":"abstract type FeedForwardType end\n\nAbstract supertype for the FeedForwardType traits.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.PureFeedForward","page":"API","title":"NetworkDynamics.PureFeedForward","text":"PureFeedForward <: FeedForwardType\n\nTrait for component output functions g that have pure feed forward behavior (do not depend on x):\n\ng!(outs..., ins..., p, t)\n\nSee also FeedForward, NoFeedForward and PureStateMap.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.FeedForward","page":"API","title":"NetworkDynamics.FeedForward","text":"FeedForward <: FeedForwardType\n\nTrait for component output functions g that have feed forward behavior. May depend on everything:\n\ng!(outs..., x, ins..., p, t)\n\nSee also PureFeedForward, NoFeedForward and PureStateMap.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.NoFeedForward","page":"API","title":"NetworkDynamics.NoFeedForward","text":"NoFeedForward <: FeedForwardType\n\nTrait for component output functions g that have no feed forward behavior (do not depend on inputs):\n\ng!(outs..., x, p, t)\n\nSee also PureFeedForward, FeedForward and PureStateMap.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.PureStateMap","page":"API","title":"NetworkDynamics.PureStateMap","text":"PureStateMap <: FeedForwardType\n\nTrait for component output functions g that only depends on state:\n\ng!(outs..., x)\n\nSee also PureFeedForward, FeedForward and NoFeedForward.\n\n\n\n\n\n","category":"type"},{"location":"API/#Symbolic-Indexing-API","page":"API","title":"Symbolic Indexing API","text":"","category":"section"},{"location":"API/#Network-Parameter-Object","page":"API","title":"Network Parameter Object","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"NWParameter\nNWParameter(::Any)\nNWParameter(::NWParameter)\nNWParameter(::SciMLBase.DEIntegrator)","category":"page"},{"location":"API/#NetworkDynamics.NWParameter","page":"API","title":"NetworkDynamics.NWParameter","text":"NWParameter(nw_or_nw_wraper, pflat)\n\nIndexable wrapper for flat parameter array pflat. Needs Network or wrapper of Network, e.g. ODEProblem.\n\np = NWParameter(nw)\np.v[idx, :sym] # get parameter :sym of vertex idx\np.e[idx, :sym] # get parameter :sym of edge idx\np[s::Union{VPIndex, EPIndex}] # get parameter for specific index\n\nGet flat array representation using pflat(p).\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.NWParameter-Tuple{Any}","page":"API","title":"NetworkDynamics.NWParameter","text":"NWParameter(nw_or_nw_wraper;\n ptype=Vector{Float64}, pfill=filltype(ptype), default=true)\n\nCreates \"empty\" NWParameter object for the Network/Wrapper nw with flat type ptype. The array will be prefilled with pfill (defaults to NaN).\n\nIf default=true the default parameter values attached to the network components will be loaded.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.NWParameter-Tuple{NWParameter}","page":"API","title":"NetworkDynamics.NWParameter","text":"NWParameter(p::NWParameter; ptype=typeof(p.pflat))\n\nCreate NWParameter based on other parameter object, just convert type.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.NWParameter-Tuple{SciMLBase.DEIntegrator}","page":"API","title":"NetworkDynamics.NWParameter","text":"NWParameter(int::SciMLBase.DEIntegrator)\n\nCreate NWParameter object from integrator.\n\n\n\n\n\n","category":"method"},{"location":"API/#Network-State-Object","page":"API","title":"Network State Object","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"NWState\nNWState(::Any)\nNWState(::NWState)\nNWState(::NWParameter)\nNWState(::SciMLBase.DEIntegrator)\nuflat\npflat","category":"page"},{"location":"API/#NetworkDynamics.NWState","page":"API","title":"NetworkDynamics.NWState","text":"NWState(nw_or_nw_wrapper, uflat, [pflat], [t])\n\nIndexable wrapper for flat state & parameter array. Needs Network or wrapper of Network, e.g. ODEProblem.\n\ns = NWState(nw)\ns.v[idx, :sym] # get state :sym of vertex idx\ns.e[idx, :sym] # get state :sym of edge idx\ns.p.v[idx, :sym] # get parameter :sym of vertex idx\ns.p.e[idx, :sym] # get parameter :sym of edge idx\ns[s::Union{VIndex, EIndex, EPIndex, VPIndex}] # get parameter for specific index\n\nGet flat array representation using uflat(s) and pflat(s).\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.NWState-Tuple{Any}","page":"API","title":"NetworkDynamics.NWState","text":"NWState(nw_or_nw_wrapper;\n utype=Vector{Float64}, ufill=filltype(utype),\n ptype=Vector{Float64}, pfill=filltype(ptype), default=true)\n\nCreates \"empty\" NWState object for the Network/Wrapper nw with flat types utype & ptype. The arrays will be prefilled with ufill and pfill respectively (defaults to NaN).\n\nIf default=true the default state & parameter values attached to the network components will be loaded.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.NWState-Tuple{NWState}","page":"API","title":"NetworkDynamics.NWState","text":"NWState(p::NWState; utype=typeof(uflat(s)), ptype=typeof(pflat(s)))\n\nCreate NWState based on other state object, just convert types.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.NWState-Tuple{NWParameter}","page":"API","title":"NetworkDynamics.NWState","text":"NWState(p::NWParameter; utype=Vector{Float64}, ufill=filltype(utype), default=true)\n\nCreate NWState based on existing NWParameter object.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.NWState-Tuple{SciMLBase.DEIntegrator}","page":"API","title":"NetworkDynamics.NWState","text":"NWState(int::SciMLBase.DEIntegrator)\n\nCreate NWState object from integrator.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.uflat","page":"API","title":"NetworkDynamics.uflat","text":"uflat(s::NWState)\n\nRetrieve the wrapped flat array representation of the state.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.pflat","page":"API","title":"NetworkDynamics.pflat","text":"pflat(p::NWParameter)\npflat(s::NWState)\n\nRetrieve the wrapped flat array representation of the parameters.\n\n\n\n\n\n","category":"function"},{"location":"API/#Symbolic-Indices","page":"API","title":"Symbolic Indices","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"VIndex\nEIndex\nVPIndex\nEPIndex","category":"page"},{"location":"API/#NetworkDynamics.VIndex","page":"API","title":"NetworkDynamics.VIndex","text":"VIndex{C,S} <: SymbolicStateIndex{C,S}\nidx = VIndex(comp, sub)\n\nA symbolic index for a vertex state variable.\n\ncomp: the component index, either int or a collection of ints\nsub: the subindex, either int, symbol or a collection of those.\n\nVIndex(1, :P) # vertex 1, variable :P\nVIndex(1:5, 1) # first state of vertices 1 to 5\nVIndex(7, (:x,:y)) # states :x and :y of vertex 7\n\nCan be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWState, NWParameter or ODESolution.\n\nSee also: EIndex, VPIndex, EPIndex\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.EIndex","page":"API","title":"NetworkDynamics.EIndex","text":"EIndex{C,S} <: SymbolicStateIndex{C,S}\nidx = EIndex(comp, sub)\n\nA symbolic index for an edge state variable.\n\ncomp: the component index, either int or a collection of ints\nsub: the subindex, either int, symbol or a collection of those.\n\nEIndex(1, :P) # edge 1, variable :P\nEIndex(1:5, 1) # first state of edges 1 to 5\nEIndex(7, (:x,:y)) # states :x and :y of edge 7\n\nCan be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWState, NWParameter or ODESolution.\n\nSee also: VIndex, VPIndex, EPIndex\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.VPIndex","page":"API","title":"NetworkDynamics.VPIndex","text":"VPIndex{C,S} <: SymbolicStateIndex{C,S}\nidx = VPIndex(comp, sub)\n\nA symbolic index into the parameter a vertex:\n\ncomp: the component index, either int or a collection of ints\nsub: the subindex, either int, symbol or a collection of those.\n\nCan be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWParameter or ODEProblem.\n\nSee also: EPIndex, VIndex, EIndex\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.EPIndex","page":"API","title":"NetworkDynamics.EPIndex","text":"EPIndex{C,S} <: SymbolicStateIndex{C,S}\nidx = VEIndex(comp, sub)\n\nA symbolic index into the parameter a vertex:\n\ncomp: the component index, either int or a collection of ints\nsub: the subindex, either int, symbol or a collection of those.\n\nCan be used to index into objects supporting the SymbolicIndexingInterface, e.g. NWParameter or ODEProblem.\n\nSee also: VPIndex, VIndex, EIndex\n\n\n\n\n\n","category":"type"},{"location":"API/#Index-generators","page":"API","title":"Index generators","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"vidxs\neidxs\nvpidxs\nepidxs","category":"page"},{"location":"API/#NetworkDynamics.vidxs","page":"API","title":"NetworkDynamics.vidxs","text":"vidxs([inpr], components=:, variables=:) :: Vector{VIndex}\n\nGenerate vector of symbolic indexes for vertices.\n\ninpr: Only needed for name matching or : access. Can be Network, sol, prob, ...\ncomponents: Number/Vector, :, Symbol (name matches), String/Regex (name contains)\nvariables: Symbol/Number/Vector, :, String/Regex (all sym containing)\n\nExamples:\n\nvidxs(nw) # all vertex state indices\nvidxs(1:2, :u) # [VIndex(1, :u), VIndex(2, :u)]\nvidxs(nw, :, [:u, :v]) # [VIndex(i, :u), VIndex(i, :v) for i in 1:nv(nw)]\nvidxs(nw, \"ODEVertex\", :) # all symbols of all vertices with name containing \"ODEVertex\"\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.eidxs","page":"API","title":"NetworkDynamics.eidxs","text":"vidxs([inpr], components=:, variables=:) :: Vector{EIndex}\n\nGenerate vector of symbolic indexes for edges.\n\ninpr: Only needed for name matching or : access. Can be Network, sol, prob, ...\ncomponents: Number/Vector, :, Symbol (name matches), String/Regex (name contains)\nvariables: Symbol/Number/Vector, :, String/Regex (all sym containing)\n\nExamples:\n\neidxs(nw) # all edge state indices\neidxs(1:2, :u) # [EIndex(1, :u), EIndex(2, :u)]\neidxs(nw, :, [:u, :v]) # [EIndex(i, :u), EIndex(i, :v) for i in 1:ne(nw)]\neidxs(nw, \"FlowEdge\", :) # all symbols of all edges with name containing \"FlowEdge\"\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.vpidxs","page":"API","title":"NetworkDynamics.vpidxs","text":"vpidxs([inpr], components=:, variables=:) :: Vector{VPIndex}\n\nGenerate vector of symbolic indexes for parameters. See vidxs for more information.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.epidxs","page":"API","title":"NetworkDynamics.epidxs","text":"epidxs([inpr], components=:, variables=:) :: Vector{EPIndex}\n\nGenerate vector of symbolic indexes for parameters. See eidxs for more information.\n\n\n\n\n\n","category":"function"},{"location":"API/#Metadata-API","page":"API","title":"Metadata API","text":"","category":"section"},{"location":"API/#Component-Metadata-API","page":"API","title":"Component Metadata API","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"metadata\nhas_metadata(::NetworkDynamics.ComponentModel, ::Symbol)\nget_metadata(::NetworkDynamics.ComponentModel, ::Symbol)\nset_metadata!(::NetworkDynamics.ComponentModel, ::Symbol, ::Any)\nhas_graphelement\nget_graphelement\nset_graphelement!","category":"page"},{"location":"API/#NetworkDynamics.metadata","page":"API","title":"NetworkDynamics.metadata","text":"metadata(c::ComponentModel)\n\nRetrieve metadata object for the component.\n\nSee also metadata\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.has_metadata-Tuple{NetworkDynamics.ComponentModel, Symbol}","page":"API","title":"NetworkDynamics.has_metadata","text":"has_metadata(c::ComponentModel, key::Symbol)\n\nChecks if metadata key is present for the component.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.get_metadata-Tuple{NetworkDynamics.ComponentModel, Symbol}","page":"API","title":"NetworkDynamics.get_metadata","text":"get_metadata(c::ComponentModel, key::Symbol)\n\nRetrieves the metadata key for the component.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.set_metadata!-Tuple{NetworkDynamics.ComponentModel, Symbol, Any}","page":"API","title":"NetworkDynamics.set_metadata!","text":"set_metadata!(c::ComponentModel, key::Symbol, value)\n\nSets the metadata key for the component to value.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.has_graphelement","page":"API","title":"NetworkDynamics.has_graphelement","text":"has_graphelement(c)\n\nChecks if the edge or vetex function function has the graphelement metadata.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_graphelement","page":"API","title":"NetworkDynamics.get_graphelement","text":"get_graphelement(c::EdgeModel)::@NamedTuple{src::T, dst::T}\nget_graphelement(c::VertexModel)::Int\n\nRetrieves the graphelement metadata for the component model. For edges this returns a named tupe (;src, dst) where both are either integers (vertex index) or symbols (vertex name).\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.set_graphelement!","page":"API","title":"NetworkDynamics.set_graphelement!","text":"set_graphelement!(c::EdgeModel, src, dst)\nset_graphelement!(c::VertexModel, vidx)\n\nSets the graphelement metadata for the edge model. For edges this takes two arguments src and dst which are either integer (vertex index) or symbol (vertex name). For vertices it takes a single integer vidx.\n\n\n\n\n\n","category":"function"},{"location":"API/#Per-Symbol-Metadata-API","page":"API","title":"Per-Symbol Metadata API","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"symmetadata\nget_metadata(::NetworkDynamics.ComponentModel, ::Symbol, ::Symbol)\nhas_metadata(::NetworkDynamics.ComponentModel, ::Symbol, ::Symbol)\nset_metadata!(::NetworkDynamics.ComponentModel, ::Symbol, ::Symbol, ::Any)\nhas_default\nget_default\nset_default!\nhas_guess\nget_guess\nset_guess!\nhas_init\nget_init\nset_init!\nhas_bounds\nget_bounds\nset_bounds!","category":"page"},{"location":"API/#NetworkDynamics.symmetadata","page":"API","title":"NetworkDynamics.symmetadata","text":"symmetadata(c::ComponentModel)::Dict{Symbol,Dict{Symbol,Any}}\n\nRetrieve the metadata dictionary for the symbols. Keys are the names of the symbols as they appear in sym, psym, obssym and insym.\n\nSee also symmetadata\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_metadata-Tuple{NetworkDynamics.ComponentModel, Symbol, Symbol}","page":"API","title":"NetworkDynamics.get_metadata","text":"get_metadata(c::ComponentModel, sym::Symbol, key::Symbol)\n\nRetrievs the metadata key for symbol sym.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.has_metadata-Tuple{NetworkDynamics.ComponentModel, Symbol, Symbol}","page":"API","title":"NetworkDynamics.has_metadata","text":"has_metadata(c::ComponentModel, sym::Symbol, key::Symbol)\n\nChecks if symbol metadata key is present for symbol sym.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.set_metadata!-Tuple{NetworkDynamics.ComponentModel, Symbol, Symbol, Any}","page":"API","title":"NetworkDynamics.set_metadata!","text":"set_metadata!(c::ComponentModel, sym::Symbol, key::Symbol, value)\nset_metadata!(c::ComponentModel, sym::Symbol, pair)\n\nSets the metadata key for symbol sym to value.\n\n\n\n\n\n","category":"method"},{"location":"API/#NetworkDynamics.has_default","page":"API","title":"NetworkDynamics.has_default","text":"has_default(c::ComponentModel, sym::Symbol)\n\nChecks if a default value is present for symbol sym.\n\nSee also get_default, set_default!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_default","page":"API","title":"NetworkDynamics.get_default","text":"get_default(c::ComponentModel, sym::Symbol)\n\nReturns the default value for symbol sym.\n\nSee also has_default, set_default!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.set_default!","page":"API","title":"NetworkDynamics.set_default!","text":"set_default(c::ComponentModel, sym::Symbol, value)\n\nSets the default value for symbol sym to value.\n\nSee also has_default, get_default.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.has_guess","page":"API","title":"NetworkDynamics.has_guess","text":"has_guess(c::ComponentModel, sym::Symbol)\n\nChecks if a guess value is present for symbol sym.\n\nSee also get_guess, set_guess!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_guess","page":"API","title":"NetworkDynamics.get_guess","text":"get_guess(c::ComponentModel, sym::Symbol)\n\nReturns the guess value for symbol sym.\n\nSee also has_guess, set_guess!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.set_guess!","page":"API","title":"NetworkDynamics.set_guess!","text":"set_guess(c::ComponentModel, sym::Symbol, value)\n\nSets the guess value for symbol sym to value.\n\nSee also has_guess, get_guess.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.has_init","page":"API","title":"NetworkDynamics.has_init","text":"has_init(c::ComponentModel, sym::Symbol)\n\nChecks if a init value is present for symbol sym.\n\nSee also get_init, set_init!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_init","page":"API","title":"NetworkDynamics.get_init","text":"get_init(c::ComponentModel, sym::Symbol)\n\nReturns the init value for symbol sym.\n\nSee also has_init, set_init!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.set_init!","page":"API","title":"NetworkDynamics.set_init!","text":"set_init(c::ComponentModel, sym::Symbol, value)\n\nSets the init value for symbol sym to value.\n\nSee also has_init, get_init.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.has_bounds","page":"API","title":"NetworkDynamics.has_bounds","text":"has_bounds(c::ComponentModel, sym::Symbol)\n\nChecks if a bounds value is present for symbol sym.\n\nSee also get_bounds, set_bounds!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.get_bounds","page":"API","title":"NetworkDynamics.get_bounds","text":"get_bounds(c::ComponentModel, sym::Symbol)\n\nReturns the bounds value for symbol sym.\n\nSee also has_bounds, set_bounds!.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.set_bounds!","page":"API","title":"NetworkDynamics.set_bounds!","text":"set_bounds(c::ComponentModel, sym::Symbol, value)\n\nSets the bounds value for symbol sym to value.\n\nSee also has_bounds, get_bounds.\n\n\n\n\n\n","category":"function"},{"location":"API/#Initialization","page":"API","title":"Initialization","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"find_fixpoint\ninitialize_component!\ninit_residual","category":"page"},{"location":"API/#NetworkDynamics.find_fixpoint","page":"API","title":"NetworkDynamics.find_fixpoint","text":"find_fixpoint(nw::Network, [x0::NWState=NWState(nw)], [p::NWParameter=x0.p]; kwargs...)\nfind_fixpoint(nw::Network, x0::AbstractVector, p::AbstractVector; kwargs...)\nfind_fixpoint(nw::Network, x0::AbstractVector; kwargs...)\n\nConvenience wrapper around SteadyStateProblem from SciML-ecosystem. Constructs and solves the steady state problem, returns found value wrapped as NWState.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.initialize_component!","page":"API","title":"NetworkDynamics.initialize_component!","text":"initialize_component!(cf::ComponentModel; verbose=true, kwargs...)\n\nInitialize a ComponentModel by solving the corresponding NonlinearLeastSquaresProblem. During initialization, everyting which has a default value (see Metadata) is considered \"fixed\". All other variables are considered \"free\" and are solved for. The initial guess for each variable depends on the guess value in the Metadata.\n\nThe result is stored in the ComponentModel itself. The values of the free variables are stored in the metadata field init.\n\nThe kwargs are passed to the nonlinear solver.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.init_residual","page":"API","title":"NetworkDynamics.init_residual","text":"init_residual(cf::T; t=NaN, recalc=false)\n\nCalculates the residual |du| for the given component model for the values provided via default and init Metadata.\n\nIf recalc=false just return the residual determined in the actual initialization process.\n\nSee also initialize_component!.\n\n\n\n\n\n","category":"function"},{"location":"API/#Execution-Types","page":"API","title":"Execution Types","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"ExecutionStyle\nSequentialExecution\nPolyesterExecution\nThreadedExecution\nKAExecution","category":"page"},{"location":"API/#NetworkDynamics.ExecutionStyle","page":"API","title":"NetworkDynamics.ExecutionStyle","text":"abstract type ExecutionStyle{buffered::Bool} end\n\nAbstract type for execution style. The coreloop dispatches based on the Execution style stored in the network object.\n\nbuffered=true means that the edge input es explicitly gathered, i.e. the vertex outputs in the output buffer will be copied into a dedicated input buffer for the edges.\nbuffered=false means, that the edge inputs are not explicitly gathered, but the corloop will perform a redirected lookup into the output buffer.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.SequentialExecution","page":"API","title":"NetworkDynamics.SequentialExecution","text":"struct SequentialExecution{buffered::Bool}\n\nSequential execution, no parallelism. For buffered see ExecutionStyle.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.PolyesterExecution","page":"API","title":"NetworkDynamics.PolyesterExecution","text":"struct PolyesterExecution{buffered}\n\nParallel execution using Polyester.jl. For buffered see ExecutionStyle.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.ThreadedExecution","page":"API","title":"NetworkDynamics.ThreadedExecution","text":"struct ThreadedExecution{buffered}\n\nParallel execution using Julia threads. For buffered see ExecutionStyle.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.KAExecution","page":"API","title":"NetworkDynamics.KAExecution","text":"struct KAExecution{buffered}\n\nParallel execution using KernelAbstractions.jl. Works with GPU and CPU arrays. For buffered see ExecutionStyle.\n\n\n\n\n\n","category":"type"},{"location":"API/#Aggregators","page":"API","title":"Aggregators","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"Aggregator\nSequentialAggregator\nSparseAggregator\nThreadedAggregator\nPolyesterAggregator\nKAAggregator","category":"page"},{"location":"API/#NetworkDynamics.Aggregator","page":"API","title":"NetworkDynamics.Aggregator","text":"abstract type Aggregator end\n\nAbstract sypertype for aggregators. Aggregators operate on the output buffer of all components and fill the aggregation buffer with the aggregatated edge values per vertex.\n\nAll aggregators have the constructor\n\nAggegator(aggfun)\n\nfor example\n\nSequentialAggreator(+)\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.SequentialAggregator","page":"API","title":"NetworkDynamics.SequentialAggregator","text":"SequentialAggregator(aggfun)\n\nSequential aggregation.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.SparseAggregator","page":"API","title":"NetworkDynamics.SparseAggregator","text":"SparseAggregator(+)\n\nOnly works with additive aggregation +. Aggregates via sparse inplace matrix multiplication. Works with GPU Arrays.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.ThreadedAggregator","page":"API","title":"NetworkDynamics.ThreadedAggregator","text":"ThreadedAggregator(aggfun)\n\nParallel aggregation using Julia threads.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.PolyesterAggregator","page":"API","title":"NetworkDynamics.PolyesterAggregator","text":"PolyesterAggregator(aggfun)\n\nParallel aggregation using Polyester.jl.\n\n\n\n\n\n","category":"type"},{"location":"API/#NetworkDynamics.KAAggregator","page":"API","title":"NetworkDynamics.KAAggregator","text":"KAAggregator(aggfun)\n\nParallel aggregation using KernelAbstractions.jl. Works with both GPU and CPU arrays.\n\n\n\n\n\n","category":"type"},{"location":"API/#Utils","page":"API","title":"Utils","text":"","category":"section"},{"location":"API/","page":"API","title":"API","text":"save_parameters!\nff_to_constraint\nBase.copy(::NetworkDynamics.ComponentModel)","category":"page"},{"location":"API/#NetworkDynamics.save_parameters!","page":"API","title":"NetworkDynamics.save_parameters!","text":"save_parameters!(integrator::SciMLBase.DEIntegrator)\n\nSave the current parameter values in the integrator. Call this function inside callbacks if the parameter values have changed. This will store a timeseries of said parameters in the solution object, thus alowing us to recosntruct observables which depend on time-dependet variables.\n\n\n\n\n\n","category":"function"},{"location":"API/#NetworkDynamics.ff_to_constraint","page":"API","title":"NetworkDynamics.ff_to_constraint","text":"ff_to_constraint(v::VertexModel)\n\nTakes VertexModel v with feed forward and turns all algebraic output states into internal states by defining algebraic constraints contraints 0 = out - g(...). The new output function is just a StateMask into the extended internal state vector.\n\nReturns the transformed VertexModel.\n\n\n\n\n\n","category":"function"},{"location":"API/#Base.copy-Tuple{NetworkDynamics.ComponentModel}","page":"API","title":"Base.copy","text":"copy(c::NetworkDynamics.ComponentModel)\n\nShallow copy of the component model. Creates a deepcopy of metadata and symmetadata but references the same objects everywhere else.\n\n\n\n\n\n","category":"method"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"EditURL = \"../../examples/cascading_failure.jl\"","category":"page"},{"location":"generated/cascading_failure/#Cascading-Failure","page":"Cascading Failure","title":"Cascading Failure","text":"","category":"section"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"This script reimplements the minimal example of a dynamic cascading failure described in Schäfer et al. (2018) [1]. In is an example how to use callback functions to change network parameters. In this case to disable certain lines. This script can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"[1] Schäfer, B., Witthaut, D., Timme, M., & Latora, V. (2018). Dynamically induced cascading failures in power grids. Nature communications, 9(1), 1-13. https://www.nature.com/articles/s41467-018-04287-5","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"The system is modeled using swing equation and active power edges. The nodes are characterized by the voltage angle δ, the active power on each line is symmetric and a function of the difference between source and destination angle δ_src - δ_dst.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"using NetworkDynamics\nusing Graphs\nusing OrdinaryDiffEqTsit5\nusing DiffEqCallbacks\nusing Plots\nusing Test #hide\nimport SymbolicIndexingInterface as SII","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"For the nodes we define the swing equation. State v[1] = δ, v[2] = ω. The swing equation has three parameters: p = (P_ref, I, γ) where P_ref is the power setpopint, I is the inertia and γ is the droop or damping coeficcient.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"The output of the node is just the first state. g=1 is a shorthand for g=StateMask(1:1) which implements a trivial output function g which just takes the first element of the state vector.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"function swing_equation(dv, v, esum, p,t)\n P, I, γ = p\n dv[1] = v[2]\n dv[2] = P - γ * v[2] .+ esum[1]\n dv[2] = dv[2] / I\n nothing\nend\nvertex = VertexModel(f=swing_equation, g=1, sym=[:δ, :ω], psym=[:P_ref, :I=>1, :γ=>0.1])","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"Lets define a simple purely active power line whose active power flow is completlye determined by the connected voltage angles and the coupling constant K. We give an additonal parameter, the line limit, which we'll use later in the callback.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"function simple_edge(e, v_s, v_d, (K,), t)\n e[1] = K * sin(v_s[1] - v_d[1])\nend\nedge = EdgeModel(;g=AntiSymmetric(simple_edge), outsym=:P, psym=[:K=>1.63, :limit=>1])","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"With the definition of the graph topology we can build the Network object:","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"g = SimpleGraph([0 1 1 0 1;\n 1 0 1 1 0;\n 1 1 0 1 0;\n 0 1 1 0 1;\n 1 0 0 1 0])\nswing_network = Network(g, vertex, edge)","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"For the parameters, we create the NWParameter object prefilled with default p values","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"p = NWParameter(swing_network)\n# vertices 1, 3 and 4 act as loads\np.v[(1,3,4), :P_ref] .= -1\n# vertices 2 and 5 act as generators\np.v[(2,5), :P_ref] .= 1.5\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"We can use find_fixpoint to find a valid initial condition of the network","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"u0 = find_fixpoint(swing_network, p)\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"In order to implement the line failures, we need to create a VectorContinousCallback. In the callback, we compare the current flow on the line with the limit. If the limit is reached, the coupling K is set to 0.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"First we can define the affect function:","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"function affect!(integrator, idx)\n println(\"Line $idx tripped at t=$(integrator.t)\")\n p = NWParameter(integrator) # get indexable parameter object\n p.e[idx, :K] = 0\n auto_dt_reset!(integrator)\n save_parameters!(integrator)\n nothing\nend\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"There is one important aspect to this function: the save_parameters! call. In the callback, we change the parameters of the network, making the parameters time dependent. The flow on the line is a function P(t) = f(u(t), p(t)). Thus we need to inform the integrator, that a discrete change in parameters happend. With this, the solution object not only tracks u(t) but also p(t) and we may extract the observable P(t) directly.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"The callback trigger condition is a bit more complicated. The straight forward version looks like this:","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"function naive_condition(out, u, t, integrator)\n # careful, u != integrator.u\n # therefore construct nwstate with Network info from integrator but u\n s = NWState(integrator, u, integrator.p, t)\n for i in eachindex(out)\n out[i] = abs(s.e[i,:P]) - s.p.e[1,:limit] # compare flow with limit for line\n end\n nothing\nend\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"However, from a performacne perspectiv there are problems with this solution: on every call, we need to perform symbolic indexing into the NWState object. Symbolic indexing is not cheap, as it requires to gather meta data about the network. Luckily, the SymbolicIndexingInterface package which powers the symbolic indexing provides the lower level functions getp and getu which can be used to create and cache accessors to the internal states.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"This still isn't ideal beacuse both getlim and getflow getters will create arrays within the callback. But is far better then resolving the flat state indices every time.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"condition = let getlim = SII.getp(swing_network, epidxs(swing_network, :, :limit)),\n getflow = SII.getu(swing_network, eidxs(swing_network, :, :P))\n function (out, u, t, integrator)\n # careful, u != integrator.u\n # therefore construct nwstate with Network info from integrator but u\n s = NWState(integrator, u, integrator.p, t)\n out .= getlim(s) .- abs.(getflow(s))\n nothing\n end\nend\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"We can combine affect and condition to form the callback.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"trip_cb = VectorContinuousCallback(condition, affect!, ne(g));\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"However, there is another component missing. If we look at the powerflow on the lines in the initial steady state","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"u0.e[:, :P]","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"We see that every flow is below the trip value 1.0. Therefor we need to add a distrubance to the network. We do this by manually disabeling line 5 at time 1.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"trip_first_cb = PresetTimeCallback(1.0, integrator->affect!(integrator, 5));\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"With those components, we can create the problem and solve it.","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"prob = ODEProblem(swing_network, uflat(u0), (0,6), copy(pflat(p));\n callback=CallbackSet(trip_cb, trip_first_cb))\nsol = solve(prob, Tsit5());\n# we want to test the reconstruction of the observables # hide\n@test all(!iszero, sol(sol.t; idxs=eidxs(sol,:,:P))[begin]) # hide\n@test all(iszero, sol(sol.t; idxs=eidxs(sol,:,:P))[end][[1:5...,7]]) # hide\nnothing #hide","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"Through the magic of symbolic indexing we can plot the power flows on all lines:","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"plot(sol; idxs=eidxs(sol,:,:P))","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"","category":"page"},{"location":"generated/cascading_failure/","page":"Cascading Failure","title":"Cascading Failure","text":"This page was generated using Literate.jl.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"EditURL = \"../../examples/gas_network.jl\"","category":"page"},{"location":"generated/gas_network/#Dynamic-Flow-in-simple-Gas-Network","page":"Gas Network","title":"Dynamic Flow in simple Gas Network","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"This Example is based on the paper","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Albertus J. Malan, Lukas Rausche, Felix Strehle, Sören Hohmann, Port-Hamiltonian Modelling for Analysis and Control of Gas Networks, IFAC-PapersOnLine, Volume 56, Issue 2, 2023, https://doi.org/10.1016/j.ifacol.2023.10.193.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"and tries replicate a simple simulation of flow in a 3-node gas network.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"This example can be dowloaded as a normal Julia script here.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"We start by importing the necessary packages:","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"using NetworkDynamics\nusing ModelingToolkit\nusing DynamicQuantities\nusing ModelingToolkit: D as Dt, t as t\nusing Test\nusing StaticArrays\nusing LinearInterpolations\nusing OrdinaryDiffEqTsit5\nusing CairoMakie\nCairoMakie.activate!(type=\"svg\") #hide","category":"page"},{"location":"generated/gas_network/#Node-Models","page":"Gas Network","title":"Node Models","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"In this example, we use the equation based modeling using ModelingToolkit.jl. To verify the equations on a basic level we also provide units to eveything to perform dimensionality checks.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"There are 2 node models used in the paper. The first node type has a constant pressure. Additionally, we ad some \"internal\" state q̃_inj which we want to plot later (see also Observables).","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@mtkmodel ConstantPressureNode begin\n @parameters begin\n p_set, [description=\"Constant pressure setpoint\", unit=u\"Pa\"]\n end\n @variables begin\n p(t) = p_set, [description=\"Pressure\", unit=u\"Pa\", output=true]\n q̃_nw(t), [description=\"aggregated flow from pipes into node\", unit=u\"m^3/s\", input=true]\n q̃_inj(t), [description=\"internal state for introspection\", unit=u\"m^3/s\"]\n end\n @equations begin\n p ~ p_set\n q̃_inj ~ -q̃_nw\n end\nend\nnothing #hide","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The second node model is a variable pressure node. It has one output state (the pressure) and one input state, the aggregated flows from the connected pipes. As an internal state we have the injected flow from our source/load. The source/load behaviour itself is provided via a time dependent function.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@mtkmodel VariablePressureNode begin\n @structural_parameters begin\n load_profile # time dependent load profile\n end\n @parameters begin\n C, [description=\"Lumped capacitance of connected pipes\", unit=u\"m^4 * s^2 / kg\"]\n end\n @variables begin\n p(t)=5e6, [description=\"Pressure\", unit=u\"Pa\", output=true]\n q̃_inj(t), [description=\"external injection into node\", unit=u\"m^3/s\"]\n q̃_nw(t), [description=\"aggregated flow from pipes into node\", unit=u\"m^3/s\", input=true]\n end\n @equations begin\n q̃_inj ~ load_profile(t)\n C * Dt(p) ~ q̃_inj + q̃_nw # (30)\n end\nend\nnothing #hide","category":"page"},{"location":"generated/gas_network/#Pipe-Model","page":"Gas Network","title":"Pipe Model","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The pipe is modeld as a first order ODE for the volumetric flow at the dst end. It has two inputs: the pressure at the source and and the pressure at the destination end. Later on, we'll specify the model to be antisymmetric, thus the flow is calculated explicitly for the destination end, but the source end will just recive just that times (-1).","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@mtkmodel Pipe begin\n @parameters begin\n L, [description=\"Length of pipe\", unit=u\"m\"]\n D, [description=\"Diameter of pipe\", unit=u\"m\"]\n A, [description=\"Cross-sectional area of pipe\", unit=u\"m^2\"]\n sinθ, [description=\"Angle of inclination\" ]\n γ, [description=\"Friction efficiency factor\"]\n η, [description=\"Dynamic viscosity\", unit=u\"kg/(m*s)\"]\n r, [description=\"Pipe roughness\", unit=u\"m\"]\n g, [description=\"Gravitational acceleration\", unit=u\"m/s^2\"]\n T, [description=\"simulation temperature\", unit=u\"K\"]\n Tc, [description=\"crictical temperature\", unit=u\"K\"]\n pc, [description=\"critical pressure\", unit=us\"Pa\"]\n Rs, [description=\"Specific gas constant for natural gas\", unit=us\"J/(kg*K)\"]\n c̃, [description=\"Speed of sound in fluid at standard conditions\", unit=u\"m/s\"]\n ρ̃, [description=\"standard density\", unit=u\"kg/m^3\"]\n p̃, [description=\"standard pressure\", unit=us\"Pa\"]\n end\n @variables begin\n p_src(t), [description=\"Pressure at source end\", unit=us\"Pa\", input=true]\n p_dst(t), [description=\"Pressure at destination end\", unit=us\"Pa\", input=true]\n q̃(t)=1, [description=\"Flow through pipe\", unit=u\"m^3/s\", output=true]\n Re(t), [description=\"Reynolds number\"]\n λ(t), [description=\"Friction factor\"]\n λe(t), [description=\"Effective friction factor\"]\n pM(t), [description=\"mean pressure\", unit=us\"Pa\"]\n Z(t), [description=\"compressibility factor\"]\n ρ(t), [description=\"density\", unit=u\"kg/m^3\"]\n c(t), [description=\"speed of sound\", unit=u\"m/s\"]\n end\n @equations begin\n Z ~ 1 - 3.52 * pM/pc * exp(-2.26*(T/Tc)) + 0.274 * (pM/pc)^2 * exp(-1.878*(T/Tc)) # (5)\n ρ ~ pM / (Rs * T * Z) # (4)\n\n # TODO: Whats the correct speed of sound?\n c ~ sqrt(T * Rs * Z) # (4) # pressure/temp dependent\n # c ~ c̃ # \"standard\" speed of sound based on standard conditions\n\n # TODO: Whats the correct Reynolds number?\n Re ~ (ρ * abs(q̃*p̃/pM) * D) / (η * A) # (6) # based \"actual\" conditions\n # Re ~ (ρ̃ * abs(q̃) * D) / (η * A) # (6) # based on standard conditions\n\n λ ~ ifelse(Re < 2300,\n 64/Re, # laminar (7)\n (2*log10(4.518/Re * log10(Re/7) + r/(3.71*D)))^(-2) # turbulent (8)\n )\n λe ~ λ/γ^2 # (10)\n pM ~ 2/3*(p_src + p_dst - (p_src*p_dst)/(p_src + p_dst)) # (20)\n\n Dt(q̃) ~ A/(L*ρ̃)*(-(λe * ρ̃^2 * c^2 * L * abs(q̃))/(2 * D * A^2 * pM) * q̃ - (g * L * sinθ)/(c^2) * pM + (p_src - p_dst)) # (31)\n end\nend\nnothing #hide","category":"page"},{"location":"generated/gas_network/#Parametrization","page":"Gas Network","title":"Parametrization","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The parameterization turned out to be a bit tricky. There might be errors in there.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Some of them are quite cleare and explicitly given.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"g = 9.81u\"m/s^2\" # that we just know\nRs = 518.28u\"J/(kg*K)\" # Specific gas constant for natural gas\nη = 1e-5u\"kg/(m*s)\" # Dynamic viscosity\npc = 46.5u\"bar\" # Critical pressure\np̃ = 1.01325u\"bar\" # standard pressure\nTc = 190.55u\"K\" # critical temperature\nT̃ = 273.15u\"K\" # standard temperature\nT = 278u\"K\" # simulation temperature\nγ = 0.98 # friction efficiency factor\nr = 0.012u\"mm\" # pipe roughness\nD = 0.6u\"m\" # pipe diameter\n\n# TODO: here is switched the lenths l12 and l13. The results are better. Is this a mistake in the paper?\nL₁₂ = 90u\"km\"\nL₁₃ = 80u\"km\"\nL₂₃ = 100u\"km\"\nΔh₁ = 0u\"km\" # this value is different for different sims in the paper\np₁_set = 50u\"bar\"\nnothing # hide","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The geometric parameters for the pipes can be directly derived.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"A = π/4 * D^2\nsinθ₁₂ = ustrip(Δh₁ / L₁₂)\nsinθ₁₃ = ustrip(Δh₁ / L₁₃)\nsinθ₂₃ = 0.0\nnothing # hide","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Lastly, we need to calculate the compressibility factor, the speed of sound and the density at standard conditions:","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Z̃ = 1 - 3.52 * p̃/pc * exp(-2.26*(T̃/Tc)) + 0.274 * (p̃/pc)^2 * exp(-1.878*(T̃/Tc)) # (5)\nc̃ = sqrt(T̃ * Rs * Z̃) # (4) at standard conditions\nρ̃ = p̃ / (Rs * T̃ * Z̃) # (4) at standard conditions\n\nnothing # hide","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The equivalent \"pressure capacity\" at the nodes is calculated as a sum of the connected pipe parameters according to (28).","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Here use defintions based on the speed and \"standard\" conditions.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"C₂ = L₁₂*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28)\nC₃ = L₁₃*A/(2*ρ̃*c̃^2) + L₂₃*A/(2*ρ̃*c̃^2) # (28)\nnothing #hide","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Alternatively, we could calculate Z2 and Z3 based on the actuel pressure and simulation temperature. Then we could calculated the speed of sound for the \"correct\" conditions at the node. It seems to have very little effect on the actual results so I kept it simple.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"nothing #hide","category":"page"},{"location":"generated/gas_network/#Load-Profile","page":"Gas Network","title":"Load Profile","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The paper specifies the load profile at two nodes. We use the package LinearInterpolations.jl to get a callable object which represents this picewise linear interpolation.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"However, this function is not Symbolics.jl compatible, so we need to stop Symbolics.jl/ModelingToolkit.jl from tracing it. To do so, we use @register_symbolic to declare it as a symbolic function which is treated as a blackbox.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Additionally, we need to tell ModelingToolkit about the units of this object. This is just used for the static unit check during construction of the model. Later one, when we generate the Julia code from the symbolic reepresentation all units will be stripped.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"note: Discontinuities in RHS\nThe picewise linear interpolated function creates discontinuities in the RHS of the system. However since we know the times exactly, we can handle this by simply giving a list of explicit tstops to the solve command, to make sure those are hit exactly.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"load2(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[20, 30, 10, 30, 20], extrapolate=LinearInterpolations.Constant(20))(t)\nload3(t) = -Interpolate(SA[0, 4, 12, 20, 24]*3600, SA[40, 50, 30, 50, 40], extrapolate=LinearInterpolations.Constant(40))(t)\n@register_symbolic load2(t)\n@register_symbolic load3(t)\nModelingToolkit.get_unit(op::typeof(load2), _) = u\"m^3/s\"\nModelingToolkit.get_unit(op::typeof(load3), _) = u\"m^3/s\"\nnothing #hide","category":"page"},{"location":"generated/gas_network/#Building-the-Network","page":"Gas Network","title":"Building the Network","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"To bild the Network we first need to define the components. This is a two step process:","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"first create the symbolic ODESystem using ModelingToolkit\nsecondly build a NetworkDynamics component model (VertexModel/EdgeModel) based on the symbolic system.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"In the first step we can use the keyword arguments to pass \"default\" values for our parameters and states. Those values will be automaticially transfered to the metadata of the component model the second step.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"The second step requires to define the interface variables, i.e. what are the \"input\" states of your component model and what are the \"output\" states. For VertexModel the input state is the aggregated flow of all connected pipes. The output state is the pressure of the node.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@named v1_mtk = ConstantPressureNode(p_set=p₁_set)\nv1 = VertexModel(v1_mtk, [:q̃_nw], [:p]; name=:v1, vidx=1)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@named v2_mtk = VariablePressureNode(C=C₂, load_profile=load2)\nv2 = VertexModel(v2_mtk, [:q̃_nw], [:p]; name=:v2, vidx=2)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@named v3_mtk = VariablePressureNode(C=C₃, load_profile=load3)\nv3 = VertexModel(v3_mtk, [:q̃_nw], [:p]; name=:v3, vidx=3)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"For the edge Model we have two inputs: the pressure on both source and destination end. There is a single output state: the volumetric flow. However we also need to tell NetworkDynamics about the coupling type. In this case we use AntiSymmetric, which meas that the source end will recieve the same flow, just inverted sign.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"@named e12_mtk = Pipe(; L=L₁₂, sinθ=sinθ₁₂, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)\n@named e13_mtk = Pipe(; L=L₁₃, sinθ=sinθ₁₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)\n@named e23_mtk = Pipe(; L=L₂₃, sinθ=sinθ₂₃, D, A, γ, η, r, g, T, Tc, pc, Rs, c̃, ρ̃, p̃)\n\ne12 = EdgeModel(e12_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e12, src=1, dst=2)\ne13 = EdgeModel(e13_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e13, src=1, dst=3)\ne23 = EdgeModel(e23_mtk, [:p_src], [:p_dst], AntiSymmetric([:q̃]); name=:e23, src=2, dst=3)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"To build the network object we just need to pass the vertices and edges to the constructor.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Note that we've used the vidx and src/dst keywords in the constructors to define for each component to which \"part\" of the network it belongs.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"This means, the constructor can automaticially construct a graph based on those informations and we don't need to pass it explicitly.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"nw = Network([v1, v2, v3], [e12, e13, e23])","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"As a result, we recive a network with 3 unique types (v2 and v3 are similar but structurally different, because both functions capure a unique loadprofile function).","category":"page"},{"location":"generated/gas_network/#Finding-a-Steady-State","page":"Gas Network","title":"Finding a Steady State","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"To simulate the systme, we first need to find a steadystate. As a \"guess\" for that we create a NWState object from the network. This will allocate flat arrays for states u and parameters p and fill them with the default values.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"uguess = NWState(nw)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"This is not a steadystate of the system however. To find a true steadystate we want to ensure that the lhs of the system is zero. We can solve for a steady state numerically by defining a Nonlinear Rootfind problem.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"To do so, we need to wrap the Network object in a closure.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"nwwrap = (du, u, p) -> begin\n nw(du, u, p, 0)\n nothing\nend\ninitprob = NonlinearProblem(nwwrap, uflat(uguess), pflat(uguess))\ninitsol = solve(initprob)","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"We can create a new NWState object by wrapping the solution from the nonlinear problem and the original prameters in a new NWState object.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"u0 = NWState(nw, initsol.u, uguess.p)","category":"page"},{"location":"generated/gas_network/#Solving-the-ODE","page":"Gas Network","title":"Solving the ODE","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Using this as our initial state we can create the actual ODEProblem. Since the ode allways operates on flat state and aprameter arrays we use uflat and pflat to extract them.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"prob = ODEProblem(nw, uflat(u0), (0.0,24*3600), copy(pflat(u0)))\nsol = solve(prob, Tsit5(), tstops=[0,4,12,20,24]*3600)\nnothing #hide","category":"page"},{"location":"generated/gas_network/#Inspect-the-Solution","page":"Gas Network","title":"Inspect the Solution","text":"","category":"section"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Inspecting the solution is all which is left to do.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"xticks = ((0:4:24)*3600, string.(0:4:24)) # its nice to display hours\nfig = begin\n _fig = Figure()\n row = 1\n ax = Axis(_fig[row, 1]; xlabel=\"time [h]\", ylabel=\"pressure [Pa]\", title=\"Pressure at nodes\", xticks)\n xlims!(ax, sol.t[begin], sol.t[end])\n ylims!(ax, 47.9e5, 49.9e5)\n for i in 1:3\n lines!(ax, sol, idxs=vidxs(nw, i, :p); label=\"v$i\", color=Cycled(i))\n end\n axislegend(ax)\n row += 1\n\n ax = Axis(_fig[row, 1]; xlabel=\"time [h]\", ylabel=\"flow [m³/s]\", title=\"Flow through pipes\", xticks)\n xlims!(ax, sol.t[begin], sol.t[end])\n ylims!(ax, 16, 44)\n for i in 1:2\n lines!(ax, sol, idxs=eidxs(nw, i, :q̃); label=\"e$i flow\", color=Cycled(i))\n end\n axislegend(ax, position=:rb)\n row += 1\n _fig\nend","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Notably, the \"internal\" states defined in the symbolic models are not \"states\" in the sense of the ODE. For example, we captured the load profile in the q̃_inj state of the VariablePressureNode. The only dynamic state of the model however is p. Using the \"observables\" mechanism from SciML, which is implemented by NetworkDynamics, we can reconstruct those \"optimized\" states which have been removed symbolicially. Here we plot the reconstructed load profile of nodes 2 and 3. Also, we know that node 1 is infinetly stiff, acting as an infinite source of volumetric flow. We can reconstruct this flow too.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"fig = begin\n _fig = Figure()\n row = 1\n ax = Axis(_fig[row, 1]; xlabel=\"time [h]\", ylabel=\"flow [m³/s]\", title=\"Flow at nodes\", xticks)\n xlims!(ax, sol.t[begin], sol.t[end])\n lines!(ax, sol, idxs=vidxs(nw, 1, :q̃_inj); label=\"v1 compensation\", color=Cycled(1))\n for i in 2:3\n lines!(ax, sol, idxs=vidxs(nw, i, :q̃_inj); label=\"v$i load profile\", color=Cycled(i))\n end\n axislegend(ax, position=:rc)\n _fig\nend","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"Lastly we want to observe two internal states of the pipes: the Reynolds number and the mean pressure. We see, that we're purely in the turbulent flow regime.","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"fig = begin\n _fig = Figure()\n row = 1\n ax = Axis(_fig[row, 1]; xlabel=\"time [h]\", ylabel=\"Reynolds number\", title=\"Reynolds number\", xticks)\n xlims!(ax, sol.t[begin], sol.t[end])\n for i in 1:3\n lines!(ax, sol, idxs=eidxs(nw, i, :Re); label=\"e $i\", color=Cycled(i))\n end\n hlines!(ax, 2300, color=:black, linestyle=:dash, label=\"L/T transition\")\n axislegend(ax, position=:rb)\n row += 1\n\n ax = Axis(_fig[row, 1]; xlabel=\"time [h]\", ylabel=\"Mean pressure [Pa]\", title=\"Mean pressure in pipes\", xticks)\n xlims!(ax, sol.t[begin], sol.t[end])\n for i in 1:3\n lines!(ax, sol, idxs=eidxs(nw, i, :pM); label=\"e $i\", color=Cycled(i))\n end\n axislegend(ax, position=:rb)\n _fig\nend","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"","category":"page"},{"location":"generated/gas_network/","page":"Gas Network","title":"Gas Network","text":"This page was generated using Literate.jl.","category":"page"},{"location":"#NetworkDynamics","page":"General","title":"NetworkDynamics","text":"","category":"section"},{"location":"","page":"General","title":"General","text":"A package for working with dynamical systems on complex networks. NetworkDynamics.jl provides an interface between Graphs.jl and DifferentialEquations.jl. It allows for high performant simulation of dynamic networks by describing the local dynamics on the edges and vertices of the graph.","category":"page"},{"location":"","page":"General","title":"General","text":"The behavior of a node or an edge can be described by algebraic equations, by differential algebraic equation (DAEs) in mass matrix form or by ordinary differential equations (ODE). ","category":"page"},{"location":"","page":"General","title":"General","text":"The central construction is the function Network that receives functions describing the local dynamics on the edges and nodes of a graph g as inputs, and returns a composite function compatible with the DifferentialEquations.jl calling syntax.","category":"page"},{"location":"","page":"General","title":"General","text":"nd = Network(g, vertex_dynamics, edge_dynamics)\nnd(dx, x, p, t)","category":"page"},{"location":"","page":"General","title":"General","text":"Main features:","category":"page"},{"location":"","page":"General","title":"General","text":"Clear separation of local dynamics and topology: you can easily change topology of your system or switching out dynamical components.\nHigh performance when working with heterogeneous models (which means heaving different local dynamics in different parts of your network).\nSymbolic Indexing into solutions and states: NetworkDynamics keeps track of the states of the individual subsystems.\nDifferent execution schemes: NetworkDynamics exploits the known inter-dependencies between components to auto parallelize execution, even on GPUs!\nEquation based models: use ModelingToolkit.jl to define local dynamics, use NetworkDynamics.jl to combine them into large networks!","category":"page"},{"location":"#Where-to-begin?","page":"General","title":"Where to begin?","text":"","category":"section"},{"location":"","page":"General","title":"General","text":"Check out the Mathematical Model to understand the underlying modelling ideas of NetworkDynamics followed by the page on Network Construction to learn how to implement you own models.","category":"page"},{"location":"","page":"General","title":"General","text":"If you prefer to look at some concrete code first check out the Getting Started tutorial!","category":"page"},{"location":"#Installation","page":"General","title":"Installation","text":"","category":"section"},{"location":"","page":"General","title":"General","text":"Installation is straightforward with Julia's package manager.","category":"page"},{"location":"","page":"General","title":"General","text":"(v1.11) pkg> add NetworkDynamics","category":"page"},{"location":"#Reproducibility","page":"General","title":"Reproducibility","text":"","category":"section"},{"location":"","page":"General","title":"General","text":"

Direct dependencies used for this documentation:","category":"page"},{"location":"","page":"General","title":"General","text":"using Pkg # hide\nPkg.status() # hide","category":"page"},{"location":"","page":"General","title":"General","text":"
","category":"page"},{"location":"","page":"General","title":"General","text":"
Julia Version:","category":"page"},{"location":"","page":"General","title":"General","text":"using InteractiveUtils # hide\nversioninfo() # hide","category":"page"},{"location":"","page":"General","title":"General","text":"
","category":"page"},{"location":"","page":"General","title":"General","text":"
Full Manifest:","category":"page"},{"location":"","page":"General","title":"General","text":"using Pkg # hide\nPkg.status(; mode = PKGMODE_MANIFEST) # hide","category":"page"},{"location":"","page":"General","title":"General","text":"
","category":"page"},{"location":"#Funding","page":"General","title":"Funding","text":"","category":"section"},{"location":"","page":"General","title":"General","text":"Development of this project was in part funded by the German Federal Ministry for Economic Affairs and Climate Action as part of the OpPoDyn-Project (Project ID 01258425/1, 2024-2027).","category":"page"},{"location":"","page":"General","title":"General","text":"","category":"page"},{"location":"network_construction/#Network-Construction","page":"Network Construction","title":"Network Construction","text":"","category":"section"},{"location":"network_construction/#Building-a-Network","page":"Network Construction","title":"Building a Network","text":"","category":"section"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"The main type of NetworkDyanmics.jl is a Network. A network bundles various component models (edge and vertex models) together with a graph to form a callable object which represents the RHS of the overall dynamical system, see Mathematical Model.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"A Network is build by passing a graph g, vertex models vertexm and edge models edgem.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"nw = Network(g, vertexm, edgem; kwargs...)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"Two important keywords for the Network constructor are:","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"execution: Defines the ExecutionStyle of the coreloop, e.g. SequentialExecution{true}(). A execution style is a special struct which tells the backend how to parallelize for example. A list of available executions styles can be found under Execution Types in the API.\naggregator: Tells the backend how to aggregate and which aggregation function to use. Aggregation is the process of creating a single vertex input by reducing over the outputs of adjecent edges of said vertex. The aggregator contains both the function and the algorith. E.g. SequentialAggregator(+) is a sequential aggregation by summation. A list of availabe Aggregators can be found under Aggregators in the API.","category":"page"},{"location":"network_construction/#Building-VertexModels","page":"Network Construction","title":"Building VertexModels","text":"","category":"section"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"This chapter walks through the most important aspects when defining custom vertex model. For a list of all keyword arguments please check out the docstring of VertexModel. As an example, we'll construct an second order kuramoto model, because that's what we do.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"using NetworkDynamics #hide\nfunction kuramoto_f!(dv, v, esum, p, t)\n M, P, D = p\n dv[1] = v[2]\n dv[2] = (P - D*v[2] + esum[1])/M\n nothing\nend\nfunction kuramoto_g!(y, v, esum, p, t)\n y[1] = v[1]\n nothing\nend\nVertexModel(; f=kuramoto_f!, g=kuramoto_g!, dim=2, pdim=3, outdim=1)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"Those keywords are the minimum metadata we need to provide.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"However there is a problem: the vertex is classified as a FeedForward vertex, which is unnecessary. We can improve the implementation of g according to the Feed Forward Behavior section.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"function kuramoto_g_noff!(y, v, p, t)\n y[1] = v[1]\n nothing\nend\nVertexModel(; f=kuramoto_f!, g=kuramoto_g_noff!, dim=2, pdim=3, outdim=1)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"It is still annoying to explicitly write this trivial output function. You can prevent this by using StateMask. By writing","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"VertexModel(; f=kuramoto_f!, g=StateMask(1:1), dim=2, pdim=3)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"we told the vertex model, that the output is part of the states x[1:1]. This enables a few things:","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"outdim is not needed anymore, can be inferred from StateMask\noutsym is not a generic :o any more but inferred from the state symbols.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"We can be even less verbose by writing g=1:1 or just g=1.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"In a last we define better names for our states and parameters as well as assigning a position in the graph to enable the graphless network construction. Whenever you provide sym keyword the corresponding dim keyword is not neccessary anymore. We end up with a relatively short definition","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"VertexModel(; f=kuramoto_f!, g=1,\n sym=[:θ, :ω], psym=[:M=>1, :P=>0.1, :D=>0], \n insym=[:P_nw], name=:swing, vidx=1)","category":"page"},{"location":"network_construction/#Building-EdgeModels","page":"Network Construction","title":"Building EdgeModels","text":"","category":"section"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"This chapter walks through the most important aspects when defining custom edge models. For a list of all keyword arguments please check out the docstring of EdgeModel.","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"As an example edge model we want to define standard sinusoidal coupling between the vertices in our network. The full definition looks like this:","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"function edge_f!(de, e, vsrc, vdst, p, t)\n nothing\nend\nfunction edge_g!(ysrc, ydst, e, vsrc, vdst, p, t)\n ydst[1] = p[1] * sin(vsrc[1] - vdst[1])\n ysrc[1] = -ydst[1]\nend\nEdgeModel(; f=edge_f!, g=edge_g!, dim=0, pdim=1, outdim=1)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"This is a purely \"static\" edge without internal states. This means we can omit f and dim entirely. Also, we can define a variant of g without the e input","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"function edge_g_ff!(ysrc, ydst, vsrc, vdst, p, t)\n ydst[1] = p[1] * sin(vsrc[1] - vdst[1])\n ysrc[1] = -ydst[1]\nend\nEdgeModel(;g=edge_g_ff!, pdim=1, outdim=1)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"which no classifies as a PureFeedForward edge. In cases like this, where the edge is actually anti symmetric we can alternatively define a single sided output function and wrapping it in an AntiSymmetric object","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"function edge_g_s!(ydst, vsrc, vdst, p, t)\n ydst[1] = p[1] * sin(vsrc[1] - vdst[1])\nend\nEdgeModel(;g=AntiSymmetric(edge_g_ff!), pdim=1, outdim=1)","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"which can also lead to briefer output naming. Available single sided wrappers are","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"Directed (no coupling at src), \nAntiSymmetric (same coupling at src and dst),\nSymmetric (inverse coupling at dst) and\nFiducial (define separate g for both ends).","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"Once again we can add additonal data like defining a src and dst index","category":"page"},{"location":"network_construction/","page":"Network Construction","title":"Network Construction","text":"function edge_g_s!(ydst, vsrc, vdst, p, t)\n ydst[1] = p[1] * sin(vsrc[1] - vdst[1])\nend\nEdgeModel(;g=AntiSymmetric(edge_g_ff!), psym=:K=>1, outsym=:P, insym=:θ, src=1, dst=4)","category":"page"}] +} diff --git a/previews/PR184/siteinfo.js b/previews/PR184/siteinfo.js new file mode 100644 index 00000000..e40ec43e --- /dev/null +++ b/previews/PR184/siteinfo.js @@ -0,0 +1 @@ +var DOCUMENTER_CURRENT_VERSION = "previews/PR184"; diff --git a/previews/PR184/symbolic_indexing/2131439f.svg b/previews/PR184/symbolic_indexing/2131439f.svg new file mode 100644 index 00000000..66157b47 --- /dev/null +++ b/previews/PR184/symbolic_indexing/2131439f.svg @@ -0,0 +1,52 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/symbolic_indexing/74fa3e98.svg b/previews/PR184/symbolic_indexing/74fa3e98.svg new file mode 100644 index 00000000..74f689e9 --- /dev/null +++ b/previews/PR184/symbolic_indexing/74fa3e98.svg @@ -0,0 +1,58 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/symbolic_indexing/d1c7b351.svg b/previews/PR184/symbolic_indexing/d1c7b351.svg new file mode 100644 index 00000000..1e7f8d53 --- /dev/null +++ b/previews/PR184/symbolic_indexing/d1c7b351.svg @@ -0,0 +1,48 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR184/symbolic_indexing/index.html b/previews/PR184/symbolic_indexing/index.html new file mode 100644 index 00000000..801fb0e6 --- /dev/null +++ b/previews/PR184/symbolic_indexing/index.html @@ -0,0 +1,51 @@ + +Symbolic Indexing · NetworkDynamics

Symbolic Indexing

Using SciML's SymblicIndexingInterface.jl, ND.jl provides lots of methods to access and change variables and Parameters.

Setup code to make following examples work
using NetworkDynamics
+using Graphs
+using OrdinaryDiffEqTsit5
+using Plots

Provide Symbol Names

When construction component models, you can pass symbolic names using the sym and psym keywords.

function _edgef!(e, v_s, v_d, (K,), t)
+    e .= K * (v_s[1] .- v_d[1])
+end
+edgef = EdgeModel(;g=AntiSymmetric(_edgef!), outsym=[:flow], psym=[:K=>1])
EdgeModel :StaticEdgeM PureFeedForward()
+ ├─   0 states:  []  
+ ├─ 1/1 outputs: src=[₋flow] dst=[flow]
+ └─   1 param:   [K=1]

Here we created a static diffusion edge with suitable variable and parameter names. Similarly, we define the diffusion vertex with symbolic names.

function _vertexf!(dv, v, esum, p, t)
+    dv[1] = esum[1]
+end
+vertexf = VertexModel(f=_vertexf!, g=1, sym=[:storage])
VertexModel :VertexM PureStateMap()
+ ├─ 1 state:  [storage]
+ └─ 1 output: [storage]

Fundamental Symblic Indices

The default types for this access are the types VIndex, EIndex, VPIndex and EPIndex. Each of those symbolic indices consists of 2 elements: a reference to the network componen and a reference to the symbol within that component. As such, VIndex(2, :x) refers to variable with symbolic name :x in vertex number 2. EPIndex(4, 2) would refer to the second parameter of the edge component for the 4th edge.

Setup code to make following examples work
g = wheel_graph(5)
+nw = Network(g, vertexf, edgef)
+s = NWState(nw)
+s.v[:,:storage] .= randn(5)
+prob = ODEProblem(nw, uflat(s), (0,2), pflat(s))
+sol = solve(prob, Tsit5())

Those fundamental indices can be used in a lot of scenarios. Most importantly you can use them to

sol(sol.t; idxs=VIndex(1, :storage))   # extract timeseries out ouf solution object
+plot(sol; idxs=[VIndex(1, :storage), VIndex(5,:storage)]) # plot storage of two nodes
Example block output

Generate Symbolic Indices

Often, you need many individual symbolic indices. For that there are the helper methods vidxs, eidxs, vpidxs and epidxs. With the help of those methods you can generate arrays of symbolic indices:

vidxs(nw, :, :storage) # get variable "storage" for all nodes
5-element Vector{VIndex}:
+ VIndex(1, :storage)
+ VIndex(2, :storage)
+ VIndex(3, :storage)
+ VIndex(4, :storage)
+ VIndex(5, :storage)
plot(sol; idxs=vidxs(nw, :, :storage))
Example block output

NWState and NWParameter Objects

Internally, both state and parameters of a Network are represented using flat arrays. To access the state or parameters of a network, you can use the NWState and NWParameter objects.

p = NWParameter(nw)
Parameter{Vector{Float64}} of Network (5 vertices, 8 edges)
+  ├─ EPIndex(1, :K) => 1.0
+  ├─ EPIndex(2, :K) => 1.0
+  ├─ EPIndex(3, :K) => 1.0
+  ├─ EPIndex(4, :K) => 1.0
+  ├─ EPIndex(5, :K) => 1.0
+  ├─ EPIndex(6, :K) => 1.0
+  ├─ EPIndex(7, :K) => 1.0
+  └─ EPIndex(8, :K) => 1.0

creates a NWParameter object for the network nw. It essentially creates a new flat parameter array and fills it with the default parameter values define in the component. The parameters in the NWParameter object can be accessed using the symbolic indices.

p[EPIndex(5, :K)] = 2.0 # change the parameter K of the 5th edge

Similarly, you can create a NWState object for the network nw using

s = NWState(nw)
NWState{Vector{Float64}} of Network (5 vertices, 8 edges)
+  ├─ VIndex(1, :storage) => NaN
+  ├─ VIndex(2, :storage) => NaN
+  ├─ VIndex(3, :storage) => NaN
+  ├─ VIndex(4, :storage) => NaN
+  └─ VIndex(5, :storage) => NaN
+ p = NWParameter([1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0])
+ t = nothing

No default values were provided in the network components, so the state array is filled with NaNs.

s[VIndex(:, :storage)] .= randn(5) # set the (initial) storage for alle nodes
NWState{Vector{Float64}} of Network (5 vertices, 8 edges)
+  ├─ VIndex(1, :storage) => 0.3953170217786552
+  ├─ VIndex(2, :storage) => 0.9173896583682629
+  ├─ VIndex(3, :storage) => -1.0978639190905948
+  ├─ VIndex(4, :storage) => 2.2930233712677026
+  └─ VIndex(5, :storage) => 1.8225484084116617
+ p = NWParameter([1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0, 1.0])
+ t = nothing

For both NWState and NWParameter objects, the there is a more convenient way to access the variables and parameters.

@assert s.v[1, :storage] == s[VIndex(1, :storage)] # s.v -> access vertex states
+@assert s.e[1, :flow]    == s[EIndex(1, :flow)]    # s.e -> access edge states
+@assert s.p.e[1,:K]      == p[EPIndex(1, :K)]      # s.p -> access parameters

The NWState and NWParameter objects are mutable, thus changing them will also change the underlying wrapped flat arrays. You can allways access the flat representations by calling uflat and pflat.

Note

The NWState and NWParameter wrappers can be constructed from various objects. Fore example, within a callback you might construct p = NWParameter(integrator) to then change the parameters of the network within the callback.

Observables

Sometimes, the "states" you're interested in aren't really states in the DAE sense but rather algebraic derivations from DAE states, parameters and time – in accordance with the naming in the SciML-ecosystem those states are called Observables.

A prime example of Observables are edge/vertex-outputs, such as the flow in the edge model defined above. It is also possible to define additional Observables manually by using the obssym and obsf keyword on the EdgeModel/VertexModel constructors. When building models using ModelingToolkit, the reduced algebraic states will be preserved as observables automatically.

Observables can be accessed like any other state, for example, the flows in the network don't show up in the state array but can be accessed in all the ways discussed above, for example

plot(sol; idxs=eidxs(nw, :, :flow))
Example block output

NetworkDynamics

A package for working with dynamical systems on complex networks. NetworkDynamics.jl provides an interface between Graphs.jl and DifferentialEquations.jl. It allows for high performant simulation of dynamic networks by describing the local dynamics on the edges and vertices of the graph.

The behavior of a node or an edge can be described by algebraic equations, by differential algebraic equation (DAEs) in mass matrix form or by ordinary differential equations (ODE).

The central construction is the function Network that receives functions describing the local dynamics on the edges and nodes of a graph g as inputs, and returns a composite function compatible with the DifferentialEquations.jl calling syntax.

nd = Network(g, vertex_dynamics,  edge_dynamics)
+nd(dx, x, p, t)

Main features:

  • Clear separation of local dynamics and topology: you can easily change topology of your system or switching out dynamical components.
  • High performance when working with heterogeneous models (which means heaving different local dynamics in different parts of your network).
  • Symbolic Indexing into solutions and states: NetworkDynamics keeps track of the states of the individual subsystems.
  • Different execution schemes: NetworkDynamics exploits the known inter-dependencies between components to auto parallelize execution, even on GPUs!
  • Equation based models: use ModelingToolkit.jl to define local dynamics, use NetworkDynamics.jl to combine them into large networks!

Where to begin?

Check out the Mathematical Model to understand the underlying modelling ideas of NetworkDynamics followed by the page on Network Construction to learn how to implement you own models.

If you prefer to look at some concrete code first check out the Getting Started tutorial!

Installation

Installation is straightforward with Julia's package manager.

(v1.11) pkg> add NetworkDynamics

Reproducibility

Direct dependencies used for this documentation:
Status `~/work/NetworkDynamics.jl/NetworkDynamics.jl/docs/Project.toml`
+  [13f3f980] CairoMakie v0.12.16
+  [459566f4] DiffEqCallbacks v4.2.2
+  [31c24e10] Distributions v0.25.113
+  [e30172f5] Documenter v1.8.0
+  [06fc5a27] DynamicQuantities v1.4.0
+  [1ecd5474] GraphMakie v0.5.12
+  [86223c79] Graphs v1.12.0
+  [b964fa9f] LaTeXStrings v1.4.0
+ [b20c7882] LinearInterpolations v0.1.4
+  [98b081ad] Literate v2.20.1
+  [961ee093] ModelingToolkit v9.53.0
+  [22e9dc34] NetworkDynamics v0.9.2 `~/work/NetworkDynamics.jl/NetworkDynamics.jl`
+  [127b3ac7] OrdinaryDiffEqNonlinearSolve v1.2.4
+  [43230ef6] OrdinaryDiffEqRosenbrock v1.3.1
+  [2d112036] OrdinaryDiffEqSDIRK v1.1.0
+  [b1df2697] OrdinaryDiffEqTsit5 v1.1.0
+  [91a5bcdd] Plots v1.40.9
+  [1bc83da4] SafeTestsets v0.1.0
+  [0bca4576] SciMLBase v2.63.1
+  [47aef6b3] SimpleWeightedGraphs v1.4.0
+  [860ef19b] StableRNGs v1.0.2
+  [90137ffa] StaticArrays v1.9.8
+  [789caeaf] StochasticDiffEq v6.71.1
+  [2efcf032] SymbolicIndexingInterface v0.3.35
+  [de0858da] Printf v1.11.0
+  [9a3f8284] Random v1.11.0
+  [f489334b] StyledStrings v1.11.0
+Info Packages marked with  have new versions available and may be upgradable.
Julia Version:
Julia Version 1.11.1
+Commit 8f5b7ca12ad (2024-10-16 10:53 UTC)
+Build Info:
+  Official https://julialang.org/ release
+Platform Info:
+  OS: Linux (x86_64-linux-gnu)
+  CPU: 4 × AMD EPYC 7763 64-Core Processor
+  WORD_SIZE: 64
+  LLVM: libLLVM-16.0.6 (ORCJIT, znver3)
+Threads: 1 default, 0 interactive, 1 GC (on 4 virtual cores)
+Environment:
+  JULIA_PKG_SERVER_REGISTRY_PREFERENCE = eager
Full Manifest:
Status `~/work/NetworkDynamics.jl/NetworkDynamics.jl/docs/Manifest.toml`
+  [47edcb42] ADTypes v1.11.0
+  [a4c015fc] ANSIColoredPrinters v0.0.1
+  [621f4979] AbstractFFTs v1.5.0
+  [1520ce14] AbstractTrees v0.4.5
+  [7d9f7c33] Accessors v0.1.38
+  [79e6a3ab] Adapt v4.1.1
+  [35492f91] AdaptivePredicates v1.2.0
+  [66dad0bd] AliasTables v1.1.3
+  [27a7e980] Animations v0.4.2
+  [dce04be8] ArgCheck v2.3.0
+  [ec485272] ArnoldiMethod v0.4.0
+  [4fba245c] ArrayInterface v7.17.1
+  [4c555306] ArrayLayouts v1.10.4
+ [a9b6321e] Atomix v0.1.0
+  [67c07d97] Automa v1.1.0
+  [13072b0f] AxisAlgorithms v1.1.0
+  [39de3d68] AxisArrays v0.4.7
+  [e2ed5e7c] Bijections v0.1.9
+  [d1d4a3ce] BitFlags v0.1.9
+  [62783981] BitTwiddlingConvenienceFunctions v0.1.6
+  [8e7c35d0] BlockArrays v1.2.0
+  [70df07ce] BracketingNonlinearSolve v1.1.0
+  [fa961155] CEnum v0.5.0
+  [2a0fbf3d] CPUSummary v0.2.6
+  [00ebfdb7] CSTParser v3.4.3
+  [159f3aea] Cairo v1.1.1
+  [13f3f980] CairoMakie v0.12.16
+  [7057c7e9] Cassette v0.3.14
+  [d360d2e6] ChainRulesCore v1.25.0
+  [fb6a15b2] CloseOpenIntervals v0.1.13
+  [944b1d66] CodecZlib v0.7.6
+  [a2cac450] ColorBrewer v0.4.0
+  [35d6a980] ColorSchemes v3.27.1
+ [3da002f7] ColorTypes v0.11.5
+ [c3611d14] ColorVectorSpace v0.10.0
+ [5ae59095] Colors v0.12.11
+  [861a8166] Combinatorics v1.0.2
+  [a80b9123] CommonMark v0.8.15
+  [38540f10] CommonSolve v0.2.4
+  [bbf7d656] CommonSubexpressions v0.3.1
+  [f70d9fcc] CommonWorldInvalidations v1.0.0
+  [34da2185] Compat v4.16.0
+  [b152e2b5] CompositeTypes v0.1.4
+  [a33af91c] CompositionsBase v0.1.2
+  [2569d6c7] ConcreteStructs v0.2.3
+  [f0e56b4a] ConcurrentUtilities v2.4.2
+  [187b0558] ConstructionBase v1.5.8
+  [d38c429a] Contour v0.6.3
+  [adafc99b] CpuId v0.3.1
+  [a8cc5b0e] Crayons v4.1.1
+  [9a962f9c] DataAPI v1.16.0
+  [864edb3b] DataStructures v0.18.20
+  [e2d170a0] DataValueInterfaces v1.0.0
+  [927a84f5] DelaunayTriangulation v1.6.3
+  [8bb1440f] DelimitedFiles v1.9.1
+  [2b5f629d] DiffEqBase v6.160.0
+  [459566f4] DiffEqCallbacks v4.2.2
+  [77a26b50] DiffEqNoiseProcess v5.23.0
+  [163ba53b] DiffResults v1.1.0
+  [b552c78f] DiffRules v1.15.1
+  [a0c0ee7d] DifferentiationInterface v0.6.23
+  [8d63f2c5] DispatchDoctor v0.4.17
+  [b4f34e82] Distances v0.10.12
+  [31c24e10] Distributions v0.25.113
+  [ffbed154] DocStringExtensions v0.9.3
+  [e30172f5] Documenter v1.8.0
+  [5b8099bc] DomainSets v0.7.14
+  [7c1d4256] DynamicPolynomials v0.6.1
+  [06fc5a27] DynamicQuantities v1.4.0
+  [4e289a0a] EnumX v1.0.4
+  [f151be2c] EnzymeCore v0.8.6
+  [429591f6] ExactPredicates v2.2.8
+  [460bff9d] ExceptionUnwrapping v0.1.11
+  [d4d017d3] ExponentialUtilities v1.27.0
+  [e2ba6199] ExprTools v0.1.10
+ [6b7a57c9] Expronicon v0.8.5
+  [411431e0] Extents v0.1.4
+  [c87230d0] FFMPEG v0.4.2
+  [7a1cc6ca] FFTW v1.8.0
+  [7034ab61] FastBroadcast v0.3.5
+  [9aa1b823] FastClosures v0.3.2
+  [29a986be] FastLapackInterface v2.0.4
+  [a4df4552] FastPower v1.1.1
+  [5789e2e9] FileIO v1.16.6
+  [8fc22ac5] FilePaths v0.8.3
+  [48062228] FilePathsBase v0.9.22
+  [1a297f60] FillArrays v1.13.0
+  [64ca27bc] FindFirstFunctions v1.4.1
+  [6a86dc24] FiniteDiff v2.26.2
+  [53c48c17] FixedPointNumbers v0.8.5
+  [1fa38f19] Format v1.3.7
+  [f6369f11] ForwardDiff v0.10.38
+  [b38be410] FreeType v4.1.1
+  [663a7486] FreeTypeAbstraction v0.10.6
+  [f62d2435] FunctionProperties v0.1.2
+  [069b7b12] FunctionWrappers v1.1.3
+  [77dc65aa] FunctionWrappersWrappers v0.1.3
+  [d9f16b24] Functors v0.5.1
+ [46192b85] GPUArraysCore v0.1.6
+  [28b8d3ca] GR v0.73.8
+  [c145ed77] GenericSchur v0.5.4
+  [68eda718] GeoFormatTypes v0.4.2
+  [cf35fbd7] GeoInterface v1.3.8
+ [5c1252a2] GeometryBasics v0.4.11
+  [d7ba0133] Git v1.3.1
+  [c27321d9] Glob v1.3.1
+  [1ecd5474] GraphMakie v0.5.12
+  [a2bd30eb] Graphics v1.1.3
+  [86223c79] Graphs v1.12.0
+  [3955a311] GridLayoutBase v0.11.1
+  [42e2da0e] Grisu v1.0.2
+  [cd3eb016] HTTP v1.10.12
+  [3e5b6fbb] HostCPUFeatures v0.1.17
+  [34004b35] HypergeometricFunctions v0.3.25
+  [b5f81e59] IOCapture v0.2.5
+  [615f187c] IfElse v0.1.1
+  [2803e5a7] ImageAxes v0.6.12
+  [c817782e] ImageBase v0.1.7
+  [a09fc81d] ImageCore v0.10.5
+  [82e4d734] ImageIO v0.6.9
+  [bc367c6b] ImageMetadata v0.9.10
+  [9b13fd28] IndirectArrays v1.0.0
+  [d25df0c9] Inflate v0.1.5
+  [18e54dd8] IntegerMathUtils v0.1.2
+  [a98d9a8b] Interpolations v0.15.1
+  [d1acc4aa] IntervalArithmetic v0.22.19
+  [8197267c] IntervalSets v0.7.10
+  [3587e190] InverseFunctions v0.1.17
+  [92d709cd] IrrationalConstants v0.2.2
+  [f1662d9f] Isoband v0.1.1
+  [c8e1da08] IterTools v1.10.0
+  [82899510] IteratorInterfaceExtensions v1.0.0
+  [1019f520] JLFzf v0.1.9
+  [692b3bcd] JLLWrappers v1.6.1
+  [682c06a0] JSON v0.21.4
+  [b835a17e] JpegTurbo v0.1.5
+  [98e50ef6] JuliaFormatter v1.0.62
+  [ccbc3e58] JumpProcesses v9.14.0
+  [ef3ab10e] KLU v0.6.0
+  [63c18a36] KernelAbstractions v0.9.29
+  [5ab0869b] KernelDensity v0.6.9
+  [ba0b0d4f] Krylov v0.9.8
+  [929cbde3] LLVM v9.1.3
+  [b964fa9f] LaTeXStrings v1.4.0
+  [23fbe1c1] Latexify v0.16.5
+  [10f19ff3] LayoutPointers v0.1.17
+  [0e77f7df] LazilyInitializedFields v1.3.0
+  [5078a376] LazyArrays v2.2.2
+  [8cdb02fc] LazyModules v0.3.1
+  [2d8b4e74] LevyArea v1.0.0
+  [87fe0de2] LineSearch v0.1.4
+  [d3d80556] LineSearches v7.3.0
+ [b20c7882] LinearInterpolations v0.1.4
+  [7ed4a6bd] LinearSolve v2.37.0
+  [98b081ad] Literate v2.20.1
+  [2ab3a3ac] LogExpFunctions v0.3.28
+  [e6f89c97] LoggingExtras v1.1.0
+  [bdcacae8] LoopVectorization v0.12.171
+  [d8e11817] MLStyle v0.4.17
+  [1914dd2f] MacroTools v0.5.13
+  [ee78f7c6] Makie v0.21.16
+  [20f20a25] MakieCore v0.8.10
+  [d125e4d3] ManualMemory v0.1.8
+  [dbb5928d] MappedArrays v0.4.2
+  [d0879d2d] MarkdownAST v0.1.2
+  [0a4f8689] MathTeXEngine v0.6.2
+  [bb5d69b7] MaybeInplace v0.1.4
+  [739be429] MbedTLS v1.1.9
+  [442fdcdd] Measures v0.3.2
+  [e1d29d7a] Missings v1.2.0
+  [2a8e4939] Mixers v0.1.2
+  [961ee093] ModelingToolkit v9.53.0
+  [e94cdb99] MosaicViews v0.3.4
+  [46d2c3a1] MuladdMacro v0.2.4
+  [102ac46a] MultivariatePolynomials v0.5.7
+  [d8a4904e] MutableArithmetics v1.6.0
+  [d41bc354] NLSolversBase v7.8.3
+  [2774e3e8] NLsolve v4.5.1
+  [872c559c] NNlib v0.9.25
+  [77ba4419] NaNMath v1.0.2
+  [f09324ee] Netpbm v1.1.1
+  [22e9dc34] NetworkDynamics v0.9.2 `~/work/NetworkDynamics.jl/NetworkDynamics.jl`
+  [46757867] NetworkLayout v0.4.7
+  [8913a72c] NonlinearSolve v4.2.0
+  [be0214bd] NonlinearSolveBase v1.3.3
+  [5959db7a] NonlinearSolveFirstOrder v1.1.0
+  [9a2c21bd] NonlinearSolveQuasiNewton v1.0.0
+  [26075421] NonlinearSolveSpectralMethods v1.0.0
+  [510215fc] Observables v0.5.5
+  [6fe1bfb0] OffsetArrays v1.14.1
+  [52e1d378] OpenEXR v0.3.3
+  [4d8831e6] OpenSSL v1.4.3
+  [429524aa] Optim v1.10.0
+  [bac558e1] OrderedCollections v1.6.3
+  [1dea7af3] OrdinaryDiffEq v6.90.1
+  [89bda076] OrdinaryDiffEqAdamsBashforthMoulton v1.1.0
+  [6ad6398a] OrdinaryDiffEqBDF v1.1.2
+  [bbf590c4] OrdinaryDiffEqCore v1.12.1
+  [50262376] OrdinaryDiffEqDefault v1.1.0
+  [4302a76b] OrdinaryDiffEqDifferentiation v1.2.0
+  [9286f039] OrdinaryDiffEqExplicitRK v1.1.0
+  [e0540318] OrdinaryDiffEqExponentialRK v1.1.0
+  [becaefa8] OrdinaryDiffEqExtrapolation v1.2.1
+  [5960d6e9] OrdinaryDiffEqFIRK v1.5.0
+  [101fe9f7] OrdinaryDiffEqFeagin v1.1.0
+  [d3585ca7] OrdinaryDiffEqFunctionMap v1.1.1
+  [d28bc4f8] OrdinaryDiffEqHighOrderRK v1.1.0
+  [9f002381] OrdinaryDiffEqIMEXMultistep v1.1.0
+  [521117fe] OrdinaryDiffEqLinear v1.1.0
+  [1344f307] OrdinaryDiffEqLowOrderRK v1.2.0
+  [b0944070] OrdinaryDiffEqLowStorageRK v1.2.1
+  [127b3ac7] OrdinaryDiffEqNonlinearSolve v1.2.4
+  [c9986a66] OrdinaryDiffEqNordsieck v1.1.0
+  [5dd0a6cf] OrdinaryDiffEqPDIRK v1.1.0
+  [5b33eab2] OrdinaryDiffEqPRK v1.1.0
+  [04162be5] OrdinaryDiffEqQPRK v1.1.0
+  [af6ede74] OrdinaryDiffEqRKN v1.1.0
+  [43230ef6] OrdinaryDiffEqRosenbrock v1.3.1
+  [2d112036] OrdinaryDiffEqSDIRK v1.1.0
+  [669c94d9] OrdinaryDiffEqSSPRK v1.2.0
+  [e3e12d00] OrdinaryDiffEqStabilizedIRK v1.1.0
+  [358294b1] OrdinaryDiffEqStabilizedRK v1.1.0
+  [fa646aed] OrdinaryDiffEqSymplecticRK v1.1.0
+  [b1df2697] OrdinaryDiffEqTsit5 v1.1.0
+  [79d7bb75] OrdinaryDiffEqVerner v1.1.1
+  [90014a1f] PDMats v0.11.31
+  [f57f5aa1] PNGFiles v0.4.3
+  [65ce6f38] PackageExtensionCompat v1.0.2
+  [19eb6ba3] Packing v0.5.1
+  [5432bcbf] PaddedViews v0.5.12
+  [d96e819e] Parameters v0.12.3
+  [69de0a69] Parsers v2.8.1
+  [b98c9c47] Pipe v1.3.0
+  [eebad327] PkgVersion v0.3.3
+  [ccf2f8ad] PlotThemes v3.3.0
+  [995b91a9] PlotUtils v1.4.3
+  [91a5bcdd] Plots v1.40.9
+  [e409e4f3] PoissonRandom v0.4.4
+  [f517fe37] Polyester v0.7.16
+  [1d0040c9] PolyesterWeave v0.2.2
+  [647866c9] PolygonOps v0.1.2
+  [3a141323] PolynomialRoots v1.0.0
+  [85a6dd25] PositiveFactorizations v0.2.4
+  [d236fae5] PreallocationTools v0.4.24
+  [aea7be01] PrecompileTools v1.2.1
+  [21216c6a] Preferences v1.4.3
+  [27ebfcd6] Primes v0.5.6
+  [92933f4c] ProgressMeter v1.10.2
+  [43287f4e] PtrArrays v1.2.1
+  [4b34888f] QOI v1.0.1
+  [1fd47b50] QuadGK v2.11.1
+  [74087812] Random123 v1.7.0
+  [e6cf234a] RandomNumbers v1.6.0
+  [b3c3ace0] RangeArrays v0.3.2
+  [c84ed2f1] Ratios v0.4.5
+  [3cdcf5f2] RecipesBase v1.3.4
+  [01d81517] RecipesPipeline v0.6.12
+  [731186ca] RecursiveArrayTools v3.27.4
+  [f2c3362d] RecursiveFactorization v0.2.23
+  [189a3867] Reexport v1.2.2
+  [2792f1a3] RegistryInstances v0.1.0
+  [05181044] RelocatableFolders v1.0.1
+  [ae029012] Requires v1.3.0
+  [ae5879a3] ResettableStacks v1.1.1
+  [79098fc4] Rmath v0.8.0
+  [5eaf0fd0] RoundingEmulator v0.2.1
+  [7e49a35a] RuntimeGeneratedFunctions v0.5.13
+  [fdea26ae] SIMD v3.7.0
+  [94e857df] SIMDTypes v0.1.0
+  [476501e8] SLEEFPirates v0.6.43
+  [1bc83da4] SafeTestsets v0.1.0
+  [0bca4576] SciMLBase v2.63.1
+  [19f34311] SciMLJacobianOperators v0.1.1
+  [c0aeaf25] SciMLOperators v0.3.12
+  [53ae85a6] SciMLStructures v1.6.1
+  [6c6a2e73] Scratch v1.2.1
+  [efcf1570] Setfield v1.1.1
+ [65257c39] ShaderAbstractions v0.4.1
+  [992d4aef] Showoff v1.0.3
+  [73760f76] SignedDistanceFields v0.4.0
+  [777ac1f9] SimpleBufferStream v1.2.0
+  [727e6d20] SimpleNonlinearSolve v2.0.0
+  [699a6c99] SimpleTraits v0.9.4
+  [ce78b400] SimpleUnPack v1.1.0
+  [47aef6b3] SimpleWeightedGraphs v1.4.0
+  [45858cf5] Sixel v0.1.3
+  [a2af1166] SortingAlgorithms v1.2.1
+  [47a9eef4] SparseDiffTools v2.23.0
+  [0a514795] SparseMatrixColorings v0.4.10
+  [e56a9233] Sparspak v0.3.9
+  [276daf66] SpecialFunctions v2.4.0
+  [860ef19b] StableRNGs v1.0.2
+  [cae243ae] StackViews v0.1.1
+  [aedffcd0] Static v1.1.1
+  [0d7ed370] StaticArrayInterface v1.8.0
+  [90137ffa] StaticArrays v1.9.8
+  [1e83bf80] StaticArraysCore v1.4.3
+  [10745b16] Statistics v1.11.1
+  [82ae8749] StatsAPI v1.7.0
+  [2913bbd2] StatsBase v0.34.3
+  [4c63d2b9] StatsFuns v1.3.2
+  [9672c7b4] SteadyStateDiffEq v2.4.1
+  [789caeaf] StochasticDiffEq v6.71.1
+  [7792a7ef] StrideArraysCore v0.5.7
+ [09ab397b] StructArrays v0.6.18
+  [2efcf032] SymbolicIndexingInterface v0.3.35
+  [19f23fe9] SymbolicLimits v0.2.2
+  [d1185830] SymbolicUtils v3.7.2
+ [0c5d862f] Symbolics v6.19.0
+  [3783bdb8] TableTraits v1.0.1
+  [bd369af6] Tables v1.12.0
+  [62fd8b95] TensorCore v0.1.1
+  [8ea1fca8] TermInterface v2.0.0
+  [1c621080] TestItems v1.0.0
+  [8290d209] ThreadingUtilities v0.5.2
+  [731e570b] TiffImages v0.11.1
+  [a759f4b9] TimerOutputs v0.5.25
+  [0796e94c] Tokenize v0.5.29
+  [3bb67fe8] TranscodingStreams v0.11.3
+  [d5829a12] TriangularSolve v0.2.1
+  [410a4b4d] Tricks v0.1.9
+  [981d1d27] TriplotBase v0.1.0
+  [781d530d] TruncatedStacktraces v1.4.0
+  [5c2747f8] URIs v1.5.1
+  [3a884ed6] UnPack v1.0.2
+  [1cfade01] UnicodeFun v0.4.1
+  [1986cc42] Unitful v1.21.0
+  [45397f5d] UnitfulLatexify v1.6.4
+  [a7c27f48] Unityper v0.1.6
+  [013be700] UnsafeAtomics v0.2.1
+  [d80eeb9a] UnsafeAtomicsLLVM v0.2.1
+  [41fe7b60] Unzip v0.2.0
+  [3d5dd08c] VectorizationBase v0.21.71
+  [19fa3120] VertexSafeGraphs v0.2.0
+  [e3aaa7dc] WebP v0.1.3
+  [efce3f68] WoodburyMatrices v1.0.0
+  [6e34b625] Bzip2_jll v1.0.8+2
+  [4e9b3aee] CRlibm_jll v1.0.1+0
+  [83423d85] Cairo_jll v1.18.2+1
+  [ee1fde0b] Dbus_jll v1.14.10+0
+  [5ae413db] EarCut_jll v2.2.4+0
+  [2702e6a9] EpollShim_jll v0.0.20230411+0
+  [2e619515] Expat_jll v2.6.4+0
+ [b22a6f82] FFMPEG_jll v4.4.4+1
+  [f5851436] FFTW_jll v3.3.10+1
+  [a3f928ae] Fontconfig_jll v2.13.96+0
+  [d7e528f0] FreeType2_jll v2.13.3+0
+  [559328eb] FriBidi_jll v1.0.14+0
+  [0656b61e] GLFW_jll v3.4.0+1
+  [d2c73de3] GR_jll v0.73.8+0
+  [78b55507] Gettext_jll v0.21.0+0
+  [59f7168a] Giflib_jll v5.2.2+0
+  [f8c6e375] Git_jll v2.46.2+0
+  [7746bdde] Glib_jll v2.82.2+0
+  [3b182d85] Graphite2_jll v1.3.14+1
+  [2e76f6c2] HarfBuzz_jll v8.3.1+0
+  [905a6f67] Imath_jll v3.1.11+0
+  [1d5cc7b8] IntelOpenMP_jll v2024.2.1+0
+  [aacddb02] JpegTurbo_jll v3.0.4+0
+  [c1c5ebd0] LAME_jll v3.100.2+0
+  [88015f11] LERC_jll v4.0.0+0
+  [dad2f222] LLVMExtra_jll v0.0.34+0
+  [1d63c593] LLVMOpenMP_jll v18.1.7+0
+  [dd4b983a] LZO_jll v2.10.2+1
+ [e9f186c6] Libffi_jll v3.2.2+1
+  [d4300ac3] Libgcrypt_jll v1.11.0+0
+  [7e76a0d4] Libglvnd_jll v1.6.0+0
+  [7add5ba3] Libgpg_error_jll v1.50.0+0
+  [94ce4f54] Libiconv_jll v1.17.0+1
+  [4b2f31a3] Libmount_jll v2.40.2+0
+  [89763e89] Libtiff_jll v4.7.0+0
+  [38a345b3] Libuuid_jll v2.40.2+0
+  [856f044c] MKL_jll v2024.2.0+0
+  [e7412a2a] Ogg_jll v1.3.5+1
+  [18a262bb] OpenEXR_jll v3.2.4+0
+  [458c3c95] OpenSSL_jll v3.0.15+1
+  [efe28fd5] OpenSpecFun_jll v0.5.5+0
+  [91d4177d] Opus_jll v1.3.3+0
+  [36c8627f] Pango_jll v1.54.1+0
+ [30392449] Pixman_jll v0.43.4+0
+  [c0090381] Qt6Base_jll v6.7.1+1
+  [629bc702] Qt6Declarative_jll v6.7.1+2
+  [ce943373] Qt6ShaderTools_jll v6.7.1+1
+  [e99dba38] Qt6Wayland_jll v6.7.1+1
+  [f50d1b31] Rmath_jll v0.5.1+0
+  [a44049a8] Vulkan_Loader_jll v1.3.243+0
+  [a2964d1f] Wayland_jll v1.21.0+1
+  [2381bf8a] Wayland_protocols_jll v1.31.0+0
+  [02c8fc9c] XML2_jll v2.13.5+0
+  [aed1982a] XSLT_jll v1.1.42+0
+  [ffd25f8a] XZ_jll v5.6.3+0
+  [f67eecfb] Xorg_libICE_jll v1.1.1+0
+  [c834827a] Xorg_libSM_jll v1.2.4+0
+  [4f6342f7] Xorg_libX11_jll v1.8.6+0
+  [0c0b7dd1] Xorg_libXau_jll v1.0.11+1
+  [935fb764] Xorg_libXcursor_jll v1.2.0+4
+  [a3789734] Xorg_libXdmcp_jll v1.1.4+1
+  [1082639a] Xorg_libXext_jll v1.3.6+0
+  [d091e8ba] Xorg_libXfixes_jll v5.0.3+4
+  [a51aa0fd] Xorg_libXi_jll v1.7.10+4
+  [d1454406] Xorg_libXinerama_jll v1.1.4+4
+  [ec84b674] Xorg_libXrandr_jll v1.5.2+4
+  [ea2f1a96] Xorg_libXrender_jll v0.9.11+0
+  [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+1
+  [c7cfdc94] Xorg_libxcb_jll v1.17.0+0
+  [cc61e674] Xorg_libxkbfile_jll v1.1.2+0
+  [e920d4aa] Xorg_xcb_util_cursor_jll v0.1.4+0
+  [12413925] Xorg_xcb_util_image_jll v0.4.0+1
+  [2def613f] Xorg_xcb_util_jll v0.4.0+1
+  [975044d2] Xorg_xcb_util_keysyms_jll v0.4.0+1
+  [0d47668e] Xorg_xcb_util_renderutil_jll v0.3.9+1
+  [c22f9ab0] Xorg_xcb_util_wm_jll v0.4.1+1
+  [35661453] Xorg_xkbcomp_jll v1.4.6+0
+  [33bec58e] Xorg_xkeyboard_config_jll v2.39.0+0
+  [c5fb5394] Xorg_xtrans_jll v1.5.0+1
+  [3161d3a3] Zstd_jll v1.5.6+1
+  [35ca27e7] eudev_jll v3.2.9+0
+  [214eeab7] fzf_jll v0.56.3+0
+  [1a1c6b14] gperf_jll v3.1.1+0
+  [9a68df92] isoband_jll v0.2.3+0
+  [a4ae2306] libaom_jll v3.9.0+0
+  [0ac62f75] libass_jll v0.15.2+0
+  [1183f4f0] libdecor_jll v0.2.2+0
+  [2db6ffa8] libevdev_jll v1.11.0+0
+  [f638f0a6] libfdk_aac_jll v2.0.3+0
+  [36db933b] libinput_jll v1.18.0+0
+  [b53b4c65] libpng_jll v1.6.44+0
+  [075b6546] libsixel_jll v1.10.3+1
+  [f27f6e37] libvorbis_jll v1.3.7+2
+  [c5f90fcd] libwebp_jll v1.4.0+0
+  [009596ad] mtdev_jll v1.1.6+0
+  [1317d2d5] oneTBB_jll v2021.12.0+0
+ [1270edf5] x264_jll v2021.5.5+0
+ [dfaa095f] x265_jll v3.5.0+0
+  [d8fb68d0] xkbcommon_jll v1.4.1+1
+  [0dad84c5] ArgTools v1.1.2
+  [56f22d72] Artifacts v1.11.0
+  [2a0f44e3] Base64 v1.11.0
+  [8bf52ea8] CRC32c v1.11.0
+  [ade2ca70] Dates v1.11.0
+  [8ba89e20] Distributed v1.11.0
+  [f43a241f] Downloads v1.6.0
+  [7b1f6079] FileWatching v1.11.0
+  [9fa8497b] Future v1.11.0
+  [b77e0a4c] InteractiveUtils v1.11.0
+  [4af54fe1] LazyArtifacts v1.11.0
+  [b27032c2] LibCURL v0.6.4
+  [76f85450] LibGit2 v1.11.0
+  [8f399da3] Libdl v1.11.0
+  [37e2e46d] LinearAlgebra v1.11.0
+  [56ddb016] Logging v1.11.0
+  [d6f4376e] Markdown v1.11.0
+  [a63ad114] Mmap v1.11.0
+  [ca575930] NetworkOptions v1.2.0
+  [44cfe95a] Pkg v1.11.0
+  [de0858da] Printf v1.11.0
+  [3fa0cd96] REPL v1.11.0
+  [9a3f8284] Random v1.11.0
+  [ea8e919c] SHA v0.7.0
+  [9e88b42a] Serialization v1.11.0
+  [1a1011a3] SharedArrays v1.11.0
+  [6462fe0b] Sockets v1.11.0
+  [2f01184e] SparseArrays v1.11.0
+  [f489334b] StyledStrings v1.11.0
+  [4607b0f0] SuiteSparse
+  [fa267f1f] TOML v1.0.3
+  [a4e569a6] Tar v1.10.0
+  [8dfed614] Test v1.11.0
+  [cf7118a7] UUIDs v1.11.0
+  [4ec0a83e] Unicode v1.11.0
+  [e66e0078] CompilerSupportLibraries_jll v1.1.1+0
+  [deac9b47] LibCURL_jll v8.6.0+0
+  [e37daf67] LibGit2_jll v1.7.2+0
+  [29816b5a] LibSSH2_jll v1.11.0+1
+  [c8ffd9c3] MbedTLS_jll v2.28.6+0
+  [14a3606d] MozillaCACerts_jll v2023.12.12
+  [4536629a] OpenBLAS_jll v0.3.27+1
+  [05823500] OpenLibm_jll v0.8.1+2
+  [efcefdf7] PCRE2_jll v10.42.0+1
+  [bea87d4a] SuiteSparse_jll v7.7.0+0
+  [83775a58] Zlib_jll v1.2.13+1
+  [8e850b90] libblastrampoline_jll v5.11.0+0
+  [8e850ede] nghttp2_jll v1.59.0+0
+  [3f19e933] p7zip_jll v17.4.0+2
+Info Packages marked with  and  have new versions available. Those with  may be upgradable, but those with  are restricted by compatibility constraints from upgrading. To see why use `status --outdated -m`

Funding

Development of this project was in part funded by the German Federal Ministry for Economic Affairs and Climate Action as part of the OpPoDyn-Project (Project ID 01258425/1, 2024-2027).

SFJry@MQoOj?zuZJ zNM!P{AfNjQ3k^lnQuKz#`)2|`FBMszeXSG7Np7=d)Gxq#-h{+kfF4)!)@>#5qA<7r zOgo4eg<=>!N(k)$wRbva8Ug~Xl;!7sXWxU11AqB^aWD%>Kr!k>HqS>;s0bm3FRf8(x+2b0Rl)^p6`C)}`W%EiQ>#1*!b>xn5m zEhtqi07h`q`#yhplZN%kJM$(FfJ{+#;LYS5AdVW z5Iv`PUt*HeT!|B%?wVswZ}#2&cHUk$1VitFygGI0_UPxy%23+6yCUbny?1kf)V}o{ zsjfPJf+F+>*{RVF2; zjT=#t+`Diavv1lq4*9$tYbvUi+KTnNU?3YeXZ~t|j*blz!r=h$T}fw8#G*yT<&%CL z?nwt;`8W)HLk1(-NE(_1srk;Fx^(^%6`N4xW zk4o1T$QVvXpiTv89$%r^qSSCtbgSm7%b253ZS{j&FFxyASN*9fnYzVL)0vfcID=mm z%kBiLEu`>MV?cX@@Q}o)91>Q9Ey%?j2cXZ8X=YRkfpBu{OgdiY6d@7O;qO=8D+ea= z0j-5lI->^2AcD{g?W@gZub7>7xyKvtC0%Fjts+17g8nAKV|*ImQc*R3qy6}fOb!Zv z>Bw*=*c8$N|MWm*Ky8GWHyY zJ7a|Byq0|6u?v&0up;e%np%;H9XdK9nDglzLJt+2SOa~h(8BX!Nl z9H#H|K%yIEt0SQdnVSh>V^GGvF{2>;RvnJ>>WuyQivwXcS?BBB$PQx%!$3V#s%Gv>6%_1U3iXY}mz1v_$tO zi##Td_qYH62$oXKT80RuVr~XuNyKot1T^4B+c2?+W4EP(lYO6gVH%!;NoWM08`NgJ z-&P?CK$%a{zqZmMi=tYx0>yu{L{dA*gW^r;zNJ@ALi~ev?mBi*A%lbTeBQ}TP4&Y+ ziB6b7_-M3K+|VLqtxwXv*md3P;+#R1sDwbIVDh;62T~n4PI2*GU>m?1Q%H#!tCeTP z>X!40eRT&RqIC_Fxcj{v15F+0ZOe}Q%SIExS>LWG7e1fNw{opnq)Jc#68h18j%Hwg zF$sS0dh*o~XEWD0v!OVHq!%;H_10hgCQJWT?r3!x zP)-5?FB#cDA5Fq?@pa8jqu{)r0=paMS}5Ol#xNK{Zj`T6q&}g!GlAT$<4dA=wS>o zQByVqa}tFcdP}$>L|tB@tS1dCy>y7cct9UOy`xjAuiR}+bU&7|!^3)De3bS!3;hMr*LQQkLgIvT z*-iqoxWmmIJGB4@lp?se^aWbvP+z>2grBRc(4yy$Ksx*mgr<1|7S}g0zK=-S!(q=k zaIFKl`v_qra{mPie(ji}nx9|@o1O=$B0lf!l^~=&cE)u{&CME-B;YlxK`-Dgu8(8WGQXo8ZK~vg1XWd_;hNx=p5{5i4H>UDNZ}Y)LI*02Y`QqFH zNyaMffrI4o739^jl-nt|4%Nw~d7sT}eQM^T=zmR|J_-hu&?^ECXoWIh*_-~@-F)Za z!^z0$fHWmW`5r*}(TXgWNYxX_S86UiZ+Gy}-=r5KPTcZ2AOJE6DUoo%%PP^l;$FTt z^!xBft)G^~<-`t&IM-!hPe@Z@(OLtSTR9pPS{TNmgN59fogFt^YHrD)? zZA?5MyXVzAXrvS#>6kKT!`QXfT%po&UD?Ks)&r2pn11xfYwA3hXb~bPv&!2yij@8yG4j7Ho>?y3mR0geE&!3>llY!=DEYZEz`Ksf{slwlF zqM+c%<;5Tfd#M-R-A!2yYS|9JiiB|C=--OWka#hx5$&b!c;qp zfLqN_`$5R7p2PTqr}h(1C&?AC3n4boYmzM_!P<)7QOElp@;3-5>z<$cW9g`AKb`X| z;=X9E2z;t1p#!>(5x!w46yV257ezJOXt;y+cP-+kX%|z88IM8TayfaZf;@k8Wl@Jc}u69XvN-U{!7p$}XDe5Gms4n2H-qn$dvq z)_l}QMSBz;rYJ$g2E{3OYru|k4C=;&8ZU@7_SsUQ#qYQ$CV;9_V|x}}ck83li~9U| zx|MeR)z@OY8$0iftscHN)FgGo$q_j{oZyz|yr>&bcfg>>UU55FfT{h){q;*Ip-QRG zfU^8=5!8lA>|=@92a9%YZ-cV94|%lPvoWp+-*)ojz8hZB=3f1fl^l}l*4nU-=K;LW`ZRP5HfR(}n(tw0Su+Uif9-y)4p1)l+Gm|lQ z>ltY7b90+iILVzV>JMtEPHLN}KGKk^x}yuEbAnjl6E+NrJZ{{(lAY~!*dJP`a&L!9 z9XbF|f|XM}IkPSNjN2<9V|k4-sGYlVEhv{b_mnkexBhn+aWJd9n7w+0r_hexA%9D^ z(LlDmgfOD=7?J)7c_XFNI969_S%mecwZt95$jZ7AXP}|{hYteUX6ZuC_2{*a_*#BI z26(}LwWJQ5)1xcYpj+5RDU6>IfOJwd#PkMGo@QLY0G4tDU5+!OL;l64rGu;kx{hT+ z?x})#(i9z)%e@lxsS$KMuWwc?JpPAtHf`V(gds(S*>8;%(-$M5(0 zOtk&qkd6gW-8OloSqC#U)m``Ao{h0uWHdFLr3CdK+71 zqn||a;7aP2R&9L{>uz>3s;L2J02p9 z8TwKUrx|cZq)hgkkP}$@JG4&|MHrT`ydrGGpW)FWv2lP9=(0at9h#78}gYb)}zj$j8Us&$L<5PT--l>B|Y;S;Z&x z0J~@iAsRtaxK_426F;Ud?w9L#+R3JbNwL|T`*g~0O+Pp^p%ijXk{1}U)@ALUbP*hV z<@7~j&+-~W9$3-yYlT=O^rrm)e+@Ua2$v-bvi*vIcxhiGAdB(ok=dZ55)()0YJP$E zfbg6fYw7OI{%){sdzLHd2@bne1$$X0ttpIpP$`^sZDt9sI>3u~X@D&=IDG`C$_rBlO`{<~;WY*Aw)l*pl7OlZRCzLqZwg>|_kaO*UCJzhSRc%CFFm&%oRM3?bDS2dvbq`zRyAir6grL?XlnhN2fVZzup}79&*+1;=&@`qjg!6_Os1}E`^BK0(&?_w7-kBQu#7*?)!^Fu#vrL}rBK!{vaw1GU70s&M@>Q6)iT=5k4&CQq%2SY_Nhv3nKrV3kT z9-c8GDTuD$f9*neuY)vH;0rb;{y8H9TdekoS$uN59`Bn$Ju%IK?MfYdz^r^j|(kTn|vLyKsM5x}JXE~lb*s6%HQMnHBU6SSd+)?-+&+CV+ z4qaQ;4tzX?%-p1Gqj5XOu+2zZp3SmZPovh}Fg?mQIT1kUVD%p?N_}sMi zyIBN+s6&o3!)G4WjWJ~`{W@g4IfpJf_4U-85iMrZd!sK9){XrBE=V<0Th}=g^1A~S z%Go~i{%144x0aW|zkv)FvldATiTU|H1=Qp2qEsdaTlklFaD2C?FBJk-Ia%cZnrMZ; zGpPMZmf}k^AsV4@b)mo^W1ZO9r#!ZEpu4<(#j28YLt1uZzikQX+k9ykR8zzF24XrS z8_rlWOTc@RZD2(O@t>vGQk^3vibP1!1$48K{YX%D12iCkF?EWt5pd8Ag*XNxq?<7~ zOaBrs&WrUw&Bjfh$eHmcRAPzxShCna|NoegRZ7_E>s7=}^Hh7~{2jaXjK<<@YqW)M zGlf`mN9u1=<0)(W z`3um(nC=tUZo!1?jbS5^S_lE6ho6Wa*J%IGNcr<9UJE7m05kl?J&xhVFkFCRN49>x zqsZxxzEjy3tt#tZH>+R$P|r$8_rV7D8!63t73^LbYZ*oHFS*tF-%F{X`UWBVNu}6X zGnjNz`efDij#*;an7)b>ls)HK^SETLBZY~inmgE)!ETe+Wg0Y04B(@m8h=Gl+~|5x zIO$Z?Tg39F!Srd;8GlPDgTGc&@sVXCu25(R59tb<{6&?gXJ{d@L>as*`NS_I!H1>b z)20T}8@yHB3eHk0pdQ%h{8x4`!Uq`g70X98)45`jZ#BnE^~iU3rs?}eB_&q_rgO@+ zNq2eyrQu6u+Q=Wy9T?Z0!&dpyJU5?mK8|NrLi@`!xhbcl^fFd9^#`^Wbvo)X#u1-f zE|<{_XAJ_%$wvCdZnn>t8eW!w%Fi(=D{&{+?xdg_Sa2N|<#^S8BZ^CA#4W(~u5`BV z&LlA24if3yk#qvi z{L+gI6*h?*ewLC|m$8XTd=ZCj4G@U!IMI(5K%mvaO!$S+)Zl5ew@{-mkmaV^feF6} zjgkvqmTJrC2CGMuJ*k{*q+lyz<t&bkJkS*4lS}(0!AX1&QMp2>{OgV0^jqsx0+{^(dFGD_Y(T?mClN8BR7Uz> z@0mXF?o(@HT3Qovx@?L7uXLo|$IB{s*YGwzBdE9FJ_V2-GWaub67Uzh{?wk{!Da{5i&;SH=L&88QSqdu{51#E8&(un6$Z>GZ+%g5{3)AAnNbX{l%sd2wsU~G_ zd5Ai)1nLsBLhqXej<*;;hRo`*G1X%T+@g>S)%?kEr@2P^uNjg@e+7_MHOiNz{hE3S6|Hok{rsPKZDfN*Zyno@Fg{I;|3RE%ZpUjy^TNh@m7+2Hy%?>! zvn+W2^D;!zRbqVp83u#R4!4Hfj}i9suR}AW4M*AJVMgwWOZ+XjcL1#L3yL3uN+pEb zfpCm@w;mKbufc?**crfXC};azuyykB4--@V~M_QbwyOu+PP z>=Y+=mkq1%PwbX?g*EGk?G96uw!cnRcJKHn48xHQQph&`KX;ULR0x_;->|zKFjMCI{3FIz~Qq5k!l1a46kTn8&Q_16YN3FjN zn|)ETNr4{X+mFS+q(=SD?BkM${l_LLs6{fQV1h7GXI^iY6@1ENfJb=(P6nOR_16u+ z7HXS`*#Jv-1|gy3Q`iI;6`8-5=)Yxaf1X>0&F3MNxWEDbb(i;)ERS?Pl~bF7n=B*d^qS0fkXQIx3MP^7*1{vdw?&nZVL5T1^a}WP#30W*Q(A_+X1u??ej&bhPtDm*vq?2xIMX1lHICt4sV zU;Q}tKE8i-7xyLb7;RWO3wZD*O^48QWvLfYj?!yL6~YRWLj(?5(%`6S!k?x#Aurv1X!ZkwI3#H3R=EDmBCcx;46MY z_M2QcmwZn{c4oxF>j~4iu5#K)k+dtb2R}G>KrT_5s=V9)#bvB)_9=G#$vL%DbS>_E zBPc2uSs!$&GXv7rI`gq@Gyw%yBi`x&oo0EP%!XL2X*(l*qs9kGP!Gmt_9v%jLyYfr z!G0`07Prm-5Gr!M$YV3bKBUp%z*2cs`6Iwf)WDFi@Sq|X&aCp0z4`hy z70z1F%aK%--?m@gv5LH-v4BHnoR{y^(wUXQ?KcxdukrVDyS3GN75&S77i|WW4E6}0zH2U z60OI@q@-Qdjk4u8Q8%*nuMYPVy(0Y6Rj<*ZszAapjedIlU0>#^{)uZG;Ly=^mBz^N zR%3Toy!6qh6 zvDVH~cL^-Qx^D-23^p(4M1=m&M6(3Fr#yW+hC?zCuUp$DldqfL-BgVDe040I_8Ad$ z$Ub5^N`8&g2mSg>SE{9h4+}hp30|t#x|;IrXMlqzCY0l|%Mv2*mncr$8ALQ7@H>k4 z3CKHUEWk)Jz(D3i<|0|?3|j6ID4Rt|GxTo}Oo0Om`F8q9_eEszA}rNICY2O23JrXu z+cMsOW*1(0=6sn=wcX_t5_bxbah>C>d@znO-S$@ndJnc!7C$SG21de3mqjMRhtJct zIpd$}1ID`MQb_%!`xJX% zmjcUO6r`Dap(-brmw5~70|UO+c;Q|Qv$LSF7K%=})*b0Ec3)YS{A1}oCh}G|i|jSD zj+|hL9PDe%nCfMoMr2kvKn|_+X)p!$J@u|yJwg{zwQDv^yW_m0u%LUTX5YIjl;wI` zXI(4BC}@fgq7>7+$grdbG@1V*+<1o|QJEG+zP!Nyq8mUHtdO#q0KiW__&a0H&)OxB zoWg`a)fL#(KJoC=2s=u!DVPhwOqy52{U5s#q1m^%M}dH16qj2rs#i>#6C?#si ziWWG^o(}5ZX~&QgYQ3#j3R^lL3M`?X3P+rH%l4)u^9uEBcWRGlVP-SH6kcM!lm50f z4N<2PqDjRWvVqVj1FmCbuJh~#mk>EXnb=kW-h3A2d%sZn@2^!JFWDCeZR6m>!a{SOcRW%0^dODz(#(LN5fWzm3vQ^94t0?6tBWq1H z&8$`dBxAt;P?JgxI}%BW?52$!P9GlNgB7V{MK@H3LGACD9#UGX2uG$4H@ZSGEX=iY z*mc!&Qn)FzN-sf85o?qkCxKxPUQ+sbPBjFx`avl;Y#W!?k>`>mjT7h14Ob-~q*#i`? zd{^CYWv!H!TP`PTD~z}(5KKyg(J!@=me@Q1kjF-xy*YB}%ljdA%c1l_Y}+y|pfE>X zkFS^e>6;x%8^J)&K0Eab8&;IKDsK?Je-#47Ik|F`5zLR(Tu@RD?r(kf@zeQhZ_6O% z)T-eCWfoi8`LsFR{2K(hnCJ7vOdO8mR*oQE>2D zn2$GS3w#@>!)o8ab1WF*?by$6qTfHuEEuV!rz`R2m7f+eB(WbA>R0!vrSFRH_IWAv z0Gn(>h@GqHpN-Z`M4&tWK#75RVn)?52-C=+)C>^tf=vkrzpd@sMn#PG3j?? zaT;=Te978->A5~(v$8hxvV2d+gCHMQ1|`PZ*`NV4GkFX47Lt-SoNB1uO;C(Ui?-7FF?@0e6w`~sP8c&GgD^Py^Vc~)m{JA zyx)-tJwR@N$aqr_%>X}0c2LL`W)h=%w8J$z_yqc@X^`2(!*~$JsXv_2SaLu`xie{N z900+T;fLKRtsnudfiA8+d-@{%4cHd3^nmR96;b98k3oOH7T8LHaMcG=$06y6kbyqM zv(!HWv=v+WWYe3JHrbFn{{c;-Ns$NsYWwS8OaKIOp?eEoq`258`bsVW8OQYa503Hb zmdaJ{wP_0Rr}JV7#~pL!f~ad7?hhY8(!T#)?BdjC($nKgym>1sh zEUNmmQJJ>5ZV4u7?d|n_qByeA5ewUo$$YAFS=dw`DJB5cx#phQ=3j1 z8Aa&$X=~+`vn52V`1EG9r?WRfma&2A{l6taj&9LZ$VvGI7{Yv^Qh&RNfIg*?%`v;3 z0h!7IouTU%X7rE4QW^NhVCpr1F|Q<=p=D70W7X;VH5Cy$Y4i;#p0K3yTnEiPO_5+> z8#DbUX5{50mFzv15Jf?K?UChRv8Yt$3UCJ?9hQ#Az-HzJC*>i~t?3sH&Qut80F5Z1 zhf;GNb}zKu%%_*phAp0~C}Nl~fD(##GZIkio_z*jtRgovOuUO$uK5H=R6ChVYN{~j z$2{ujJAK(LWlGS)^`q!J_~6k7F9FJ2K1|X@Y&!8_B!zHh?AGJfP#+xC4$Zt;VL~0B zSAWV9n7&s{VG)5d7xiSQ>qWoO8$8LPEIX|hff{3oX|D}(DO7=fdkK)Y+sL>e@*T;7EeR!|jnC*!APALi1TpN~w*L zGWP}|zm5!K0RU!t#J#0IGR4KK5n|Reh=z2L`|FEQAW^xdjuB~6EAp$PVnTfGuq#lP zHUwU9c@Li=NSI|)l*XYsIjIZ#Up2;;5)ckPRQ4zIO$-aWu)Y{!Q&@7?NO}G;R#!$o zcm+8>3cwGr-yzBmZLDqy+DvWc?#A78T~J1uk_p2GScJrEPqff%Xyaf{9KMg)hW!LM zW?G-VqL6&dS5G!rhCb8Dt~kp1lmYvkdM(ac%;b}tpL}02&$-K-*MI*JZ+d0|*5a{S zFeCmwFclx&Sn0%Z`;W_3C00ic9^KtOI`Tmu6@_qYgAeU!Q>lBfl z3^2sOu_?um2$jtHX}9Xzuz}nR`yF2hr`oo722fZ%_ibyNFKqq4c9E9FSf42hs?@Jl zNV8B)7{tBj&u7dO(NT%QSm!?O7Ahzqe&{B1z5Qlz`@28T;6u}R=Qi(#Mnhra4*e`b0QdMcOm2s% zO6cK3<3dkW%sbXnizU1T^DEK5%W=`k->OoO?rLP`+Kq-N7nLtS!lAw!?`E+a8>8E9>KIzU# zu~JKZ)QDO*tFTp?;2^G^>f?GTWUFTB=IxAA)i4(E9icH|U&`8ndhqK?4>9Dy& za2s5LQ<5`y|?3R zhkzD}MymWu7b1C3!&aHH2r~iIYkWw_cDF=Zw(?P+OZl=dYeO#V4I`OVsb_!}YyW&2 z>&hn-g@x|&HB$^__IrCBCjglTq0)|vdo#Ze z?QQQBQEne!pd_IMV&zUH4Wi8TX?67LwXwF5JeZ7x$bWMnFyo=q?~$KMT*c9i`S$Ay zJd>;3C=NPFGqX7VcuY4UiPzByrIIurPQV~rfWt*?9cy*24G^@}dCIP6(CT{b3OYz?FsA2hdOs79fsXzjSpONz2-@%W3?b`nQAu&nPo z1r!ml;7{tBYjpDH^HZp1$1?>?ZPY_Pm6H^sN2|1$}XPi{rGVq805reo0BcY5(_K0F=)^P(d_MT8qzAN<~&)a z(ZYpv^}a}L^FDLJc~uqmO{(zywmnBIt>J%YvwLlN{KqKu@3LN1hrRD6;Jp2XOXzm& z>UC3i>?5bFm4;N0GtyWLJSHNzq_@Pb`UPLYwX?UcKro1OeaQrvL-HROIsCoD^GnQlwHm0xN##jtw(l#1tfbMpR;WI)yTX59`SPl~OpX6<8gfS#J3j zXbjJ_2))j=s0g2wy5I`Gou~{)Uq57oMpCpmx|%jgON<$ z80ojig@eg*GIW@2TV~4}|It>uEC&rZpGEp85~3?^z-={`|OFaMf;!5P9N3n@*lK=SsG`kra>m8(D{WNk!6utx6VTktlc~s)yj_3 z(#q$GzZo(b6 z2p?o-iEb+zQ(R#w2AnsW=TDX1x?-Vec5;HG`A`x$~2psf#7HO016_;B_rDG~AScVNd@nks2I z`A2nMX_X^V4q%f*H5VhRw(%1fiLKbnFzR@=Wc^1SlUo|X=0?i;XUTq8`l zz=eU-JdQ`Lyv3@uw2WeKDFTfda$cnbv|-r_zFOx;ThHf-GSajFQX%up;sV5Bi~&Xb z^<7|~E0So@~NVv3?!D4S6 zp+_nBU@dbg1%rclCGL5X;!$J18Wa(%|0{V+0yNKiPc~33Yg=^Mm5bCh!7Q<0tpvhS z&eKQ|Ou-*g4%x|sJbXr#hYpH{{C6G-3r=iVeNydvyT0B{ng)_klkjih7zCvid%Kgs z+H2N9bD*&<8~r!?n6VQD8lhxvmIXx@Zp7f2&+0)=G23Q`DBvM0o%8f69M%S}-Z~MP zJtzeID8fnO-A(k*@;%zYR1{ynJk&uLgs$@cy}Kv>KH*sy?SoXR?LLH}Ilo5A$bw&3 zD0E9hw??%ND2jHG5BA;&Mq%l*V5(o!diA(BIDy=0jhDDqdg>J6`Y3?2HQY71Ya0z< zmo6I+0!TW}#GDp}y&}zPL`$dLdqWJhI3RE`JiZ8mn87GHYdFB)5CDn!zm6QnqaS>% z3eU=s)s^N*jN#|K!ubzNk^HO}_Lj-cAo=CmMr>Y0LExmQ@Y32ErY`m?fk9{|roON$ z9q=12hPy<2+gBacIbItg+E7NdKWC7oe_ffj8Tq3f?%ix=Ljh&i$PRF!txaCCsW<*5 zOAEQdbzzp31)+;AR@wR;MM4s`rPc#`=iwjRPYC@WdKDp1CZhdfr{A!&6hr;&${6cX zi19h|;QvCB5r4cyMy|2rhBU|r&;B{Mz?#4J7nn%@&-#l%quBOpPdK(Qh91@MhI4gI zP^!C9PTg@jbag7_{icxJIY4~us}rWqgO@3Gw|U_+f@|qGZ*Q(i|9Yqh1e&Ys2Hc8! z&Ry2E?a>drNorwz(L+k?+8@Qjg#0AIyKVT^(NilQiLYr2=MGV+c3PEK;XQk)*Q3`2 z3vkWXKg~sRG>c8fLxNd$?~s@Hm~scVx|8q6m)&96>!BWz_Hc7_MxwzRK|m32 zve%z<@z*G^U=hEIU5tYftxI+UCsl9ZmL#TTmtj=|{nMS901>JCADY<)FuA3j0iFs- zMxV ziQ?QbXA*&HE^oO_`|aneQ~as~qhmMxo8OYge)KV1zrpL2vCD1E!2%OfbaGyu(=Vnx z&&a-%qj^bBLtfTAxh8kFZJ@!ItuC6l9KcwZ{MCXIy{ElBoqi&n92K4mj`IYDvtMdH z8#r{~f*ObkCRL!rfgk4Ml43q!X{Bs|A{_CbK0t` z2Ao=8TKVfTRA>=u4CYqZG4mu$x9(xfA5G|{D;FDmoBiF$?7JmK3=<8)Xm&vHHfr$d zllx_cB@DQM)z7LD@zu>UA6=?y zI)TLi8y%dewlqIL$m{$PdoAst+OU+OcgAO=sHY_!jmf~)o>hn-ST@A__@JhmCPQ$A zA2C4NI!!{ziaNpbTo#2|JD^JxjUdteb5}b5q!Yn=GR&iyM{lfE!!wVB?UL3ka8}0# z8owpY(+bAigBq@~^is)V+UZ*){PBhS>Pt{UwcM0ss+8R1Gil`zQg&Cfi4F1DC~GL& zCYZR=-P>tHHKJo!FfIP%EeEXf{3 zSP}mXqQa(6es=4v%7&~O7(d@>(|W%&iMN~Ytrny6u9y-U@3Qk!kaAk9ru#$X^U zqfmrao&b0}S-! zELYv$DArYz1z|Jtp1UNWt<>SL7*1=SA=7I>8+9rc{haV9fl0HEbTe; z!IyWm+hAOX1P#oeFu(4mnU7t1$UjOypeRBB#@o?Y47ny5UV-8EYfFTsfmTAFZIlAt zXFNpuLW0juUkAnZR*r?)U^>YOt6Ckm++~1_*emH%3;tEj|>SSs3+_v39by zY~csB zw7)7&cf4gv>g;CkEd7Ya!2WU}XD}HYw~)z{ZMNgYMkbdXO!@808i?Ui{E@=itBzxV zr+t#SMr*LLyF}R`MxDOx9aMCEZ4WjML-C{Dh+z(Y@Sj)?MkZYFTzd!=&~bs^#dy|_ zbYnLs#iNQWv^i|2d{gWjWVW&=?>C&?f=by#f;xk;XM_>DPV%@ky+^u?Kr}I)FKR|I z*Z>L)qbK&H8#NT#KUOHMYcsqjnk74FxS?pa>Yl@R1DZ}Km%tkZpF*|Z7LtrwkKwo6 z?Z0}{q_ZqHwp#1y$fdQd;(rdbv&E@pIifXJu~}slp7PEpH4%8yDRhoF{(kSl|Ew3K zn5MIuWg`?xQNWr@nz4hU>dUb}47b&QWhT)I-ee4*pYM`P+ii>3%!Thkv-2m4f zBU=n`)L&B90lN4s=wrpgSRlea15h31v+d@lY&UQ8p?chSF>LQ2d9x}DOi_3mo69}2 zlB`5mp^r)&&PPkwY}+%`Cwt?fW`ycH5^^%00GU#Zna9#{wbTd&!-elc6zGWD@8yf5xnUp7tX{dt`P(>w!W-J=BWyB%f!&55`#d zf^V*D^S?sW$ag=_G_*XVry%7(S0KID_1W1yk~x;*V5A4E5pD4stF|sf;SK`xnV4Q` zjw5KaYj$=Colw52uZt`7;;E~LEr@#5>?9lpUPzd$bu#QqD0~?a{*(Q2m*9$t%N6E2 zzvsN)s38+_r9bU3@&>y^-16prne(V|h1(5aS@{*9*Enp;|dmwxg-c2T8W3wdU4i4ZrJ#z;EQJdGce+WLYE8 zj=tL(NQ`X$Y5$>y1psWf^Kl;2cq__EtXY4Hu>dYNt~K_fX5rbBvn3w z-;8&0+_s@A_xol&j?bZO(*g7TJ=wy8AX*<6J=lutg+Vmj*hb9lTkGi0BDvoSS!NR?$KT(0P>Uv-{oRR^!VVSAGQcwj!3zyuXHwhb8Y@q zR8u3(!SLuq<174yN$yn~O&tB$TKK1&Qqiy7Om6D+tm-Wo9EUhCkBujg2aTO05L}+Z z5ku6feaZo}MALF}-ZUTDi^3;>+Y0l7FF}5O1Hb1Pe--Un zC2?oLy2YRyO1mRr<+X*7?L+A z-ih*xow4EdQ}%pG9B~^7gr+RtzmV2!S4@r##FQ4{5@=Z=QnUy9DXrGnhGh{HYHjV1BTw&{{uoV2RAY+yaJi7>-r|_Q#U$+ zms$#!mzX5Db&<2t7l!SqOXOS}*U`(0h_h=jC+Us!ANoUqG;@xOjY4`vI@s`<+n%ju zxmg1h;J9o{2QLhn^18;UoN`ALT>b#M&)Z}*gHsF+h$SE=282Z*3sDbq6= zrbQ;&I&=^~MiVX$tJiDhZ=oL?>m}HYcXQ;k=C0=z*jzQiu@z(tb~rs&V*3c2EB5rw z|IhI$qBv~!u5LZ47QCVlIBfS>s%!wZqr#>m=srcgD%V!WUG{qJDB{Ioo9>zz0vIc< zdS+E7i%*A76D`+?9nyM7nb&|HSthcS^8Go_G3D-;acnc9LyS z7J13hYP?oBReNSjl_tpH6!#O0H#VWsNa57Mr+}4k4J9<62{V9c$>8gC+I}vPdc*^q zd{j~b=ck{r>{G+_Z;Txu08)T{)&n4)5RAk{~z={ z`Kn4wv2SNvoT|@ak1E7S005ASrN?{di>3mOYw=)s$x=1yKP4T9^b=w!1b|k=X`j z2BC@X1K9-?3pPz8d>diZEwxk6AmVdAtgt$pQeB?q+Zn8ds(iU5XnHkUSnN1C9a0~ zVgHPmL=nFjtpkdubQ~_#EB|S{bXoUVz@d=@-1&oH2f_etawBcq@LgSC;v%}E6{>!rq^dqktO$^i5{>2YxA~I`J6+I6&d`HzNEmE8$gz{a zWS|V#aTdnYHo4)jBPuCGN{mLtK(2zgeX0K?qg5aY{oF=dH^NrbP78Q*WmpWJZ8N3= z1Qwwt=_vSCKgu5XU2mf8tEcan*rsieS(F4-+Nr*2@Pa7`Y?oJ7DtHQS^r?sYy1{d9 zv^}SXgAhbyfBD2{(&P*k&0iPRwXb<5CeT%ZRDYRCMi$azrewsk<|BtW{ z-${;2g}ds&^3So6|F-G36_y$Q`KH(d*tiP1jRCp&*-jJqFqU)5IP5$eu~cw*LWJck zYyIdOWV56~_BwdU>=b3%wiHV#n{MTvPUQ=|I-=RNDMY_DjttOjO4DIz{pA~Rh*4(> z4baERW(4p?+)j9dFGVHL#Ai}()2NY^A8tJgULO}k)b!51#6$_dWn$c^X*s^Vy+onU z;=AjL-dr3Ya&Rq3=c$HiMsV|rH7q&iB4L}X!-5+UW;F;WZI5J8&jmIL-8MBuv79a8 zftbLWJ_DIfaGkBAx5IOU3MCW$4Le0`{?-Ke%SFQoe4K~;A{P+pl#0>DlN}F<#k^NU ztM=sPrRV$WGaNGFGoer)l*{(MN-~wxYPUob&0l{VN0}W_AYDkv=P>KnWpiL!8LXs+ zZE;giJbXkVv1AE)^S6T$642(*A5$^;%@7V9GmfWdF643*N6XbA)z2@c!g$LUrywUD zA>0>fpOO{rWPdOY2h*(q`qEc}BQyxcs0bN6)GylXgVE81v`KlF_myW;8~(D{_de}x ze+ZqhHUE8U*Se>TXP<*oE!!r(9B@dTBt8huC}9SoD_nhwP0l^pUADKho%P&@m`|*+ z)zi!rJtU>{^&OuL{BXz=-k*@R(QfMUU3rQZTiN#zosAk&ai>w@pQc@K!K_L0~^6m^Wk683MJM7}(oxbg62ECJZ*{pM0M4iA#= z&c@>K7gbTXr2iYXpQ9AU$>f;V4*$H#s&lC9r$0%`uyQ)&$LA2+IXme@H+%P{MVfayvR1q-E>L(KhWJsi0t;KS3!6E-{Nf;PE;* znMz?{?NditBBN@|bm_388GbkQ^~~FMF)RX03Spnp#_q0)xNwQ05X7!0bIDua!?mNx z1YyI-f|PM;ec;#bgRAJ242+`^d{T_n?aFOyl_*Lf1*&l@f!Lz06M85|W-=R-zJd}$ zr}RVacSL1+{#y1sDc|gv-?bIDkCM7lIM6Gu`n1K1E$YiX0^hpD`q^R_!bFtb7+CSb z6DQtF07t!6OVQk&%pEz8gyo|KW1`j=ptM^a0>3~HZ8;bN$^5Zor%J`38#w;iyrxTv z|ICa#IsYDl)t@Y~R`K<4Z3+zObekSW+0RUcO_9XQW{pafOPRVtQV5^05FU~uT`3Zj zc2E%%nRJ!q`bTCjM_VzPf*O1->990Kj1$@lmb@LtNhK@%p(<01cNLT~pq|CPibnHi z*af^bkMYBPl3&`{;@n`nE2@_IOcVNlE{F(Kuk15Uxz#Hmz|G^Qsi>sEtL0idsj1b zxHIS?pWYJdS)0zAS@sO?^zojVRH$dU?6%s9?yFEu`14}%JJ%(gE^*3o(R3MHqNg@N zh2|4rSTVhUjU?77QKLEXOce(z_JJ=--|GlEhCn*r)_E<)>TN7{LJRK(0*T1fmge@Q zMauD4{Utizv3NPwms=&_TB4>rAi9cq@Bl|M9`rg%_clb}AIcnx%y=~UR(~#m_5sv2 z_+E~aY3^MVq&v*}L?dyX171xmDRudnkz8`(@;|BFC1&yNBH9M@UIFP^WDnKr4sTQt z0S}>~zJdPQxM|VD^P=Yy7K7=g6fUeHH{qAUV`|o=L?d$EItsB|D-(fBQ%8&8Y*8wF z)lAa~+zk##AW{m8_XLMbC(0NEdrrA64dPMRF>3B$tyDx*?}mI`WR8jJvU{M_E~L-t zMA7cl%VUDO=QL*`AV|SIS}^+r_zV3dHoQ?O8iqO9-U=~cH^ECPse6DO;%bpavJH3| z3th#UBVCG1Y$H)VZ9qJE2`_V{ej#a0j@QA34L6~V+PSLSCsKg&sUi}9nOxOw$K}8& zlY72{*gHhIVk$hEWl%fR$a;3(zFl@gTr!B!Mrb2 z0v`Q8xmKl|{wt9ck$_Kd4ht=-P!E=QIRGNt8Km;K$c{i41-9E#?^G!z3aXq)Tyg6G zUV3f6f5f{3)6||w<9ypNVG}PgJ8`!DDOyz6AsXCwM+A^)~Hd9 zx5EL(v6A;Y%8Yyhp}w-ZGESaw9gL?^Vjg?}>Gb`%&bDy%HOo4#Gk+Xy729)s(TVvk zt9j%RwZd?NCl9nxVFb%hr8--vgeDqVop8%lpH?Lx6YkqfyDLY0ym0b@2kQ}1!AL>h z&DJ+3LPUH05j`}(c2?wSD_nZqk928LSaW~eiSC|8PBi|f##cX(SAmZbgiyo6iXMwVf&je^VDQ+1 zR4~;M0%Y`H!>8!7Lx3VfF<$q!2`AKpm`~Uo;V4g{t%ykvOGX`0MPvMbAv<84%>7X@ zQiuW^9NB;T*+V>l*n*QG;ynV5qk>gKA5C~K%}P4q-`WRoL@6oj($^>)>Tv4lp=ufr zInU2DUyi@Rel3a_^E^46f;>p!fO}#hYCo1Q5iNZ2aiaOp-Xx=ZAlTdnG%}hc!wt>I zBEJueDF<5~kUQpIbb8#3SkJFU;W|S+pWHJLpXX8&Iys4204&j$QQI58+%D|MC;Af} zvQ{7N2Dh+*a<}Y(l~{52mnn~NAo$6DuoZsVvwd&Ez!UVKf}9WcV(ZLg{7}C0xCn#M zF>n9pF8BwW@vh~TzbfX$|mb$!9LG`(uG+uShPxVq~u{&)u?4-}$; zhlh5z1hKXSd({DK+`5;uBv&hxq=BPqnw_DS6<2Nw4i# z1GKAfYl8AQMR_jOP#!w*2$4oaW3+pEGPWWN&UX11Z~d?%tT$dPrBX{O7|e8(^FX7C z)xsDzm?|$J!dHMHF=mU8p9UdHg4?{!tDz#JYaM-~r@iZO^Tps&kFAs$O=f$?=LRr;m|?@#8?^T zpP!IG8G`7kwoBSw#1FN6;G#m!tg#_x`1`R9Kjtt5Ln1n&Ycf>ZP1MtjtXw3-e&Hx4 z?g1=avV)S z`Rv#>1hphz#5qwmV91QW@g@Stg<^F*;|DSeCumb#Xn6Ug6erlWWu<5ASz6h-kwVS+ zB`A#mw%m%aj_hBn+Lv(Qfimy}a9hSoNiB9c65^%``p=X=Tv_A`KbvU{590T3h3F@U ztCCrXr*80kq|kNzAajTmj!Y19&dK1eX`oTmt<6J}*@}vhk$#?#W-(hTGt;tw>!GEd z@o==Oi^MHF$c&*rzojxlk@7ixUX%%*(@Mmla)jWW|Ueoz_OEY4NamwcL`Wa8EA_L7L8VQw-*T>-2UIXRs(tyV>Z+MyMftNKE9r|FVY?x#;Dmai z0)!#r@EY4a5A*!8dYKMeBy&M&?2@5fKH8Dn@8otRq8-qCdRR3J>QyY_^DAff*3`}- zhQnt%&8k*{x*OwX8$z(mEjIMm@jy;H+h!*Hd%q7kxHL{A=mu;o8ZiUm$5E~T$pkQx zy?8si0N=T%aEQZAGBg}bn+^N=kU7EA0C!pRI1YKQ*Vh!tXi;5sUIcM5=vCt`rHR(m zPACPC5Y%OLuNQ3>+>%DW2JO)1CF-#a@-3?c-V6O4HGF%kw*qSwjH_o6>TtMe?ZB#P z8`@!hR4NYe=jRfBEv1$9A%nqAekDUVU z60#s6t~baD|MV`yZ!h`Sc-%jDaH_2*o*H^bLQR6%Z!jemgn)uMCSaRt8RGS_7@y?T zZlP}ULBN2lmZ-e!dg93u7Mm`@3W;c~WQe_M^lsqn*fd;y`Vdk#%{JsL)ojLwc2eR- zAs10zu>31nopss16!;=;rIPWzFuI#~R8QMxs*(zW6NH8NLvx81@(xl>n{^EC_G5iq z4%`eC6<;{+5FK;T!TPWPEIzsS7}v5PbXi-0MByRcwVEE?vVTxQPka3HI!P>)#v$9& zqXfA^)1w9z00(#Gy{6B1dg|Ziy0T&+2;9JC^vhXTM`uDbYrB~yMh75x@)E~&f&~t6 z9Is;8^}cRAYt+sX9%-mh;0A}|SFmC;59mu}txxv4EzQ8$w)fg;h9dp~Q$?yIO)8eE zHhbo{uVKc}JNR6k0;>29uLe8zm9~*V@}rXWoiV~ok6wu~7}a~nz3Wud#>*ovpM#x9 zY)E~Q?oN&kvCOv4K>m@17gRm>vfL|y%ap`R@>2&rrl^9RA;{+)2p`w!k;i#$uyh@Z z3EKgQ=R%Jzmc54jYbCB8oO1lsKm8Aok}=~7G)eRAF+HA#8lI+p|6H-WZm5~=d-et7 z@p$TjY8>U9srIEVSu{8Lo|IfEQ;g@P1`R>Y4B@lgzKE4)j4zgfgVinffrcC69m{k{ zQ`6i?H)}Iyq%aNA&wg_;tqNLC3GQcq30t25{VkE3fD=@X;~XA*@tmI{_y5{ukCu5* zWmM|MOS9sAwtzA^K$Dh5x4dUQs^U&Q}!8Xm%sqRAxl&?ZUHA>r&7RRvt&00Ek-&j{O>0lhUuroau)Z=iCdjMOH3(=HX+V_2plHifs@B*m*#N zO7Y@bP~`fR$K(|M`D{s6uY28fPNZ^BBkp$ROkXE27l`=s!5k=blF&WINLB4p)?u}dke})5wOOgoz5?vn%OCn`Gj{gDJchH^H7JK*!11l5@Ve+n@aZ(-93l{iC zBAN*dOLex52)9Y+av;1v`y3B*Pdix&PP{R(83d^tdn;b81J~uM>N~_+vrI>45Qqqb zw?N@4Lcc`j|JZn25jv%#EOk-PxuQ3ej7HMpyhrB@;0rz2#2Lw^H^ zBq*A8If#RycTCoA&D(TjKRc#0Rs1`Y$)m(jZ4dSUyO!s9DHns<^j*Npl!Qs4F9&qR z8yu3nry%;?JfuB0r&oEbY0-P=T3;`2wS_IWqDnApeaW~Y@t|9G6t(W<9|dUAzg5pO zwQVWePO{ZaEa?o5xqvdooz3udMuGg4*JL@P;+)A%yV0h&5Qh-if>L{cze9#RTqg1P zp$?3cV@|if9|U8ikV%yx_Br-T_EbvK(;k|#oO5Z(>Dr*-#KR8m3qEEU_~=5ZhNbW+ z%0CTtUXt{(;r_LdylJeoi>_*S2JE64mD`(iw)AARLTM)m8r#33uF(2XQy+h?GaxOK zk>yVO&u7V$7k(IGsvMlgrq9qK@S#|vaN$+|Y1JZsQYd1+c5cL%h$I68&p@BSW=dU( z-=`JN8+5XYc(an=f?x^Ms$l`QV90rGlv^l`_Son%K`QC2sT>)kD$ zBe5xVJ+<5u=refr-U6lKbzvJvU2$5)q~F-y{wQC}S90(BDl?0r&Wat%E0nej7_M1b znyc)$eMp7pW3!8Lb8+)6&)NiKc=dU9rXZF`jlny0g2;v3RCL8 z6zs1nfnw97(qh$p!)HbGRKMp47CDKS{&%(&)yl(tWXc9)B?NQh64EZrwof^e&!iuN z4HHsZG6kq)_w4QqDX&3aK9lwA+P=TzSCy0s5lm7#dc)f~6J2l@$IHBdFO_S2hX|hR z!?;+09qeSHfEj%jkgRa^k~(SE*0TCI*x<9tvru|Y2>~gcjf$*!#Oq9tOylF&_tNf26BrB}is!N!hLd=~ucyqW00wnr z9$rwOd9nfV_n2PiUr=@_j<^X1XEnXNqv+z&00eA z560BuWPWT?<0I0t+e%Zi`Ej`$8A87(-j>C_!k-B-js1?z(p^#wTU%iGE$TP5TNRU zt0J~$P?~uE!-r`Ql*CpwwOUfuXUO)T7kf->pxnpV3W>XbBt+LWVJMioE=X^D%5Lr{3TeC*pAXBe4&mpC36^qYjJ( z<{9!?r{1tJy0Q828eGqRV=G5B_%eb!g1H%mjgE?_uNhZra#=XpYG!JJX0%08sJn2k zZ1AceW~@L=`Z?W6EQWK-;`*1=>K>aGO>(kN;Ln-$5iBc47wMRUogDy>pa2lHINZZL zNCwL{0#COLT)P*8um0560M*O5&O{dNGrTyV@_{|Ucn&|pbDMPXN$0Ztm5y3C#uIn=C{XZ}@K|c{cC8Vg0*;JV-UekDjVLmC$q5Iw<_1{x zP|c2~xTs$n}{%v~r{i(vCouXjoxRXfQIBcNGVWA==p`VW&nKuO)^9CM;vvE#zwA!*2b> z#L`AKMvrEuII|@o<71(q0SwFAtw+P^1rSs=b%|@uB8ZZXl}t&}j$fh+hS;c_f+V;C z^1Hm3)%yKE*5L+~je|Hx&`r;-y@TrCC2nLpV}Nk%9eMcLKHV6Cn2MhHa2$Di7cB7%ZLh>_Msy(ln#~iU0sO0hslEIeTABvmB4~)Rh($ zG(7A&qZQc@M1eaeyz(fl{(2OX)Z*F)dK2J*HktTTzdLruuHxchJOM@Mt0qsYV6`Ne zMzEuM^hm=*x@1SxAQdCqU>9jmR7>CNyQfF0Ux>)&zwmGyOIL0bs#d`B1tUuVJ;JG; z?l4;GYe&-PpGA7f7ZCDuH;?o1o8w~rzb@!S=?cc}{;yG*6zy73kXcAoM-e1W>(&@e zISteA)$j;1p{$)RiSkbdkzE&8sQVuJ9=mh1ong0=?coa)kI~`VDM^Dd>J_d`Oy*|; zbn)0D!KQXZwXWd9Idbds3}FvjWU}rNv$LC$%MbidTxx2~cm{T1nPx0}bB3(o0wb_Emrp87Bks z8+A_@5MJZz%A?HeyyN0|7W+dL9(tCyf17xYB$&>$7KxxMx5UmYUvFVxeQ)n7V!%)8 z(SAT0omRhhFaiq}GK({^3il~sVjc3|k1Hn&(IHkFOIy3Ab-4n-+RTp6pz^P61RuNu zn?Up*0Wm_E9ys^@6xN@qW z8PL+Ljxap3j>|f!Q$PQJD$J~xSfX;W0%@koZ4rINsofocC?}nGtuDV!WIR5UB9m1V zr%P1Z6=ZO_a5GzNG`Rb783oE zHm+c_c9J&vi0s+1?mT#&OJT?22cqF28%?-CRhs-7Jmcu>py&-}c4&&BFWFh0v_os5 zj=|>yJM#6)Yyi%qd(@ArG!F6cMm+-Vvak|QvS2Be)1)5Xl-n9@@Z1cCG3ab8yy4vI zURON$y|UWnTd534?|XgKqlfH?WzQzDu=zb}w1dp46I3gAL~Zd|u4>Qd4Djm;$+Im_dYYWwEeeu7anKkCz~w z4lhzswO!4)JaY)i+?j>`$%p0EPn`HzVh%`b6@ihaBQUErFxmaB^v?bRlv&`Wc&@{4 z-7=CfxMJAzo4My(b#ayYu6eJg;yuBA_bUOlq@h(ZSk0Bwcp-u?A6)+e~Ma zaEHzzmx;gk;QZSG>{4iG8k)=K7K)_%@P=r}Yi!Ncr-A+P;yv!uq)59->x&`hAwO(A zRXr)~G=$A1EZ=y8M=5)dp=F7q?Ks*ds-XuS;2jgoa9`JoBO1_HohJAxAs9S5%D7!9pa}PTQR}4SV%FkxrGn ze6I#xxIFXsd7_kE5q%cotPJNYSObNiaam-4+3BtL!OWla&DbE_iApKc+Cb;hm??ovTN@;Irb)u=%H}5PD%sSTw9y{)9(Jf41#J=6k**py=Aojy@?>D7 zIf&hN>=vTA=>g0Rw(p*}NP|*pcb7z`x0QJK<>KdviD9g>$Uq824dSjiRlfL^b)4cS zwNFP?M{&d;{yZ9Q*BqOimhP+n^&j)WciuTmwA|ATM&$HYUjb60x{++S_yYuu|IKf# zHO$C93?m;Tc4-d$yI zW%d_OuirL0( z?KgsSFaU6XrF(s}d`i3(wkOj?JZdm-kkanB%?4@0YT`#@hKM$+WNL>$u&j%O>5_tb zvou^Etc9u77>k`r{)|XdZ``=Alt=rkyfYz5swyNoC#1D2atH4baCTrCVo=-hj&eus z!{o(R*We+>@J*)3gb1L8=&sGUv3LGyo-jY&SP;N}07>YXV&)Kt7)8=z%bd(qWrVj7 z`Q}_%XbOpodCIZ2Ce6uCOsr6Xip|S}wD!@?_)9h8 z&ozHDS+azn5008YER$JQ@(b}It_dc0>tisWS zF8deL({wqw`L;g&3dobrrNH)DJ1(u2BPV9V_2BfJ_9p!t}F{Is7!cpl* z@?wgaO7we0-czlryfI#^2vfGe&FB9m zb_m`V8jND;jj3;|qIf6eXk_jyWV>(g2Qhsk=5mGAOQqGkdff?p35KKv!Q||psI1Xvq%way9AqUSYYFodR5 zUBRIg1ndOQ6xdQnm=o2FV!3|1dDO3=6b5q}xYgSWDt5K)f4Fl@F)sZmCC5>4NzD_`E_B>?iwH9B)o z5fj}TLooKa``0a}KVf8@AD6|W!_VA5dzY`}CY|*T8*(P-5+c`G&l7t!Ktt2W)&+PV z5MUO@d@@JY|MRd=J^Ik7g6&@hMj{S`Ib6|i$2Mrx8xC z%2pl?1SJ``JA!28*U;8{NRN+}rlS_D179y5*5r%iygJg;^`@V^@T5Ie&`dyPNqiB2 zx#fF&g9wmLfig-I3t16{qz~&(j5BN?VYq6tZkIX{agI`01ZAU}Arb&YSdMMEsg@OV zAj5irV}*mCa0@6+0zmh4!qr^3@Tf{^RVQ1>D1@ck25g=~$ zmaU3jDrEa0uzX1#h$G}XUjjIxK>Xee>HKX3xY|Wms};M_7(a;AWwfD4=gG$=vlA9k zC464d-Pv;T#a_2Rj17#h^l=Gf{WU_0e~!Fky>?;CQ(Zu1xVzmdg5SJ}>6J18sH@(X zVuc$yYV+=I*Hd#ER9Z+IpRZ|UW)x;T7fv;h2^y9Li&CjV;jVF>+<7#)kaS4i2Xv%v z#K~VfH@0+KtVmOn3U^X9?GZR7Ew|On0Thj+S%0=&8iVzcgb_r8b)~4^l9rJV<{u|R z;O!k;(gqIjt0pwF%)lA_hxm_mz-ZoerCJho;v^DXx_k2NQ5WL`AVsgbkm;hKp+vr_ zR#*6?CSX>JgC^wMO>rXZvZ*_P#ii-3@L{oY(kY2Y#w5L3HkM-g#ffI%cR~x_83Luq zTLqo1yg6>MvwTy6bRI|(HB~gvj<)lBa?J2gE9MQ0tcPcOn3@JG;}HU#O7YiHCx_{~ zvvwGqjb|T9VC0~T(soFmnB_O!7+{V=-Ipm3(nYg7Cg}-|;Kwk_hXT3q!wNrtk+ri0 zLEaLc#Lxuj{m!>z5!?x2?O`uF&v|DysoGzelBFT#q*cYNkjUq;O*PE``*D+s*f?); zUuQ{d0v*2KLb0Ue=7DDXNQx>Y3&mx91iymg{vDmaPU3MWM%WrZ{`SY?22JfRVPD=w zOq^1Rlk7kw!p?=Ywn4;&6g5J0jrO?b$WPLrCL6ZBQ^AIjL0mhH5X+&-x2&8vGC!aT zT4-^NKh)yeukyT(F2D3(6np?CDvUUO@Em`@&fH4=L>@DgYYUy9nO9Wcgv30AE?wyy ztl1nBB%eEG4NMXE4r?+J1?qLc0XQ=MqvMVBO}ygE0=J>VPBgEI!9SOF&a%W~UR}UZ zbaSmof@WD$@fr|<1AXIfW$Mz@%oP-}kClFE*nEdZ$IW{<$%O?J>K6$ly_LN%Shqvu zp(U(pkDT3l8iET=8KB4taT%nr0YeF>WrhW)O3eb+mASgeq@FMUFtJI%?{d}-P|eHz z&xE;r0~A|=hL|Yd>?y?~c}k_EBzz4Sh&bLu`#H-M?kk1uG zmIu(n!A+}QD{8szalb*)_)7KOlhI1zh+Bp2@T<-uZ+=MF*`o<*PxjzC4?UGR=>r2O`tPfb!vQ2@n z&hIPMO^FbWGVN$1%%vroR3c5Mx3dbez5x}LsyRr^w z5J5k_rJC5+xAgo8vv%*yum@lB(rq{c78@q&tm4ip2b=XK0f?LGbR*Qh(pf``fa1`# zZA8SmX2O{QTllpETtvucAck|Kr`;(C|O)?3?jxj8eU4jvDRhPE%Fm_=At zKd{d{nB0*{fENV7x}t<$_)U2;yZUFkiVv@RH+qxt9^tV2t8{2K%zCAOA@>##%I{^3 zMGg}DgOU&5_Z?<%b!B-^3m2X)ae7Pp$Ea-nxfh_YWfIMJv2i`AN!ixX?;0s8576aR z6tWVpf9%AlqR#TbpmR+uY?I>i1x^m-zZ%uK?6;!IuY6lEIQzbamcsceG2hJ-3>Y6Y z?(m)hT$*tTT3`RhdX#8wr4H9@ZDc;*Mt3=Bc#Ir4AYMSu7V}ZOHO7_Y$o(U)Hq5_Y zWHHvO3YfL~=|^|g`(XBRpn;OKGiG%*Qo8%XKB-~hWz**!xr?p(X%4`bQn(udK;Y!C zR1>cVXB+Z!FQh=FhL!`Acxg(5HP*JHh*8fmKC1y_Myxo4QR`)dk-etyyNXa>1o8*3 zsU(8VdFvfk^fyu`Kgaw4wtL)P4sw?q=w=_q{m=VPv!GFO#(9K#Z>{&Te5mv^Z!d!> zK8fQCW)xy_5mu*2BW!eG6!ov)t2s8#l}+I{6=v)V4*SF0;P`1y)iM<{pK=uF*Z;W{ z`THEPS5jqDRb%IIOFjd2%mNfN?ucGZjz=9d5+|d~L|glJ?W8~=;eYYYzi4xRE;-uB z-nR=UmTqda>^wIoIRmAV{hHF%=iY@v+K9noX(nnbOPV^6!O=CdAlIPmp`Im7)yE_i z+<0eDaT{e}UyxtS5OQTx4;lUsk0a@H#@d#Ns)^1D8DN`~bWrlaRMdB2U9%ka@N-q< zwCBG8B&|+pDGAcAz~N_d!LZVW{PR6cc7muu-W%wH7EJ4Zu}*2bjjYZk*awTDN;rtR zbexfbL4-sO#I>}+WmqB^EJ6MJGqeRpZ4KReg2aIKc(L)L1vM;|e=9*w@=wdO_vfrm zRoOv)u;ld#7)0`JO-6m7ZGLyYzNY-ih_MA-lINfsMer4?#hjeIo&_{S>>nMpv&+{4 zc5EyESa|BRGsLeoa>cqE`dK76$adpFj}k-Pb+haHf!ZU1*vOTII1-z=+IEtJvh*>% zSjZkb-4`V^H9!m8kG(N~a$_Xt+Ltq71Q5EIb!T1W>9KvIw*;YiElu|M`7PZsGgc}W zQ<()8{;EYDPu13d&MuiuEykiWSsCC9938o=;d@Pa#2?=qRTKzwJ56Cj?K*bwM8lR} zwqz1MR`eTs-<}3Q2LRS7egt>l?49+FW10a)Nm`ZeR!L)ZMeS}pXJS`m3$0iA$uNUw zz;j)Nc4!u9aNjAQ2B4)<^?=7#Dgt3_|t{ftBU4b*5`<``Uud~w*;3^`E z=n!eIOjrGAHKk<<`5XS6lZi5)w@rqmF2xTDNAUxGIIMsez(5y@cE6x4vnX0^4q@+@ z-x~(nj`h7i#ORA`FfaljhG#ZiV17rkS6UfIy+T?%rJL8kNx>blDrMHf*=y{*C_LFZmnGJxdNN< z0L)MX1-`y=cXiE9S;7DP&^*4(+ANixD?ls9AEcoGIFS$`)biMAS*Vbq4(T;^I)~<+ zn1-mtB~5$_o&O-u_ipkeLkJ2FGG>(X6L(r@XqnI(eRB@M7ryLO#YG6gtb){_%9%xP zIx>Bt1IRd|E^{*;zrt4yIwsEyh}EJ=>Oxiw@(^kpz1NgcoXi4LcX7p1Du+Pma%q1O zGF3@_gUFq&X@HJCu*Oa;0QF7Mf$TS{Kz!Lbizj$lARF8nE{skpJPQ4#7}oQf;DTa~1Yfi^hm4{}xLJ zk%RrI`7G91mgn%x`W6*!4vdoI0}gd|o8O{0iz*a%V~p2F3dL*#1mDA{jxU7M)w{dvI^e6~b7L%o(2yI1cY z0aAN-Ev*P@d^v2eE9i=Zu9&|j4Zutr1PLOMg3fJYX`|%H9(!kcs}}zZYsgZ?2Do_* zj)D))^v5%4Mh(y2fu8#3qlIftMy`t=qhgn#tsc0cr%T{aklV00W!RVKtT&$sCe%g; z7QUYysNt)Oxx#_;jM!QVpFUT@sz6H9w4onpP;k4dRX0FXFt8s; zd3^C@51jV=6Feh2-vg#tO@5UA`jHxS%~Ht?P>2Bsq3b9a2XYe~iYgu(EfLpC7>0`) zuTuRR4Zwm#FTxs`J_G^{#SW9)ahnIa06-g=J;Ct_rUkn4234aTV0T4u!hY^?)=-!~ zaRzt{mr`%nhEYZ24dKyak1NiLwO0>g?QX3-e5E%3ZheBD$o0+e-;>C_; zKO*LvgaanMTj8#Lqq^%Wa#%&5AY`QDyOwiJyPf6%(RF%|4wT{~l|Q~De6IB~nN3)O z^(9UZ8{+GEDq`W>-aF_@6hpHGA9gsv?A||L@+AKGaMxp$&D;-*YB$jf9HC-%a$w!x z`erzn--t9SO@Mtb)p_paq(%=}7+}X1XW9hZg&VlXD9?|%bv{(Dvc8THyv2A&<5cAZ zK+l5SViI{g1Y|$fc9-a_6uhhSTvH)DQmV5>eOI-{>X#KP-KlPGU+vf?Fw5r^|1u$a zsoX6V-+a=xKX(?^daYK?nf!bFE>SRNV)Xsn`ec>ImLB+yOl>+bx44E(&^wLt!g)A` zd{JJpNFk_PS5dHQb_e5BnqDz^1LDa9kI)Z{i;5bndqxG)0JaE_?h=9}{#d9#vFOGu zL(bm-oO(utcCx|g>G=S7rm7C}d6}tjH=79PXFnA~bq&lf@woVVj8gW8KT~v_zWQ!- z)mEnu-{d9%9sXoEOayurt!LR>aM0uo_WsRKD85DudNo|U>HQdb9$2A0;e_HK-6LUR zH;r*OOXWedbr?lbI|oJw2H<1nx1RD~j(`Ig;5Q(r=q7^}TodEf-3siKcPx&#1V%%Q`+D^+B$yC1TeL0SsR{GP@C1@t(C?G`k&XGRX(sZIf;bqD~Z$UQN{Ue$0VOA`N zm8&PrdQpejnSZM?Tb~?>63KZh6`||hNM_DV!Y0*-SJ0#4SNR#g-TSE?|7dlweNr4Y zLh~>QhNTw@a{TU=8P1p}>Y>a|E3?-L`^mvvVr`$dSsSG^hks_D*?eO@pEMpkTVLZE@W3x(*LU)LTGDxnMv4$>nh0tLSoL|@w#aH?~B0*J{|#kc1NL68Zm zMBYBAOp?wkkw(Q^V{fUTC*L)zR{`x)Z=C+BUcr6>2r)?F2N&`;4eHeX`@nHBVuHsmHO zl6^9hKG9=+3X(%}l=Gs*v*VDhygvws-D=V&B$Km5kJ;^@qZSG?MtxN~AM(gfz-);FGcAemark*-3XuY?33y%8G8vLM#KolS%!1{MiX@TJA zTF_|ZXrl2js88>U5~5LOCLQ=aBkqouQ$0%>039d|}pr{4g+enCejn-wkrmOE%iS!kta1Z8p|L3Bgs;I615N{wb>ay<5 z$aV*R8IlKr{7*vXV?CF?bNdKSB>^62JMf^ksm$$asUn)rS8UA{sA8KW5?ZjpciqYPW=7$PD#5wxj-$D+or zXrdY`niM}#GTP@6kQf|8Reg#ph>V2)o3}j1$jH%qYG={xP!4SdEoJ|1W1as2>VQ-Y z6FT3i5_IGPSRg^JGSKbnR2^rB;YJT@49v~U?>{LFJHmp2hPh`iMOqfcj^k<m4{_kmGSsUJnQd9@>gtv`2z+e}=P-phor37lfCm1+S zSWSSr-apkar?OFeKdWUVugBl`NT}0K7_2g~yY-qemB4EIu|L{eZj3z`Sh#$XChfkd zay>d=hGABN|4A(f5wjXIeh}oi!+FhMH4$J?K%k2GX2(Q_VCu=0lfc(mOfNwK8Umyx zdSaN+S=*3a1a`oD=NJk*5Qo(|R*9>6{Pa!5F5yfCWd7_=T#;Aj1#~S7w@9`X1u^=m zzsBqj!pwVl9;HiE0Ktt7N&eE5mb{dNiLNn8J^UEEjB)}Rz_$aetsxB^-=MF3jnX-0 z(uY-AU`>5vQZQbJjfBqOv2v!b!Um#aT|kS0s=Bn z_FG-c6**Q*$(d`)+!$1f7&h#tGlS{tS7;j_*DT9@2^LFkGlX_|6XCK*52kc%O0KI} zAf<85#c%hV3Wuc%A{SL<`#8L@4^a0VeV=%^0-LUL@W<97CcyP}l~ym5<0j=($)0GK?kz+2z;0{s3Sp9!}QWuc*k0;hv?5tg`3%&zf$Q z;5~=GZ%6`gAC+m6L(8?s$;uWFyt`|+lJ;gP-vQKxpy9zj(~59eRG$I80Qj9VbT*|2 z%=uIVrylZ_^GPVk=Bw7)yt{BPLmK=T;KV8Z$aKEt#}28g8(es&B?h^@7t5}<@F@1e z_N@mo$*+=Hf_KmLi-}V4QxPMpx+HcM)^zYVk`Ji=AOJn$$qV9k4 zk8l2uBkD=k@Cb$-AX*rak#O%HeLhYtr#ttle^tH_qEH5NbpF9Zx#G+_Sdoq@>g zI&|2Gp020vYjhgvfiGjJ5KS2Mk?AS&5IKqjbf15H$s>Bz{NHVuzU(;e1?Rd|O@;28 z?Ed{cLKPbLgT1UMRE|zq!FfC%#;{DVyNm5as&GNvyn;$D`kbrQ#oDwXIcp9$(?SP2 z{JT&upW&Px*deqvWE$fw{tl1Qs$XMlOoS&F<+n?|bdML3N=xs}04p{eahLw34B+Ha zP%Cdjx-Ww*Yb#Yt_>;f4K@f~B%1*KTxtScaLmY;yOwKT<*ZXbpzZw%}^ z%_W4V-As34o3idnx^@<$Qz>Gsp9O20dSo1vane-MFx+W2WW`ykvGMd#natwQaB5P60H9w+G8yr?%TK5GuLHo=#=0p7nd!eM%t5HZ? z77n~516|oUPl$;d-)}U*_cg}?RY<}SjM=uLwMAkdPk^j-BC{kP`%0lma++7qpoS5z zTEOO+t0%iE5&p|C!>S)8q?M{2x-0RKLb5ALGz5Fha|x!~FgK@n>*2=#U|!nxIW3;C zVfY-Yn8vz_H)0E7;ldaEC*Te304acvBNygbz!`Hy9%t+Cx{~k;j1Hp9N?X<8XVF9H zY)m1(lr~^@gA6CLeO*srrCYp*WJ=D9e?h-SDHC!mnRAdl<(O`ziSxx*GV>)D2N;lP zrhGD6_YhB+*-6;>6`%RYD|@LPwzk8Md6as*a{CH- zDl)c7ydmb^$TEQ7RMO{BMlOHfO#k4ip;{Z!oW zjfi(OC8`ez>MlgqAE9bC(OwP71@MdDrc4D9(4W%t6(?ob9NWoTtb(Y;-#bSceGfl} za+?DYe;ygm{DA2y>fS$tLJfFsNvkh0RC}v0QvEtPNy>rW^3q?kVd|QXW;hSBpto54 zH|oRP%^O3)`F3{VIUqQ65D(|Fsl$uQQ;ZD zCH#muUIALyQdF0|!J4`Z#qHcR=!TQ>>Zr%rwzt=-=!+>vC z%!*Z-@#M^#Q$Bt5dg;^BEM{xm=H-%D5B-={;$hzLZJ#xd02G|$y5;)_j$F7Me?0fohjD#FiJ%`&tK;`-2+{MR>u#4%m;w_WAN+pM< zffWO>r|)b5UGXo))YT~M#TFTXaW)2m*ZOl0WpXJ<7A3sDCodetLk4ImwhRwIO z)Y4FwaO4Ymx-nvHA1-{#u=1`=M` z>-|c8l#)^m=UqO-w(>$(w1iboVXSpqH5laIZk4Mo!M*QAiV-j09-pU88EaDqlKv~R zKm02Q4SP>oCHp(g_M&R-H*7#XTcXHSJ-Vg{pdoZtkFC_vK_!xblAgGO;5Us&br>7kN)4_bXs1xv z{7HEFXuqDz7}deLb1@EGy?U3kGJ2cuG1@qPyVRn>;L{&rHcNT2AnTTEfEYSXM6nhE zdZh-Lk-VQwA#=RAK}i8(ShY@W7vJD8@%AlsT=5l;Dfp>yD{GgWu?_0pypa8UfA;`2zoI0m?5y~3ZAg{r0%gTZ9mxBS~qr>9& zSkXay|9p~vMw4dpT4}I?iB|wxthcPS1}g^6d+v@@tXH!R(?44r8Y*2l5}?s~^&hB8 zS!~kC72O+@UxbaM4MuzMB}iJP;z>cv3b*iUdAYpFc%Crug(jbc!+Qz2`%+7SM`sju zd;<{Mtkl#Lpm+H9AeL0T<9*hZ_Gm6R*N>g?mZy)27Km}%`dl0CS$C}5AF=AsVk#Y@ zv^fcL#~!PR6v|A-q(>9|RukHUKbVqIxu;L@)>N5TDV-4&l~SPNPwblvLx-D$7}F?< zQ4S?yBey!K;R_<&)qxofjz=rxTw+eW71CZL9qvcg^4lCM!Vb zfNTGa?x#QM*u?CHaI)6Wl7HwRHq{v(e}Ghde%0@|kS@w1EU$*ulqiA0l&_wpw2-$} zJ%giN|7;rNxr5^$5UBoXFSK z@`8?}JVz2(BHyt&GA^VEv2=HL&EjN^TXIx}9K zvE^R9}f#5SiSxB>KC1$#FDIIEyU`K)quzI%b+T_CP)O~gVBEdat& zo^oK$!_)$;i<6V@qp7jy<*dK({8jfy&`lf)r}!4)wv)ihV`KlLA>R+uo&VPmnd-(X zhj1MI1HO|2+j91jEC%@l=&ioj6494ANN1ODSsGSFuLal4!#g3;7Hc3ra6Bs{l~}+? zJH2tJ`feVja{dK1v+GuOxcb>X@VMcr=9s~(0Tvk0%1Y2R(cPY*7vYXqW8)J zsCk9>q@p6mn!ElM02*^Xom)DJNoh=gTTlklEkv8K=Eufsp-Qh!-@_;!*vtO(Zw+2H zn2?Hx^SAL6{h9n-;hUNFeY(^29*uj>wU=QmKLdL#pG0dvn*Z2-UUg;FH-I2Z2|{WH z&e(-AUj3N9Ds9={bcP$iOawwM;qhr+MJaU8N#gwy0<@KygJIGD-%Qe3Rxf8qqY!9m(MX3^Q z%mqN}8=(FhvEE}V&%Ue-od;*1k+8-=p59@8vQuoYM?4a#m&&>t)&~HU4KP07EnW|* zCa2wmEM#d{$}yMH2!A^AP%u;H01^Qi&xH<0($y>B5O6mE}6pCIqfLw6| zVMsCV5&_xp<%>kH(vR^(n<5S5_+%_3qkH zKkf97);t6h%uK2)wfX#cLD?TLlbZSLIDXnIpT8Y=eQtGU^~pijNyNL4cre%bmjJQ$ z!RKIxIavJ*v;5G@5oJ2bF)|@Md2RWa!W>sz`AN4~3f85NgS;aZ%LB z>TNf8=Gnc6W?IddzD%l$GjCn(am_MhR({qSER&^Z(7`+9y2SwpDqvA*DZ^_0mS=T$ za`C;UR?!_$Q4T<~DFu`xebvA$+L4_dsa@Be$gqJ)_Q5Z|) zz%#ZjzR?)=Vg1CX&K0mSKqQXt&|pIVkDuzLWS_hn5wUK+m0}_3pu#V`Xzd9EvAN;= zg!zzEJ5>n%C%AuTLdhc`>7-=pc`(;!ubAC3nziRnPYuEYky1YRf06@0!Vk{w7p;ML>lCl!XJNxW$&6M@ zmJZM_@kyl1iZ$Zez2&tu6j6Mis-D<-W!li7o!MgED4Is!UdSjouT}{4H43{AXevXN zns4+c?M>a=UUM9R13qyXN}-EL_>DPiHb~*Y`2Geuddi1Is~8TNOmS~9=UwmBn~Fys-Tn#jQb!W^pl*fdEwe z=hwj?_TUqpv;;2p$R9J(6SusQ&kZojZm(Z>!NuiDG}@M7G( zgUE-N%t-}>rbosZPOZKN*bQ??)&wPhiq`^gMdRWU%4)E4G7oz`NLY@(QoZ+YarMg} z$d^DHwf|7D)Z&>fkUm`*c@_}yiyw9(SFY>T84%G-l{40xPdZIZ^(}C2c8o#v;Vn{b z%>w#oQ=nQSVM=j{f()67;Y_Q{Jf1e9I0!tr;}*0nou{=Ar%yJinefUPe{6BHJ%b2T zXa=s1EAImyfvWWj(fk_+@&jzUvPgbT50|^_Hm`S;24*8iP%bEcM7=Qf;_`q?j%BVl z3SE6h$;MK%qM79;-afa>n*XdESUY}b)WpE3u{?%rMl>0r zDvJjV`qX+4?!7LJGZ*P=dN`D$R2hsyy9^jHix@8eOL;x}j}2Mt86KK3{)NYw=MxVC z#rcVRLsPy$MWz&+!d@hKoK$SIFuRtjOxTcEWmoLM0&vut)3CbW(TWoDXGCzUJ*SKH z=?-Z(8TL3>b))0hn8dc9uHJV@#|(2tGe-{W*+OFq+l;OcTd0UXs5}p4DjmqYHU7>^ z3ZKH-$ePQF0>S^9wpPy_Kou_h44_NSKyLS(oWqORaewQd0&!MY)4TXq3zz@^0|OjR zNmG2G^L)9r7AZ77re$OmjPp4`6y4YeEkHRT7b7j(KbsY;ChirUn@weA^qp%wE#0hN zt&rx=1B}e$4XmnZp)nNU;ucYO-^>Rd@C~zh&S(w4Ssh{?u-7y9r_biS;*KHE)mt#* z|4aSx+Vf_Scr(MbluV%X5&&6-FCjlQ0ZN22i`8>;g?N?oE-#5zA9%_@u>ZXSQ|_N6 z0%y4m%a0N1dM$JqnQEzdGCx!T_OItBxDRB({BfWUUjU=vJS&|pR3HEnw#@2MoBjKt zF?P7QfwT`EAO%i6W@r(P`sP%`xR%(aq;+QVws5*Natvw}84yDgR!+0Nqp(S8UlejQ81O;-#%wSTn9!|Q``g#h_gwsOL-^@(A&e66({+wka6#G;EcdBQ)oUbx;-x?rplJ2% zoyWrZS%G-6s=H9uxbK+b_vNnfYvl1kl8^FQB?LdE;Ou+Fz45pT%($0RtPf`UQH=JFk`8a zyo8bxVv%$HaAFNst2?jWGWhICmhdD=A5^R!p&DJZLWdCq85~o%fgbHHP8wgyM4Rf< zje%gg%%zjX=<@g(6Y9Ep2;EBh?uOouD`p9s!$4a zdPGmM+z%gGYoyC_VXs!12Oa;g=1bch(^*IF+Sp$6(zUIqAFeSVI`N)c!&dBRphi-- z^kV?rxxGh$JWj$ZWJj6S=~Jl~AI(nQDRjk4gV9{$qG<$fCn&Vz9V1SA;VVG4#W-5% z9xyRR^0wuEY1E`-cS<3Ppjp+$$lUCO%%J#b{}X#AA0)}B9V-Ggn@=?mG(5QpDAy<<`#YE1 zs{G9%$Ege9xNf&0F?$ZAji1H4*}3}|G`vpc>m=f0k)c$9YPB(!7|J`aajvGHqhxOF zXn+I*68F>c7{<_3Jq6HMjPAo=?v}C16{!@P@4Yo)H;6948RgAFm+|Ge>y{|tKaF15 zL;nZikv9ETcM(OxmVDa*lP#TLt0DTCJ+ zm@;YSjToiT{JX{_!3q$=a`O`sz4G$;Lf6YOI__>$u)HHq1u>YlR1)RyGY$j)^asp%K>lAy8ja1H~hQkdV^X#!Dg9y72YWptJ@QQvzYzbeaj#J